Merge branch 'lammps:develop' into spica-kk
This commit is contained in:
@ -1,2 +1,3 @@
|
||||
*.csv
|
||||
*.txt
|
||||
*.lammpstrj
|
||||
|
||||
@ -17,14 +17,22 @@ q_ref = float(ref_line[3])
|
||||
inv11_ref = float(ref_line[4])
|
||||
inv12_ref = float(ref_line[5])
|
||||
b1_ref = float(ref_line[6])
|
||||
felec1_ref = float(ref_line[8])
|
||||
felyt1_ref = float(ref_line[10])
|
||||
press_ref = float(ref_line[12])
|
||||
|
||||
# out.csv
|
||||
with open(sys.argv[2]) as f:
|
||||
out_line = f.readlines()[-1].split(", ")
|
||||
e_out = float(out_line[0])
|
||||
q_out = float(out_line[1])
|
||||
press_out = float(out_line[2])
|
||||
|
||||
out_lines = [("energy", e_ref, e_out), ("charge", q_ref, q_out)]
|
||||
out_lines = [
|
||||
("energy", e_ref, e_out),
|
||||
("charge", q_ref, q_out),
|
||||
("pressure", press_ref, press_out),
|
||||
]
|
||||
|
||||
# vec.csv
|
||||
vec_file = "vec.csv"
|
||||
@ -44,6 +52,14 @@ if op.isfile(inv_file):
|
||||
inv12_out = float(inv_line[1])
|
||||
out_lines.append(("inv11", inv11_ref, inv11_out))
|
||||
|
||||
# forces.lammpstrj
|
||||
force_file = "forces.lammpstrj"
|
||||
with open(force_file) as f:
|
||||
lines = f.readlines()[9:]
|
||||
for name, i, f_ref in [("felec1", "1", felec1_ref), ("felyt1", "3", felyt1_ref)]:
|
||||
f_out = next(float(y[3]) for x in lines if (y := x.split()) and y[0] == i)
|
||||
out_lines.append((name, f_ref, f_out))
|
||||
|
||||
lines = []
|
||||
for label, ref, out in out_lines:
|
||||
error = rel_error(out, ref)
|
||||
|
||||
@ -8,7 +8,7 @@ thermo_style custom step pe c_qbot c_qtop
|
||||
fix feta all property/atom d_eta ghost on
|
||||
set group bot d_eta 0.5
|
||||
set group top d_eta 3.0
|
||||
fix conp bot electrode/conp 0 2 couple top 1 symm on eta d_eta algo cg 1e-6
|
||||
fix conp bot electrode/conp 0 NULL couple top 1 symm on eta d_eta algo cg 1e-6
|
||||
|
||||
run 0
|
||||
|
||||
|
||||
@ -8,7 +8,7 @@ thermo_style custom step pe c_qbot c_qtop
|
||||
fix feta all property/atom d_eta ghost on
|
||||
set group bot d_eta 0.5
|
||||
set group top d_eta 3.0
|
||||
fix conp bot electrode/conp 0 2 couple top 1 symm on eta d_eta write_inv inv.csv write_vec vec.csv
|
||||
fix conp bot electrode/conp 0 NULL couple top 1 symm on eta d_eta write_inv inv.csv write_vec vec.csv
|
||||
|
||||
run 0
|
||||
|
||||
|
||||
@ -1,12 +1,17 @@
|
||||
#!/usr/bin/env python3
|
||||
|
||||
import time
|
||||
|
||||
import numpy as np
|
||||
from scipy.special import erf
|
||||
|
||||
SQRT2 = np.sqrt(2)
|
||||
SQRTPI_INV = 1 / np.sqrt(np.pi)
|
||||
COULOMB = 332.06371 # Coulomb constant in Lammps 'real' units
|
||||
QE2F = 23.060549
|
||||
NKTV2P = 68568.415 # pressure in 'real' units
|
||||
LENGTH = 10000 # convergence parameter
|
||||
LZ = 20
|
||||
|
||||
|
||||
def lattice(length):
|
||||
@ -26,6 +31,25 @@ def b_element(r, q, eta):
|
||||
return q * erf(eta * r) / r
|
||||
|
||||
|
||||
def force_gauss(r, qq, eta):
|
||||
etar = eta * r
|
||||
return (qq / np.square(r)) * (
|
||||
erf(etar) - 2 * etar * SQRTPI_INV * np.exp(-np.square(etar))
|
||||
)
|
||||
|
||||
|
||||
def force_point(r, qq):
|
||||
return qq / np.square(r)
|
||||
|
||||
|
||||
def force_component(dx, d, qq, eta=None):
|
||||
if eta:
|
||||
return np.sum(dx / d * force_gauss(d, qq, eta))
|
||||
else:
|
||||
return np.sum(dx / d * force_point(d, qq))
|
||||
|
||||
|
||||
time_start = time.perf_counter()
|
||||
a = 1 # nearest neighbor distance i.e. lattice constant / sqrt(2)
|
||||
x_elec = [-2, 2]
|
||||
x_elyt = [-1, 1]
|
||||
@ -36,8 +60,20 @@ v = np.array([-0.5, 0.5]) * (QE2F / COULOMB)
|
||||
# distances to images within electrode and to opposite electrode
|
||||
distances = a * np.linalg.norm(lattice(LENGTH), axis=1)
|
||||
opposite_distances = np.sqrt(np.square(distances) + distance_plates**2)
|
||||
image_distances = []
|
||||
for x in x_elec:
|
||||
image_distances.append([])
|
||||
for y in x_elyt:
|
||||
image_distances[-1].append(np.sqrt(np.square(distances) + np.abs(y - x) ** 2))
|
||||
image_elyt_distances = [[None for _ in range(len(x_elyt))] for _ in range(len(x_elyt))]
|
||||
for i, (xi, qi) in enumerate(zip(x_elyt, q_elyt)):
|
||||
for j, (xj, qj) in list(enumerate(zip(x_elyt, q_elyt)))[i + 1 :]:
|
||||
image_elyt_distances[i][j] = np.sqrt(
|
||||
np.square(distances) + np.abs(xj - xi) ** 2
|
||||
)
|
||||
|
||||
for name, eta_elec in [("", [2.0, 2.0]), ("_eta_mix", [0.5, 3.0])]:
|
||||
# for name, eta_elec in [("", [2.0, 2.0])]:
|
||||
eta_mix = np.prod(eta_elec) / np.sqrt(np.sum(np.square(eta_elec)))
|
||||
# self interaction and within original box
|
||||
A_11 = np.sqrt(2 / np.pi) * eta_elec[0]
|
||||
@ -55,22 +91,18 @@ for name, eta_elec in [("", [2.0, 2.0]), ("_eta_mix", [0.5, 3.0])]:
|
||||
|
||||
# electrode-electrolyte interaction
|
||||
b = []
|
||||
for x, eta in zip(x_elec, eta_elec):
|
||||
for i, (x, eta) in enumerate(zip(x_elec, eta_elec)):
|
||||
bi = 0
|
||||
for y, q in zip(x_elyt, q_elyt):
|
||||
d = abs(y - x)
|
||||
bi += b_element(d, q, eta)
|
||||
image_distances = np.sqrt(np.square(distances) + d**2)
|
||||
bi += 4 * np.sum(b_element(image_distances, q, eta))
|
||||
for j, (y, q) in enumerate(zip(x_elyt, q_elyt)):
|
||||
bi += b_element(np.abs(y - x), q, eta)
|
||||
bi += 4 * np.sum(b_element(image_distances[i][j], q, eta))
|
||||
b.append(bi)
|
||||
b = np.array(b)
|
||||
|
||||
# electrolyte-electrolyte energy
|
||||
elyt_11 = 4 * np.sum(1 / distances)
|
||||
distance_elyt = x_elyt[1] - x_elyt[0]
|
||||
elyt_12 = 1 / distance_elyt + 4 * np.sum(
|
||||
1 / np.sqrt(np.square(distances) + distance_elyt**2)
|
||||
)
|
||||
elyt_12 = 1 / distance_elyt + 4 * np.sum(1 / image_elyt_distances[0][1])
|
||||
elyt = np.array([[elyt_11, elyt_12], [elyt_12, elyt_11]])
|
||||
energy_elyt = 0.5 * np.dot(q_elyt, np.dot(elyt, q_elyt))
|
||||
|
||||
@ -78,9 +110,48 @@ for name, eta_elec in [("", [2.0, 2.0]), ("_eta_mix", [0.5, 3.0])]:
|
||||
q = np.dot(inv, v - b)
|
||||
energy = COULOMB * (0.5 * np.dot(q, np.dot(A, q)) + np.dot(b, q) + energy_elyt)
|
||||
|
||||
# forces in out-of-plane direction
|
||||
f_elec = np.zeros(len(x_elec))
|
||||
f_elyt = np.zeros(len(x_elyt))
|
||||
# electrode-electrode
|
||||
dx = x_elec[1] - x_elec[0]
|
||||
fij_box = force_component(dx, np.abs(dx), q[0] * q[1], eta_mix)
|
||||
fij_img = 4 * force_component(dx, opposite_distances, q[0] * q[1], eta_mix)
|
||||
f_elec[0] -= fij_box + fij_img
|
||||
f_elec[1] += fij_box + fij_img
|
||||
# electrode-electrolyte
|
||||
for i, (xi, qi, etai) in enumerate(zip(x_elec, q, eta_elec)):
|
||||
for j, (xj, qj) in enumerate(zip(x_elyt, q_elyt)):
|
||||
dx = xj - xi
|
||||
fij_box = force_component(dx, np.abs(dx), qi * qj, etai)
|
||||
fij_img = 4 * force_component(dx, image_distances[i][j], qi * qj, etai)
|
||||
f_elec[i] -= fij_box + fij_img
|
||||
f_elyt[j] += fij_box + fij_img
|
||||
# electrolyte-electrolyte
|
||||
for i, (xi, qi) in enumerate(zip(x_elyt, q_elyt)):
|
||||
for j, (xj, qj) in list(enumerate(zip(x_elyt, q_elyt)))[i + 1 :]:
|
||||
dx = xj - xi
|
||||
fij_box = force_component(dx, np.abs(dx), qi * qj)
|
||||
fij_img = 4 * force_component(dx, image_elyt_distances[i][j], qi * qj)
|
||||
f_elyt[i] -= fij_img + fij_box
|
||||
f_elyt[j] += fij_img + fij_box
|
||||
# force units
|
||||
assert np.abs(np.sum(f_elec) + np.sum(f_elyt)) < 1e-8
|
||||
f_elec *= COULOMB
|
||||
f_elyt *= COULOMB
|
||||
|
||||
# Virial
|
||||
volume = a**2 * LZ
|
||||
virial = 0.0
|
||||
for x, f in [(x_elec, f_elec), (x_elyt, f_elyt)]:
|
||||
virial += np.dot(x, f)
|
||||
pressure = NKTV2P * virial / volume
|
||||
|
||||
with open(f"plate_cap{name}.csv", "w") as f:
|
||||
f.write(
|
||||
"length, energy / kcal/mol, q1 / e, q2 / e, inv11 / A, inv12 / A, b1 / e/A, b2 / e/A\n"
|
||||
"length, energy / kcal/mol, q1 / e, q2 / e, inv11 / A, inv12 / A"
|
||||
+ ", b1 / e/A, b2 / e/A, felec1 / kcal/mol/A, felec2 / kcal/mol/A"
|
||||
+ ", felyt1 / kcal/mol/A, felyt2 / kcal/mol/A, press\n"
|
||||
)
|
||||
f.write(
|
||||
", ".join(
|
||||
@ -93,7 +164,14 @@ for name, eta_elec in [("", [2.0, 2.0]), ("_eta_mix", [0.5, 3.0])]:
|
||||
f"{inv[0, 1]:.10f}",
|
||||
f"{b[0]:.8f}",
|
||||
f"{b[1]:.8f}",
|
||||
f"{f_elec[0]:.5f}",
|
||||
f"{f_elec[1]:.5f}",
|
||||
f"{f_elyt[0]:.5f}",
|
||||
f"{f_elyt[1]:.5f}",
|
||||
f"{pressure:.2f}",
|
||||
]
|
||||
)
|
||||
+ "\n"
|
||||
)
|
||||
time_end = time.perf_counter()
|
||||
print(f"{time_end - time_start:0.4f} seconds")
|
||||
|
||||
@ -19,4 +19,8 @@ compute qtop top reduce sum v_q
|
||||
compute compute_pe all pe
|
||||
variable vpe equal c_compute_pe
|
||||
variable charge equal c_qtop
|
||||
fix fxprint all print 1 "${vpe}, ${charge}" file "out.csv"
|
||||
compute press all pressure NULL virial
|
||||
variable p3 equal c_press[3]
|
||||
fix fxprint all print 1 "${vpe}, ${charge}, ${p3}" file "out.csv"
|
||||
|
||||
dump dump_forces all custom 1 forces.lammpstrj id fx fy fz
|
||||
|
||||
File diff suppressed because it is too large
Load Diff
@ -42,7 +42,11 @@ fix fxforce_au gold setforce 0.0 0.0 0.0
|
||||
|
||||
# equilibrate z-coordinate of upper electrode while keeping the electrode rigid
|
||||
fix fxforce_wa wall setforce 0.0 0.0 NULL
|
||||
fix fxpressure wall aveforce 0 0 -0.005246 # atomspheric pressure: area/force->nktv2p
|
||||
variable atm equal 1/68568.415 # 1/force->nktv2p
|
||||
variable area equal (xhi-xlo)*(yhi-ylo)
|
||||
variable wall_force equal -v_atm*v_area/count(wall)
|
||||
print "Wall force per atom: ${wall_force}"
|
||||
fix fxpressure wall aveforce 0 0 ${wall_force} # atomspheric pressure: area/force->nktv2p
|
||||
fix fxdrag wall viscous 100
|
||||
fix fxrigid wall rigid/nve single
|
||||
|
||||
|
||||
@ -1,4 +1,5 @@
|
||||
LAMMPS (3 Nov 2022)
|
||||
LAMMPS (7 Feb 2024 - Development - patch_7Feb2024_update1-217-g1909233c69-modified)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# The intention is to find the average position of one wall at atmospheric
|
||||
# pressure. The output is the wall position over time which can be used to
|
||||
# find the average position for a run with fixed wall position.
|
||||
@ -40,8 +41,8 @@ Finding 1-2 1-3 1-4 neighbors ...
|
||||
1 = max # of 1-3 neighbors
|
||||
1 = max # of 1-4 neighbors
|
||||
2 = max # of special neighbors
|
||||
special bonds CPU = 0.001 seconds
|
||||
read_data CPU = 0.011 seconds
|
||||
special bonds CPU = 0.000 seconds
|
||||
read_data CPU = 0.012 seconds
|
||||
|
||||
# ----------------- Settings Section -----------------
|
||||
|
||||
@ -77,7 +78,13 @@ fix fxforce_au gold setforce 0.0 0.0 0.0
|
||||
|
||||
# equilibrate z-coordinate of upper electrode while keeping the electrode rigid
|
||||
fix fxforce_wa wall setforce 0.0 0.0 NULL
|
||||
fix fxpressure wall aveforce 0 0 -0.005246 # atomspheric pressure: area/force->nktv2p
|
||||
variable atm equal 1/68568.415 # 1/force->nktv2p
|
||||
variable area equal (xhi-xlo)*(yhi-ylo)
|
||||
variable wall_force equal -v_atm*v_area/count(wall)
|
||||
print "Wall force per atom: ${wall_force}"
|
||||
Wall force per atom: -0.000109285996244287
|
||||
fix fxpressure wall aveforce 0 0 ${wall_force} # atomspheric pressure: area/force->nktv2p
|
||||
fix fxpressure wall aveforce 0 0 -0.000109285996244287
|
||||
fix fxdrag wall viscous 100
|
||||
fix fxrigid wall rigid/nve single
|
||||
1 rigid bodies with 48 atoms
|
||||
@ -134,7 +141,7 @@ PPPM/electrode initialization ...
|
||||
stencil order = 5
|
||||
estimated absolute RMS force accuracy = 0.02930901
|
||||
estimated relative force accuracy = 8.8263214e-05
|
||||
using double precision MKL FFT
|
||||
using double precision FFTW3
|
||||
3d grid and FFT values/proc = 15884 6480
|
||||
Generated 6 of 6 mixed pair_coeff terms from arithmetic mixing rule
|
||||
Neighbor list info ...
|
||||
@ -157,54 +164,54 @@ Neighbor list info ...
|
||||
Per MPI rank memory allocation (min/avg/max) = 11.7 | 11.7 | 11.7 Mbytes
|
||||
Step c_temp_mobile c_qwa c_qau v_top_wall
|
||||
0 303.38967 -0.042963484 0.042963484 21.4018
|
||||
5000 285.08828 -0.26105255 0.26105255 25.155629
|
||||
10000 323.19176 -0.26264003 0.26264003 24.541676
|
||||
15000 310.479 -0.27318148 0.27318148 23.141522
|
||||
20000 295.18544 -0.11313444 0.11313444 23.828735
|
||||
25000 295.38607 -0.25433086 0.25433086 23.673314
|
||||
30000 288.0613 -0.30099901 0.30099901 23.438086
|
||||
35000 278.5591 -0.15823576 0.15823576 24.311915
|
||||
40000 303.95751 -0.19941381 0.19941381 23.69594
|
||||
45000 279.026 -0.1659962 0.1659962 23.588604
|
||||
50000 298.79278 -0.28866703 0.28866703 23.372508
|
||||
55000 301.03353 -0.078370381 0.078370381 23.192985
|
||||
60000 306.77965 -0.12807205 0.12807205 23.968574
|
||||
65000 309.86008 -0.27162663 0.27162663 23.616704
|
||||
70000 287.31116 -0.029751882 0.029751882 23.667495
|
||||
75000 312.48654 -0.10759866 0.10759866 23.504105
|
||||
80000 309.94267 -0.2558548 0.2558548 23.810576
|
||||
85000 328.04389 -0.1575471 0.1575471 24.013437
|
||||
90000 302.9806 -0.032002164 0.032002164 24.264432
|
||||
95000 294.20804 -0.27797238 0.27797238 23.291758
|
||||
100000 307.63019 -0.19047448 0.19047448 23.632147
|
||||
Loop time of 530.844 on 1 procs for 100000 steps with 726 atoms
|
||||
5000 311.85363 0.03543775 -0.03543775 24.79665
|
||||
10000 285.91321 -0.16873703 0.16873703 23.103088
|
||||
15000 295.39476 -0.44424612 0.44424612 23.767107
|
||||
20000 296.12969 -0.14120993 0.14120993 23.96361
|
||||
25000 306.59629 -0.29333182 0.29333182 23.884488
|
||||
30000 297.98559 -0.10749684 0.10749684 23.73316
|
||||
35000 297.98503 -0.11809975 0.11809975 23.984669
|
||||
40000 300.26292 -0.32784184 0.32784184 23.462748
|
||||
45000 295.68441 -0.25940165 0.25940165 23.516403
|
||||
50000 315.12883 -0.36037614 0.36037614 23.627879
|
||||
55000 290.55151 -0.0032838106 0.0032838106 23.684931
|
||||
60000 316.4625 -0.17245368 0.17245368 24.126883
|
||||
65000 296.79343 -0.054061851 0.054061851 23.695094
|
||||
70000 305.99923 -0.11363801 0.11363801 23.55476
|
||||
75000 297.40131 -0.27054153 0.27054153 23.928994
|
||||
80000 306.54811 -0.25409719 0.25409719 23.869448
|
||||
85000 303.95231 -0.17895561 0.17895561 23.658833
|
||||
90000 313.43739 -0.059036514 0.059036514 23.36056
|
||||
95000 290.3077 -0.31394478 0.31394478 23.885538
|
||||
100000 297.5156 -0.30730083 0.30730083 23.511674
|
||||
Loop time of 1586.06 on 1 procs for 100000 steps with 726 atoms
|
||||
|
||||
Performance: 32.552 ns/day, 0.737 hours/ns, 188.379 timesteps/s, 136.763 katom-step/s
|
||||
100.0% CPU use with 1 MPI tasks x no OpenMP threads
|
||||
Performance: 10.895 ns/day, 2.203 hours/ns, 63.049 timesteps/s, 45.774 katom-step/s
|
||||
99.6% CPU use with 1 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 190.47 | 190.47 | 190.47 | 0.0 | 35.88
|
||||
Bond | 0.10754 | 0.10754 | 0.10754 | 0.0 | 0.02
|
||||
Kspace | 73.179 | 73.179 | 73.179 | 0.0 | 13.79
|
||||
Neigh | 24.209 | 24.209 | 24.209 | 0.0 | 4.56
|
||||
Comm | 1.6857 | 1.6857 | 1.6857 | 0.0 | 0.32
|
||||
Output | 0.0016861 | 0.0016861 | 0.0016861 | 0.0 | 0.00
|
||||
Modify | 240.23 | 240.23 | 240.23 | 0.0 | 45.26
|
||||
Other | | 0.9595 | | | 0.18
|
||||
Pair | 460.91 | 460.91 | 460.91 | 0.0 | 29.06
|
||||
Bond | 0.047873 | 0.047873 | 0.047873 | 0.0 | 0.00
|
||||
Kspace | 341.4 | 341.4 | 341.4 | 0.0 | 21.53
|
||||
Neigh | 52.868 | 52.868 | 52.868 | 0.0 | 3.33
|
||||
Comm | 5.2321 | 5.2321 | 5.2321 | 0.0 | 0.33
|
||||
Output | 0.00099102 | 0.00099102 | 0.00099102 | 0.0 | 0.00
|
||||
Modify | 724.63 | 724.63 | 724.63 | 0.0 | 45.69
|
||||
Other | | 0.9741 | | | 0.06
|
||||
|
||||
Nlocal: 726 ave 726 max 726 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 2335 ave 2335 max 2335 min
|
||||
Nghost: 2336 ave 2336 max 2336 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 120271 ave 120271 max 120271 min
|
||||
Neighs: 120321 ave 120321 max 120321 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 120271
|
||||
Ave neighs/atom = 165.66253
|
||||
Total # of neighbors = 120321
|
||||
Ave neighs/atom = 165.7314
|
||||
Ave special neighs/atom = 1.7355372
|
||||
Neighbor list builds = 7722
|
||||
Neighbor list builds = 7670
|
||||
Dangerous builds = 0
|
||||
write_data "data.piston.final"
|
||||
System init for write_data ...
|
||||
@ -213,11 +220,11 @@ PPPM/electrode initialization ...
|
||||
G vector (1/distance) = 0.32814871
|
||||
grid = 12 15 36
|
||||
stencil order = 5
|
||||
estimated absolute RMS force accuracy = 0.029311365
|
||||
estimated relative force accuracy = 8.8270304e-05
|
||||
using double precision MKL FFT
|
||||
estimated absolute RMS force accuracy = 0.029311329
|
||||
estimated relative force accuracy = 8.8270197e-05
|
||||
using double precision FFTW3
|
||||
3d grid and FFT values/proc = 15884 6480
|
||||
Generated 6 of 6 mixed pair_coeff terms from arithmetic mixing rule
|
||||
|
||||
Average conjugate gradient steps: 1.981
|
||||
Total wall time: 0:08:50
|
||||
Total wall time: 0:26:26
|
||||
@ -1,4 +1,5 @@
|
||||
LAMMPS (3 Nov 2022)
|
||||
LAMMPS (7 Feb 2024 - Development - patch_7Feb2024_update1-217-g1909233c69-modified)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# The intention is to find the average position of one wall at atmospheric
|
||||
# pressure. The output is the wall position over time which can be used to
|
||||
# find the average position for a run with fixed wall position.
|
||||
@ -41,8 +42,8 @@ Finding 1-2 1-3 1-4 neighbors ...
|
||||
1 = max # of 1-3 neighbors
|
||||
1 = max # of 1-4 neighbors
|
||||
2 = max # of special neighbors
|
||||
special bonds CPU = 0.001 seconds
|
||||
read_data CPU = 0.017 seconds
|
||||
special bonds CPU = 0.000 seconds
|
||||
read_data CPU = 0.012 seconds
|
||||
|
||||
# ----------------- Settings Section -----------------
|
||||
|
||||
@ -66,7 +67,7 @@ Finding SHAKE clusters ...
|
||||
0 = # of size 3 clusters
|
||||
0 = # of size 4 clusters
|
||||
210 = # of frozen angles
|
||||
find clusters CPU = 0.002 seconds
|
||||
find clusters CPU = 0.000 seconds
|
||||
pair_modify mix arithmetic
|
||||
|
||||
# ----------------- Run Section -----------------
|
||||
@ -78,7 +79,13 @@ fix fxforce_au gold setforce 0.0 0.0 0.0
|
||||
|
||||
# equilibrate z-coordinate of upper electrode while keeping the electrode rigid
|
||||
fix fxforce_wa wall setforce 0.0 0.0 NULL
|
||||
fix fxpressure wall aveforce 0 0 -0.005246 # atomspheric pressure: area/force->nktv2p
|
||||
variable atm equal 1/68568.415 # 1/force->nktv2p
|
||||
variable area equal (xhi-xlo)*(yhi-ylo)
|
||||
variable wall_force equal -v_atm*v_area/count(wall)
|
||||
print "Wall force per atom: ${wall_force}"
|
||||
Wall force per atom: -0.000109285996244287
|
||||
fix fxpressure wall aveforce 0 0 ${wall_force} # atomspheric pressure: area/force->nktv2p
|
||||
fix fxpressure wall aveforce 0 0 -0.000109285996244287
|
||||
fix fxdrag wall viscous 100
|
||||
fix fxrigid wall rigid/nve single
|
||||
1 rigid bodies with 48 atoms
|
||||
@ -135,7 +142,7 @@ PPPM/electrode initialization ...
|
||||
stencil order = 5
|
||||
estimated absolute RMS force accuracy = 0.02930901
|
||||
estimated relative force accuracy = 8.8263214e-05
|
||||
using double precision MKL FFT
|
||||
using double precision FFTW3
|
||||
3d grid and FFT values/proc = 8512 2880
|
||||
Generated 6 of 6 mixed pair_coeff terms from arithmetic mixing rule
|
||||
Neighbor list info ...
|
||||
@ -158,54 +165,54 @@ Neighbor list info ...
|
||||
Per MPI rank memory allocation (min/avg/max) = 10.06 | 10.22 | 10.41 Mbytes
|
||||
Step c_temp_mobile c_qwa c_qau v_top_wall
|
||||
0 303.38967 -0.042963484 0.042963484 21.4018
|
||||
5000 292.03027 -0.19040435 0.19040435 24.581338
|
||||
10000 309.52764 -0.48308301 0.48308301 23.776985
|
||||
15000 295.00243 -0.16591109 0.16591109 23.672038
|
||||
20000 293.5536 -0.086669084 0.086669084 23.426455
|
||||
25000 303.0079 -0.16488112 0.16488112 23.862966
|
||||
30000 306.31463 -0.23192653 0.23192653 23.819882
|
||||
35000 303.66268 -0.2317907 0.2317907 23.495344
|
||||
40000 301.39435 -0.34661329 0.34661329 23.657835
|
||||
45000 291.61205 -0.30539427 0.30539427 23.437303
|
||||
50000 298.65319 -0.096107034 0.096107034 23.57809
|
||||
55000 282.65069 -0.14943539 0.14943539 23.823728
|
||||
60000 310.64182 -0.17418813 0.17418813 23.286959
|
||||
65000 308.47141 -0.02075662 0.02075662 23.91313
|
||||
70000 292.5186 -0.080163162 0.080163162 23.96283
|
||||
75000 270.13928 -0.029528648 0.029528648 23.488972
|
||||
80000 322.10914 0.030761045 -0.030761045 23.47592
|
||||
85000 310.60347 -0.24069996 0.24069996 23.987091
|
||||
90000 294.35695 -0.070458235 0.070458235 23.397929
|
||||
95000 308.69043 -0.2652581 0.2652581 23.473813
|
||||
100000 318.71883 0.024035956 -0.024035956 23.449863
|
||||
Loop time of 590.232 on 4 procs for 100000 steps with 726 atoms
|
||||
5000 291.6303 -0.1820085 0.1820085 24.641399
|
||||
10000 299.42886 -0.19823095 0.19823095 23.820522
|
||||
15000 288.23071 -0.065261869 0.065261869 23.360845
|
||||
20000 299.4644 -0.042993777 0.042993777 23.987554
|
||||
25000 304.26497 -0.15665293 0.15665293 23.729006
|
||||
30000 292.29674 -0.25142779 0.25142779 23.960725
|
||||
35000 295.57492 -0.01269228 0.01269228 23.445383
|
||||
40000 303.38438 -0.13941727 0.13941727 23.517483
|
||||
45000 302.211 -0.19589892 0.19589892 23.704043
|
||||
50000 281.64939 -0.18057298 0.18057298 23.542137
|
||||
55000 274.90565 -0.15453379 0.15453379 23.734347
|
||||
60000 290.70459 -0.27977436 0.27977436 23.835365
|
||||
65000 293.42241 -0.2454241 0.2454241 23.59269
|
||||
70000 295.20229 -0.041314995 0.041314995 23.73856
|
||||
75000 297.79519 -0.11231755 0.11231755 23.57262
|
||||
80000 285.17858 -0.070796508 0.070796508 23.817135
|
||||
85000 311.71609 -0.068920177 0.068920177 23.861127
|
||||
90000 287.80446 -0.19183387 0.19183387 23.369393
|
||||
95000 309.43345 -0.15238671 0.15238671 23.597792
|
||||
100000 294.12422 -0.14284353 0.14284353 23.526286
|
||||
Loop time of 876.546 on 4 procs for 100000 steps with 726 atoms
|
||||
|
||||
Performance: 29.277 ns/day, 0.820 hours/ns, 169.425 timesteps/s, 123.003 katom-step/s
|
||||
72.5% CPU use with 4 MPI tasks x no OpenMP threads
|
||||
Performance: 19.714 ns/day, 1.217 hours/ns, 114.084 timesteps/s, 82.825 katom-step/s
|
||||
98.6% CPU use with 4 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 57.391 | 75.867 | 96.292 | 212.1 | 12.85
|
||||
Bond | 0.10177 | 0.11042 | 0.12415 | 2.7 | 0.02
|
||||
Kspace | 102.79 | 123.16 | 141.5 | 165.7 | 20.87
|
||||
Neigh | 12.808 | 12.895 | 12.982 | 2.3 | 2.18
|
||||
Comm | 18.885 | 19.973 | 21.064 | 24.0 | 3.38
|
||||
Output | 0.0022573 | 0.0022749 | 0.0023225 | 0.1 | 0.00
|
||||
Modify | 355.89 | 356.74 | 357.61 | 4.2 | 60.44
|
||||
Other | | 1.478 | | | 0.25
|
||||
Pair | 123.63 | 171.23 | 215.73 | 336.6 | 19.53
|
||||
Bond | 0.068261 | 0.075883 | 0.081822 | 1.9 | 0.01
|
||||
Kspace | 187.59 | 231.71 | 279.01 | 287.1 | 26.43
|
||||
Neigh | 29.28 | 29.462 | 29.637 | 2.5 | 3.36
|
||||
Comm | 12.544 | 13.731 | 14.929 | 29.1 | 1.57
|
||||
Output | 0.0010182 | 0.0014585 | 0.0016071 | 0.7 | 0.00
|
||||
Modify | 428.74 | 429.25 | 429.74 | 2.3 | 48.97
|
||||
Other | | 1.092 | | | 0.12
|
||||
|
||||
Nlocal: 181.5 ave 207 max 169 min
|
||||
Histogram: 2 0 1 0 0 0 0 0 0 1
|
||||
Nghost: 1961.5 ave 1984 max 1926 min
|
||||
Histogram: 1 0 0 0 0 0 1 0 1 1
|
||||
Neighs: 30051 ave 41646 max 20775 min
|
||||
Histogram: 1 1 0 0 0 0 1 0 0 1
|
||||
Nlocal: 181.5 ave 195 max 166 min
|
||||
Histogram: 1 1 0 0 0 0 0 0 0 2
|
||||
Nghost: 1955.5 ave 1978 max 1931 min
|
||||
Histogram: 1 0 0 0 1 0 1 0 0 1
|
||||
Neighs: 30343 ave 39847 max 20428 min
|
||||
Histogram: 2 0 0 0 0 0 0 0 0 2
|
||||
|
||||
Total # of neighbors = 120204
|
||||
Ave neighs/atom = 165.57025
|
||||
Total # of neighbors = 121372
|
||||
Ave neighs/atom = 167.17906
|
||||
Ave special neighs/atom = 1.7355372
|
||||
Neighbor list builds = 7663
|
||||
Neighbor list builds = 7698
|
||||
Dangerous builds = 0
|
||||
write_data "data.piston.final"
|
||||
System init for write_data ...
|
||||
@ -214,11 +221,11 @@ PPPM/electrode initialization ...
|
||||
G vector (1/distance) = 0.32814871
|
||||
grid = 12 15 36
|
||||
stencil order = 5
|
||||
estimated absolute RMS force accuracy = 0.029311028
|
||||
estimated relative force accuracy = 8.8269289e-05
|
||||
using double precision MKL FFT
|
||||
estimated absolute RMS force accuracy = 0.029310954
|
||||
estimated relative force accuracy = 8.8269069e-05
|
||||
using double precision FFTW3
|
||||
3d grid and FFT values/proc = 8512 2880
|
||||
Generated 6 of 6 mixed pair_coeff terms from arithmetic mixing rule
|
||||
|
||||
Average conjugate gradient steps: 1.982
|
||||
Total wall time: 0:09:50
|
||||
Average conjugate gradient steps: 1.981
|
||||
Total wall time: 0:14:36
|
||||
305
examples/PACKAGES/pod/InP/InP_coefficients.pod
Normal file
305
examples/PACKAGES/pod/InP/InP_coefficients.pod
Normal file
@ -0,0 +1,305 @@
|
||||
model_coefficients: 304 0 0
|
||||
-3.756301
|
||||
914.674801
|
||||
-370.747265
|
||||
-141.227291
|
||||
97.101196
|
||||
-59.216907
|
||||
9.975284
|
||||
87.329406
|
||||
-10.969150
|
||||
14.411744
|
||||
-2.270453
|
||||
0.798817
|
||||
-0.121719
|
||||
114.805574
|
||||
-2631.563672
|
||||
-869.027988
|
||||
-1038.286258
|
||||
2431.480027
|
||||
31.972558
|
||||
139.437898
|
||||
29.230520
|
||||
39.179879
|
||||
-189.998549
|
||||
-16.358691
|
||||
18.699184
|
||||
13.386293
|
||||
12.847911
|
||||
7.310155
|
||||
1.677341
|
||||
-9.237073
|
||||
-2.228285
|
||||
0.137303
|
||||
6.446888
|
||||
-0.385837
|
||||
0.272000
|
||||
0.111052
|
||||
-1.264342
|
||||
-0.711451
|
||||
450.463638
|
||||
-499.339551
|
||||
550.704146
|
||||
-1638.278950
|
||||
-1311.408792
|
||||
-24.811632
|
||||
-14.000684
|
||||
-39.928838
|
||||
44.690659
|
||||
35.934791
|
||||
-0.425535
|
||||
16.810067
|
||||
-1.951262
|
||||
26.118670
|
||||
28.549237
|
||||
-1.779991
|
||||
-1.907896
|
||||
4.278671
|
||||
-5.852529
|
||||
-11.518503
|
||||
0.285252
|
||||
0.210939
|
||||
-1.153276
|
||||
0.744801
|
||||
2.765281
|
||||
-365.425648
|
||||
892.154409
|
||||
616.198109
|
||||
-808.930752
|
||||
-241.494545
|
||||
60.329248
|
||||
-50.220263
|
||||
-89.366098
|
||||
47.692144
|
||||
12.376825
|
||||
-11.304060
|
||||
-0.465577
|
||||
20.908593
|
||||
0.768057
|
||||
-0.296966
|
||||
-1.434787
|
||||
0.089423
|
||||
-3.273582
|
||||
1.085951
|
||||
1.627005
|
||||
0.063449
|
||||
0.501713
|
||||
-0.025247
|
||||
-1.127277
|
||||
-0.619276
|
||||
-950.742997
|
||||
11175.508296
|
||||
1041.077100
|
||||
-8713.542159
|
||||
11.024588
|
||||
-193.368092
|
||||
-17.871650
|
||||
193.000879
|
||||
-1.221800
|
||||
0.201038
|
||||
-0.297456
|
||||
10.197177
|
||||
0.118306
|
||||
-2.486775
|
||||
0.340362
|
||||
0.179573
|
||||
2064.315112
|
||||
11898.567992
|
||||
-7130.614814
|
||||
-2965.017905
|
||||
-36.665484
|
||||
-156.646217
|
||||
112.838247
|
||||
64.147104
|
||||
-0.187677
|
||||
8.822337
|
||||
-2.516814
|
||||
0.833110
|
||||
-0.808597
|
||||
-3.112898
|
||||
2.172317
|
||||
1.684634
|
||||
-5.757502
|
||||
4129.051881
|
||||
-2191.420379
|
||||
-5640.863432
|
||||
2.123836
|
||||
-34.024960
|
||||
35.525113
|
||||
106.884920
|
||||
0.406772
|
||||
6.365527
|
||||
-0.015093
|
||||
2.711538
|
||||
-0.263692
|
||||
-0.604293
|
||||
0.790243
|
||||
1.092726
|
||||
593.864089
|
||||
-2785.368577
|
||||
-1100.723468
|
||||
4424.744171
|
||||
-20.023164
|
||||
47.252092
|
||||
34.797296
|
||||
-101.504738
|
||||
-1.911711
|
||||
-0.110737
|
||||
3.998625
|
||||
-2.768303
|
||||
-0.189524
|
||||
0.793288
|
||||
-0.405026
|
||||
-1.116385
|
||||
4.808874
|
||||
86.919761
|
||||
-10.887316
|
||||
14.382398
|
||||
-2.271034
|
||||
0.710124
|
||||
-0.114050
|
||||
170.975102
|
||||
-54.119757
|
||||
-23.638119
|
||||
28.153323
|
||||
-15.183264
|
||||
2.919447
|
||||
-185.866164
|
||||
-1165.581453
|
||||
-1256.610349
|
||||
1133.815010
|
||||
814.761739
|
||||
9.901474
|
||||
31.315227
|
||||
40.389531
|
||||
-39.201068
|
||||
-50.871475
|
||||
3.268994
|
||||
19.578821
|
||||
12.684861
|
||||
-13.440885
|
||||
2.022633
|
||||
1.483279
|
||||
-4.388229
|
||||
0.944679
|
||||
3.110080
|
||||
-2.163427
|
||||
0.160512
|
||||
-0.197641
|
||||
-1.121333
|
||||
1.023995
|
||||
2.077494
|
||||
-78.649494
|
||||
15.740666
|
||||
1379.998028
|
||||
-267.931116
|
||||
-631.685867
|
||||
0.779724
|
||||
-28.384680
|
||||
-104.334909
|
||||
40.727192
|
||||
54.977623
|
||||
4.534376
|
||||
13.738711
|
||||
2.994157
|
||||
-10.950852
|
||||
-4.057951
|
||||
1.099589
|
||||
-1.782453
|
||||
3.174200
|
||||
2.605193
|
||||
-1.835511
|
||||
0.063386
|
||||
0.124447
|
||||
-0.881517
|
||||
-0.703873
|
||||
0.712785
|
||||
-567.114384
|
||||
363.884433
|
||||
-300.309621
|
||||
-1421.591050
|
||||
-1083.371637
|
||||
45.559123
|
||||
-7.797512
|
||||
24.330267
|
||||
71.829748
|
||||
60.799510
|
||||
-2.099976
|
||||
-9.821055
|
||||
-6.488823
|
||||
9.426431
|
||||
6.385231
|
||||
-0.836215
|
||||
3.533300
|
||||
2.741734
|
||||
-3.602311
|
||||
-3.863372
|
||||
-0.122980
|
||||
-0.147120
|
||||
-0.378902
|
||||
-0.232987
|
||||
0.445875
|
||||
-237.448044
|
||||
442.663085
|
||||
2103.157345
|
||||
-2382.920549
|
||||
0.583996
|
||||
-6.353184
|
||||
-17.798247
|
||||
72.320744
|
||||
-0.422216
|
||||
1.198193
|
||||
3.257409
|
||||
6.944903
|
||||
0.255190
|
||||
-0.887514
|
||||
-0.316214
|
||||
0.345565
|
||||
-242.443134
|
||||
4329.522091
|
||||
534.487792
|
||||
-4571.367114
|
||||
-9.591790
|
||||
-62.990215
|
||||
20.323544
|
||||
169.640829
|
||||
-2.788146
|
||||
2.114659
|
||||
7.272737
|
||||
21.210166
|
||||
0.904969
|
||||
-1.154060
|
||||
-1.376235
|
||||
-1.148246
|
||||
129.689234
|
||||
5953.209838
|
||||
667.823321
|
||||
-83.797221
|
||||
3.417016
|
||||
-126.968016
|
||||
-14.909772
|
||||
41.785404
|
||||
1.415997
|
||||
-5.278588
|
||||
-0.463605
|
||||
8.009232
|
||||
0.030211
|
||||
-0.765006
|
||||
-0.826223
|
||||
0.103515
|
||||
147.565462
|
||||
4404.556538
|
||||
3774.833555
|
||||
-2327.923578
|
||||
-5.422196
|
||||
-107.433002
|
||||
-70.175719
|
||||
74.887031
|
||||
-0.424490
|
||||
-6.620110
|
||||
-2.179770
|
||||
5.588150
|
||||
-0.222514
|
||||
-0.435209
|
||||
0.034179
|
||||
0.388588
|
||||
@ -1,20 +1,21 @@
|
||||
file_format extxyz
|
||||
file_extension xyz
|
||||
|
||||
path_to_training_data_set "../Ta/XYZ"
|
||||
path_to_test_data_set "../Ta/XYZ"
|
||||
path_to_training_data_set "XYZ"
|
||||
path_to_test_data_set "XYZ"
|
||||
path_to_environment_configuration_set "XYZ"
|
||||
|
||||
fitting_weight_energy 100.0
|
||||
fitting_weight_force 1.0
|
||||
fitting_regularization_parameter 1e-10
|
||||
fitting_regularization_parameter 1e-12
|
||||
|
||||
error_analysis_for_training_data_set 1
|
||||
error_analysis_for_test_data_set 0
|
||||
|
||||
# Add the following basename to the name of output files
|
||||
basename_for_output_files Ta
|
||||
basename_for_output_files InP
|
||||
|
||||
# number of digits after the decimal point for pod coefficients
|
||||
precision_for_pod_coefficients 5
|
||||
precision_for_pod_coefficients 6
|
||||
|
||||
|
||||
48
examples/PACKAGES/pod/InP/InP_param.pod
Normal file
48
examples/PACKAGES/pod/InP/InP_param.pod
Normal file
@ -0,0 +1,48 @@
|
||||
# chemical element symbols
|
||||
species In P
|
||||
|
||||
# periodic boundary conditions
|
||||
pbc 1 1 1
|
||||
|
||||
# inner cut-off radius
|
||||
rin 0.8
|
||||
|
||||
# outer cut-off radius
|
||||
rcut 5.0
|
||||
|
||||
# use only for enviroment-adaptive potentials
|
||||
number_of_environment_clusters 1
|
||||
|
||||
# principal_components of local descriptors
|
||||
number_of_principal_components 2
|
||||
|
||||
# polynomial degrees for radial basis functions
|
||||
bessel_polynomial_degree 4
|
||||
inverse_polynomial_degree 8
|
||||
|
||||
# one-body potential
|
||||
onebody 1
|
||||
|
||||
# two-body linear POD potential
|
||||
twobody_number_radial_basis_functions 6
|
||||
|
||||
# three-body linear POD potential
|
||||
threebody_number_radial_basis_functions 5
|
||||
threebody_angular_degree 4
|
||||
|
||||
# four-body linear POD potential
|
||||
fourbody_number_radial_basis_functions 4
|
||||
fourbody_angular_degree 2
|
||||
|
||||
# five-body linear POD potential
|
||||
fivebody_number_radial_basis_functions 0
|
||||
fivebody_angular_degree 0
|
||||
|
||||
# six-body linear POD potential
|
||||
sixbody_number_radial_basis_functions 0
|
||||
sixbody_angular_degree 0
|
||||
|
||||
# seven-body linear POD potential
|
||||
sevenbody_number_radial_basis_functions 0
|
||||
sevenbody_angular_degree 0
|
||||
|
||||
1932
examples/PACKAGES/pod/InP/InP_training_analysis.pod
Normal file
1932
examples/PACKAGES/pod/InP/InP_training_analysis.pod
Normal file
File diff suppressed because it is too large
Load Diff
27
examples/PACKAGES/pod/InP/InP_training_errors.pod
Normal file
27
examples/PACKAGES/pod/InP/InP_training_errors.pod
Normal file
@ -0,0 +1,27 @@
|
||||
**************** Begin of Error Analysis for the Training Data Set ****************
|
||||
--------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
--------------------------------------------------------------------------------------------
|
||||
Bulk.xyz 1 8 0.001678 0.001678 0.000000 0.000000
|
||||
EOS.xyz 268 2080 0.001463 0.001817 0.001107 0.015463
|
||||
Shear.xyz 346 2768 0.000415 0.000640 0.008336 0.012865
|
||||
Strain.xyz 163 1304 0.001129 0.001374 0.000021 0.000036
|
||||
aIn.xyz 54 11664 0.000737 0.000796 0.007969 0.016112
|
||||
aP.xyz 21 4536 0.001396 0.001407 0.019599 0.054174
|
||||
aa.xyz 20 4320 0.001991 0.001991 0.016735 0.027955
|
||||
iIn.xyz 41 8897 0.001548 0.001687 0.013910 0.025462
|
||||
iP.xyz 100 21700 0.001090 0.001203 0.009692 0.018549
|
||||
s_aIn.xyz 121 7744 0.000856 0.000889 0.011041 0.017399
|
||||
s_aP.xyz 72 4608 0.002255 0.003587 0.032425 0.045878
|
||||
s_aa.xyz 18 1152 0.001198 0.001200 0.037169 0.047713
|
||||
s_iIn.xyz 144 9360 0.002014 0.002255 0.035374 0.050726
|
||||
s_iP.xyz 337 21905 0.001655 0.002178 0.025130 0.038368
|
||||
s_vIn.xyz 17 1071 0.007984 0.007992 0.023190 0.039575
|
||||
s_vP.xyz 77 4851 0.000245 0.000281 0.018303 0.025819
|
||||
s_vv.xyz 65 4030 0.001759 0.001986 0.039037 0.052667
|
||||
vP.xyz 10 2150 0.000640 0.000640 0.005452 0.009834
|
||||
vv.xyz 19 4066 0.001336 0.001403 0.020930 0.034386
|
||||
--------------------------------------------------------------------------------------------
|
||||
All files 1894 118214 0.001288 0.001855 0.018109 0.032649
|
||||
--------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
16
examples/PACKAGES/pod/InP/README.md
Normal file
16
examples/PACKAGES/pod/InP/README.md
Normal file
@ -0,0 +1,16 @@
|
||||
### POD example for InP
|
||||
|
||||
We will fit a potential to the `InP` training data in the `XYZ` directory, which houses `.xyz` files
|
||||
|
||||
Please download the training data from [the repo](https://github.com/cesmix-mit/pod-examples/tree/main/JCP2023_InP/XYZ)
|
||||
|
||||
Fit POD with
|
||||
|
||||
lmp -in in.fitpod
|
||||
|
||||
This creates `InP_coefficients.pod` for the linear model, which we can use to run MD with
|
||||
|
||||
lmp -in in.pod
|
||||
|
||||
|
||||
|
||||
1
examples/PACKAGES/pod/InP/in.fitpod
Normal file
1
examples/PACKAGES/pod/InP/in.fitpod
Normal file
@ -0,0 +1 @@
|
||||
fitpod InP_param.pod InP_data.pod
|
||||
@ -1,13 +1,13 @@
|
||||
# Demonstrate POD Ta potential
|
||||
# Demonstrate POD potential for InP
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 3.316
|
||||
variable a equal 5.83
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
# generate the box and atom positions using a FCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable ny equal ${nrep}
|
||||
@ -15,17 +15,17 @@ variable nz equal ${nrep}
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice bcc $a
|
||||
lattice diamond $a
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
create_box 1 box
|
||||
create_atoms 1 box
|
||||
|
||||
mass 1 180.88
|
||||
create_box 2 box
|
||||
create_atoms 1 box basis 5 2 basis 6 2 basis 7 2 basis 8 2
|
||||
|
||||
mass 1 114.76
|
||||
mass 2 30.98
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * Ta_param.pod Ta_coefficients.pod Ta
|
||||
pair_coeff * * InP_param.pod InP_coefficients.pod In P
|
||||
|
||||
# Setup output
|
||||
|
||||
@ -44,4 +44,3 @@ velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
|
||||
|
||||
163
examples/PACKAGES/pod/InP/log.22May24.fitpod.g++.1
Normal file
163
examples/PACKAGES/pod/InP/log.22May24.fitpod.g++.1
Normal file
@ -0,0 +1,163 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-176-gc2e4ad220f-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
fitpod InP_param.pod InP_data.pod
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: In P
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 0.8
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 4
|
||||
inverse polynomial degree: 8
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 4
|
||||
four-body angular degree: 2
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 12
|
||||
number of local descriptors per element for three-body potential: 75
|
||||
number of local descriptors per element for four-body potential: 64
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 152
|
||||
number of global descriptors: 304
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Data File ****************
|
||||
file format: extxyz
|
||||
file extension: xyz
|
||||
path to training data set: XYZ
|
||||
path to test data set: XYZ
|
||||
path to environment configuration set: XYZ
|
||||
basename for output files: InP
|
||||
training fraction: 1
|
||||
test fraction: 1
|
||||
randomize training data set: 1
|
||||
randomize test data set: 1
|
||||
error analysis for training data set: 1
|
||||
error analysis for test data set: 0
|
||||
energy/force calculation for training data set: 0
|
||||
energy/force calculation for test data set: 0
|
||||
fitting weight for energy: 100
|
||||
fitting weight for force: 1
|
||||
fitting weight for stress: 0
|
||||
save pod descriptors: 0
|
||||
compute pod descriptors: 0
|
||||
**************** End of Data File ****************
|
||||
**************** Begin of Training Data Set ****************
|
||||
--------------------------------------------------------
|
||||
data file | number of configurations | number of atoms
|
||||
--------------------------------------------------------
|
||||
Bulk.xyz | 1 | 8
|
||||
EOS.xyz | 268 | 2080
|
||||
Shear.xyz | 346 | 2768
|
||||
Strain.xyz | 163 | 1304
|
||||
aIn.xyz | 54 | 11664
|
||||
aP.xyz | 21 | 4536
|
||||
aa.xyz | 20 | 4320
|
||||
iIn.xyz | 41 | 8897
|
||||
iP.xyz | 100 | 21700
|
||||
s_aIn.xyz | 121 | 7744
|
||||
s_aP.xyz | 72 | 4608
|
||||
s_aa.xyz | 18 | 1152
|
||||
s_iIn.xyz | 144 | 9360
|
||||
s_iP.xyz | 337 | 21905
|
||||
s_vIn.xyz | 17 | 1071
|
||||
s_vP.xyz | 77 | 4851
|
||||
s_vv.xyz | 65 | 4030
|
||||
vP.xyz | 10 | 2150
|
||||
vv.xyz | 19 | 4066
|
||||
--------------------------------------------------------
|
||||
number of files: 19
|
||||
number of configurations in all files: 1894
|
||||
number of atoms in all files: 118214
|
||||
minimum number of atoms: 4
|
||||
maximum number of atoms: 217
|
||||
**************** End of Training Data Set ****************
|
||||
**************** Begin of Memory Allocation ****************
|
||||
maximum number of atoms in periodic domain: 217
|
||||
maximum number of atoms in extended domain: 5859
|
||||
maximum number of neighbors in extended domain: 1271403
|
||||
size of double memory: 5555904
|
||||
size of descriptor matrix: 304 x 304
|
||||
**************** End of Memory Allocation ****************
|
||||
**************** Begin of Least-Squares Fitting ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
Configuration: # 401
|
||||
Configuration: # 501
|
||||
Configuration: # 601
|
||||
Configuration: # 701
|
||||
Configuration: # 801
|
||||
Configuration: # 901
|
||||
Configuration: # 1001
|
||||
Configuration: # 1101
|
||||
Configuration: # 1201
|
||||
Configuration: # 1301
|
||||
Configuration: # 1401
|
||||
Configuration: # 1501
|
||||
Configuration: # 1601
|
||||
Configuration: # 1701
|
||||
Configuration: # 1801
|
||||
**************** Begin of Error Calculation ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
Configuration: # 401
|
||||
Configuration: # 501
|
||||
Configuration: # 601
|
||||
Configuration: # 701
|
||||
Configuration: # 801
|
||||
Configuration: # 901
|
||||
Configuration: # 1001
|
||||
Configuration: # 1101
|
||||
Configuration: # 1201
|
||||
Configuration: # 1301
|
||||
Configuration: # 1401
|
||||
Configuration: # 1501
|
||||
Configuration: # 1601
|
||||
Configuration: # 1701
|
||||
Configuration: # 1801
|
||||
**************** End of Error Calculation ****************
|
||||
**************** Begin of Error Analysis for the Training Data Set ****************
|
||||
--------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
--------------------------------------------------------------------------------------------
|
||||
Bulk.xyz 1 8 0.001678 0.001678 0.000000 0.000000
|
||||
EOS.xyz 268 2080 0.001463 0.001817 0.001107 0.015464
|
||||
Shear.xyz 346 2768 0.000415 0.000640 0.008335 0.012863
|
||||
Strain.xyz 163 1304 0.001129 0.001374 0.000021 0.000036
|
||||
aIn.xyz 54 11664 0.000737 0.000796 0.007969 0.016112
|
||||
aP.xyz 21 4536 0.001396 0.001407 0.019599 0.054174
|
||||
aa.xyz 20 4320 0.001991 0.001991 0.016735 0.027955
|
||||
iIn.xyz 41 8897 0.001548 0.001687 0.013910 0.025462
|
||||
iP.xyz 100 21700 0.001090 0.001203 0.009692 0.018549
|
||||
s_aIn.xyz 121 7744 0.000856 0.000889 0.011041 0.017399
|
||||
s_aP.xyz 72 4608 0.002255 0.003587 0.032425 0.045878
|
||||
s_aa.xyz 18 1152 0.001198 0.001200 0.037169 0.047713
|
||||
s_iIn.xyz 144 9360 0.002014 0.002255 0.035374 0.050726
|
||||
s_iP.xyz 337 21905 0.001655 0.002178 0.025130 0.038368
|
||||
s_vIn.xyz 17 1071 0.007984 0.007992 0.023190 0.039575
|
||||
s_vP.xyz 77 4851 0.000245 0.000281 0.018303 0.025818
|
||||
s_vv.xyz 65 4030 0.001759 0.001986 0.039037 0.052667
|
||||
vP.xyz 10 2150 0.000640 0.000640 0.005452 0.009834
|
||||
vv.xyz 19 4066 0.001336 0.001403 0.020930 0.034386
|
||||
--------------------------------------------------------------------------------------------
|
||||
All files 1894 118214 0.001288 0.001855 0.018109 0.032648
|
||||
--------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
Total wall time: 0:00:27
|
||||
163
examples/PACKAGES/pod/InP/log.22May24.fitpod.g++.4
Normal file
163
examples/PACKAGES/pod/InP/log.22May24.fitpod.g++.4
Normal file
@ -0,0 +1,163 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-176-gc2e4ad220f-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
fitpod InP_param.pod InP_data.pod
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: In P
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 0.8
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 4
|
||||
inverse polynomial degree: 8
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 4
|
||||
four-body angular degree: 2
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 12
|
||||
number of local descriptors per element for three-body potential: 75
|
||||
number of local descriptors per element for four-body potential: 64
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 152
|
||||
number of global descriptors: 304
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Data File ****************
|
||||
file format: extxyz
|
||||
file extension: xyz
|
||||
path to training data set: XYZ
|
||||
path to test data set: XYZ
|
||||
path to environment configuration set: XYZ
|
||||
basename for output files: InP
|
||||
training fraction: 1
|
||||
test fraction: 1
|
||||
randomize training data set: 1
|
||||
randomize test data set: 1
|
||||
error analysis for training data set: 1
|
||||
error analysis for test data set: 0
|
||||
energy/force calculation for training data set: 0
|
||||
energy/force calculation for test data set: 0
|
||||
fitting weight for energy: 100
|
||||
fitting weight for force: 1
|
||||
fitting weight for stress: 0
|
||||
save pod descriptors: 0
|
||||
compute pod descriptors: 0
|
||||
**************** End of Data File ****************
|
||||
**************** Begin of Training Data Set ****************
|
||||
--------------------------------------------------------
|
||||
data file | number of configurations | number of atoms
|
||||
--------------------------------------------------------
|
||||
Bulk.xyz | 1 | 8
|
||||
EOS.xyz | 268 | 2080
|
||||
Shear.xyz | 346 | 2768
|
||||
Strain.xyz | 163 | 1304
|
||||
aIn.xyz | 54 | 11664
|
||||
aP.xyz | 21 | 4536
|
||||
aa.xyz | 20 | 4320
|
||||
iIn.xyz | 41 | 8897
|
||||
iP.xyz | 100 | 21700
|
||||
s_aIn.xyz | 121 | 7744
|
||||
s_aP.xyz | 72 | 4608
|
||||
s_aa.xyz | 18 | 1152
|
||||
s_iIn.xyz | 144 | 9360
|
||||
s_iP.xyz | 337 | 21905
|
||||
s_vIn.xyz | 17 | 1071
|
||||
s_vP.xyz | 77 | 4851
|
||||
s_vv.xyz | 65 | 4030
|
||||
vP.xyz | 10 | 2150
|
||||
vv.xyz | 19 | 4066
|
||||
--------------------------------------------------------
|
||||
number of files: 19
|
||||
number of configurations in all files: 1894
|
||||
number of atoms in all files: 118214
|
||||
minimum number of atoms: 4
|
||||
maximum number of atoms: 217
|
||||
**************** End of Training Data Set ****************
|
||||
**************** Begin of Memory Allocation ****************
|
||||
maximum number of atoms in periodic domain: 217
|
||||
maximum number of atoms in extended domain: 5859
|
||||
maximum number of neighbors in extended domain: 1271403
|
||||
size of double memory: 5555904
|
||||
size of descriptor matrix: 304 x 304
|
||||
**************** End of Memory Allocation ****************
|
||||
**************** Begin of Least-Squares Fitting ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
Configuration: # 401
|
||||
Configuration: # 501
|
||||
Configuration: # 601
|
||||
Configuration: # 701
|
||||
Configuration: # 801
|
||||
Configuration: # 901
|
||||
Configuration: # 1001
|
||||
Configuration: # 1101
|
||||
Configuration: # 1201
|
||||
Configuration: # 1301
|
||||
Configuration: # 1401
|
||||
Configuration: # 1501
|
||||
Configuration: # 1601
|
||||
Configuration: # 1701
|
||||
Configuration: # 1801
|
||||
**************** Begin of Error Calculation ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
Configuration: # 401
|
||||
Configuration: # 501
|
||||
Configuration: # 601
|
||||
Configuration: # 701
|
||||
Configuration: # 801
|
||||
Configuration: # 901
|
||||
Configuration: # 1001
|
||||
Configuration: # 1101
|
||||
Configuration: # 1201
|
||||
Configuration: # 1301
|
||||
Configuration: # 1401
|
||||
Configuration: # 1501
|
||||
Configuration: # 1601
|
||||
Configuration: # 1701
|
||||
Configuration: # 1801
|
||||
**************** End of Error Calculation ****************
|
||||
**************** Begin of Error Analysis for the Training Data Set ****************
|
||||
--------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
--------------------------------------------------------------------------------------------
|
||||
Bulk.xyz 1 8 0.001678 0.001678 0.000000 0.000000
|
||||
EOS.xyz 268 2080 0.001463 0.001817 0.001107 0.015463
|
||||
Shear.xyz 346 2768 0.000415 0.000640 0.008336 0.012865
|
||||
Strain.xyz 163 1304 0.001129 0.001374 0.000021 0.000036
|
||||
aIn.xyz 54 11664 0.000737 0.000796 0.007969 0.016112
|
||||
aP.xyz 21 4536 0.001396 0.001407 0.019599 0.054174
|
||||
aa.xyz 20 4320 0.001991 0.001991 0.016735 0.027955
|
||||
iIn.xyz 41 8897 0.001548 0.001687 0.013910 0.025462
|
||||
iP.xyz 100 21700 0.001090 0.001203 0.009692 0.018549
|
||||
s_aIn.xyz 121 7744 0.000856 0.000889 0.011041 0.017399
|
||||
s_aP.xyz 72 4608 0.002255 0.003587 0.032425 0.045878
|
||||
s_aa.xyz 18 1152 0.001198 0.001200 0.037169 0.047713
|
||||
s_iIn.xyz 144 9360 0.002014 0.002255 0.035374 0.050726
|
||||
s_iP.xyz 337 21905 0.001655 0.002178 0.025130 0.038368
|
||||
s_vIn.xyz 17 1071 0.007984 0.007992 0.023190 0.039575
|
||||
s_vP.xyz 77 4851 0.000245 0.000281 0.018303 0.025819
|
||||
s_vv.xyz 65 4030 0.001759 0.001986 0.039037 0.052667
|
||||
vP.xyz 10 2150 0.000640 0.000640 0.005452 0.009834
|
||||
vv.xyz 19 4066 0.001336 0.001403 0.020930 0.034386
|
||||
--------------------------------------------------------------------------------------------
|
||||
All files 1894 118214 0.001288 0.001855 0.018109 0.032649
|
||||
--------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
Total wall time: 0:00:10
|
||||
155
examples/PACKAGES/pod/InP/log.22May24.pod.g++.1
Normal file
155
examples/PACKAGES/pod/InP/log.22May24.pod.g++.1
Normal file
@ -0,0 +1,155 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-176-gc2e4ad220f-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD potential for InP
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 5.83
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a FCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice diamond $a
|
||||
lattice diamond 5.83
|
||||
Lattice spacing in x,y,z = 5.83 5.83 5.83
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 2 box
|
||||
Created orthogonal box = (0 0 0) to (23.32 23.32 23.32)
|
||||
1 by 1 by 1 MPI processor grid
|
||||
create_atoms 1 box basis 5 2 basis 6 2 basis 7 2 basis 8 2
|
||||
Created 512 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (23.32 23.32 23.32)
|
||||
create_atoms CPU = 0.001 seconds
|
||||
|
||||
mass 1 114.76
|
||||
mass 2 30.98
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * InP_param.pod InP_coefficients.pod In P
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: In P
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 0.8
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 4
|
||||
inverse polynomial degree: 8
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 4
|
||||
four-body angular degree: 2
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 12
|
||||
number of local descriptors per element for three-body potential: 75
|
||||
number of local descriptors per element for four-body potential: 64
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 152
|
||||
number of global descriptors: 304
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 304
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 8 8 8
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.244 | 3.244 | 3.244 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -4.8392777 0 -4.8005754 1561.0654
|
||||
10 291.27079 -4.8381515 0 -4.8005753 1709.509
|
||||
20 266.69372 -4.8349805 0 -4.8005749 2126.86
|
||||
30 230.86163 -4.8303573 0 -4.8005744 2735.6894
|
||||
40 190.64668 -4.8251686 0 -4.8005738 3416.9247
|
||||
50 153.9516 -4.8204341 0 -4.8005732 4022.2533
|
||||
60 127.93805 -4.8170778 0 -4.8005728 4405.9763
|
||||
70 117.12501 -4.8156828 0 -4.8005727 4475.6131
|
||||
80 122.09497 -4.8163242 0 -4.800573 4231.7934
|
||||
90 139.42686 -4.8185607 0 -4.8005735 3766.8505
|
||||
100 162.84813 -4.8215828 0 -4.8005741 3221.8605
|
||||
Loop time of 2.18542 on 1 procs for 100 steps with 512 atoms
|
||||
|
||||
Performance: 1.977 ns/day, 12.141 hours/ns, 45.758 timesteps/s, 23.428 katom-step/s
|
||||
97.9% CPU use with 1 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 2.1829 | 2.1829 | 2.1829 | 0.0 | 99.88
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.00080748 | 0.00080748 | 0.00080748 | 0.0 | 0.04
|
||||
Output | 0.00033584 | 0.00033584 | 0.00033584 | 0.0 | 0.02
|
||||
Modify | 0.00071224 | 0.00071224 | 0.00071224 | 0.0 | 0.03
|
||||
Other | | 0.000686 | | | 0.03
|
||||
|
||||
Nlocal: 512 ave 512 max 512 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 1451 ave 1451 max 1451 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 17408 ave 17408 max 17408 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 17408
|
||||
Ave neighs/atom = 34
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
Total wall time: 0:00:02
|
||||
155
examples/PACKAGES/pod/InP/log.22May24.pod.g++.4
Normal file
155
examples/PACKAGES/pod/InP/log.22May24.pod.g++.4
Normal file
@ -0,0 +1,155 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-176-gc2e4ad220f-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD potential for InP
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 5.83
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a FCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice diamond $a
|
||||
lattice diamond 5.83
|
||||
Lattice spacing in x,y,z = 5.83 5.83 5.83
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 2 box
|
||||
Created orthogonal box = (0 0 0) to (23.32 23.32 23.32)
|
||||
1 by 2 by 2 MPI processor grid
|
||||
create_atoms 1 box basis 5 2 basis 6 2 basis 7 2 basis 8 2
|
||||
Created 512 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (23.32 23.32 23.32)
|
||||
create_atoms CPU = 0.001 seconds
|
||||
|
||||
mass 1 114.76
|
||||
mass 2 30.98
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * InP_param.pod InP_coefficients.pod In P
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: In P
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 0.8
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 4
|
||||
inverse polynomial degree: 8
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 4
|
||||
four-body angular degree: 2
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 12
|
||||
number of local descriptors per element for three-body potential: 75
|
||||
number of local descriptors per element for four-body potential: 64
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 152
|
||||
number of global descriptors: 304
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 304
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 8 8 8
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.215 | 3.215 | 3.215 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -4.8392777 0 -4.8005754 1561.0654
|
||||
10 291.27079 -4.8381515 0 -4.8005753 1709.509
|
||||
20 266.69372 -4.8349805 0 -4.8005749 2126.86
|
||||
30 230.86163 -4.8303573 0 -4.8005744 2735.6894
|
||||
40 190.64668 -4.8251686 0 -4.8005738 3416.9247
|
||||
50 153.9516 -4.8204341 0 -4.8005732 4022.2533
|
||||
60 127.93805 -4.8170778 0 -4.8005728 4405.9763
|
||||
70 117.12501 -4.8156828 0 -4.8005727 4475.6131
|
||||
80 122.09497 -4.8163242 0 -4.800573 4231.7934
|
||||
90 139.42686 -4.8185607 0 -4.8005735 3766.8505
|
||||
100 162.84813 -4.8215828 0 -4.8005741 3221.8605
|
||||
Loop time of 0.818141 on 4 procs for 100 steps with 512 atoms
|
||||
|
||||
Performance: 5.280 ns/day, 4.545 hours/ns, 122.228 timesteps/s, 62.581 katom-step/s
|
||||
94.0% CPU use with 4 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 0.70717 | 0.7255 | 0.75748 | 2.2 | 88.68
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.05765 | 0.088203 | 0.10797 | 6.3 | 10.78
|
||||
Output | 0.00030107 | 0.00039215 | 0.00055987 | 0.0 | 0.05
|
||||
Modify | 0.00051915 | 0.00059064 | 0.00069306 | 0.0 | 0.07
|
||||
Other | | 0.003452 | | | 0.42
|
||||
|
||||
Nlocal: 128 ave 128 max 128 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 783 ave 783 max 783 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 4352 ave 4352 max 4352 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 17408
|
||||
Ave neighs/atom = 34
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
Total wall time: 0:00:00
|
||||
@ -3,19 +3,36 @@
|
||||
Go to `lammps` directory and build with the POD package:
|
||||
|
||||
cd path/to/lammps
|
||||
mkdir build-pod
|
||||
cd build-pod
|
||||
mkdir build
|
||||
cd build
|
||||
cmake -C ../cmake/presets/basic.cmake -D PKG_ML-POD=on ../cmake
|
||||
cmake --build .
|
||||
|
||||
### Fit a POD potential for tantalum
|
||||
### Compile LAMMPS/POD with Kokkos
|
||||
|
||||
cmake -C ../cmake/presets/basic.cmake -C ../cmake/presets/kokkos-cuda.cmake -D PKG_ML-POD=on ../cmake
|
||||
|
||||
### Fit a POD potential for Tantalum
|
||||
|
||||
Go to `lammps/examples/PACKAGES/pod/Ta` directory and run
|
||||
|
||||
lmp -in in.podfit
|
||||
lmp -in Ta_fit.pod
|
||||
|
||||
See the README in `lammps/examples/PACKAGES/pod/Ta` for instructions on how to run MD with the potential.
|
||||
This creates `Ta_coefficients.pod` for the linear model, which we can use to run MD with
|
||||
|
||||
lmp -in Ta_mdrun.pod
|
||||
|
||||
### Fit a POD potential for Indium Phosphide
|
||||
|
||||
Go to `lammps/examples/PACKAGES/pod/InP` directory and run
|
||||
|
||||
lmp -in InP_fit.pod
|
||||
|
||||
This creates `InP_coefficients.pod` for the linear model, which we can use to run MD with
|
||||
|
||||
lmp -in InP_mdrun.pod
|
||||
|
||||
### Examples for other materials
|
||||
|
||||
See [https://github.com/cesmix-mit/pod-examples](https://github.com/cesmix-mit/pod-examples)
|
||||
|
||||
|
||||
@ -1 +0,0 @@
|
||||
../../../../potentials/Ta_coeff.pod
|
||||
33
examples/PACKAGES/pod/Ta/Ta_coeff.pod
Normal file
33
examples/PACKAGES/pod/Ta/Ta_coeff.pod
Normal file
@ -0,0 +1,33 @@
|
||||
model_coefficients: 32 0 0
|
||||
-4.45745
|
||||
29.40034
|
||||
-13.69439
|
||||
-0.32907
|
||||
-0.14786
|
||||
-1.35221
|
||||
-0.59315
|
||||
-26.30409
|
||||
-33.37233
|
||||
162.42473
|
||||
144.67248
|
||||
-149.50021
|
||||
1.78603
|
||||
2.49026
|
||||
-11.04768
|
||||
-11.14333
|
||||
12.40537
|
||||
0.48284
|
||||
0.39345
|
||||
-2.25812
|
||||
-1.38908
|
||||
1.31551
|
||||
0.02974
|
||||
-0.05094
|
||||
-0.21177
|
||||
0.12127
|
||||
0.23170
|
||||
0.02426
|
||||
-0.15305
|
||||
-0.10803
|
||||
0.25628
|
||||
0.01291
|
||||
@ -1,33 +1,33 @@
|
||||
POD_coefficients: 32
|
||||
-4.44242
|
||||
4.10219
|
||||
2.36987
|
||||
3.92184
|
||||
-0.83796
|
||||
-0.79457
|
||||
-0.26230
|
||||
-21.24294
|
||||
-15.38460
|
||||
-38.44056
|
||||
8.29872
|
||||
-42.54514
|
||||
2.79976
|
||||
3.76109
|
||||
5.23499
|
||||
0.04878
|
||||
2.96006
|
||||
0.09101
|
||||
-0.19257
|
||||
-0.24326
|
||||
-0.16735
|
||||
0.53738
|
||||
0.02236
|
||||
-0.00154
|
||||
0.02488
|
||||
-0.00565
|
||||
0.07672
|
||||
-0.05894
|
||||
-0.05604
|
||||
-0.12664
|
||||
0.11723
|
||||
0.00262
|
||||
model_coefficients: 32 0 0
|
||||
-4.45745
|
||||
29.40034
|
||||
-13.69439
|
||||
-0.32907
|
||||
-0.14786
|
||||
-1.35221
|
||||
-0.59315
|
||||
-26.30409
|
||||
-33.37233
|
||||
162.42473
|
||||
144.67248
|
||||
-149.50021
|
||||
1.78603
|
||||
2.49026
|
||||
-11.04768
|
||||
-11.14333
|
||||
12.40537
|
||||
0.48284
|
||||
0.39345
|
||||
-2.25812
|
||||
-1.38908
|
||||
1.31551
|
||||
0.02974
|
||||
-0.05094
|
||||
-0.21177
|
||||
0.12127
|
||||
0.23170
|
||||
0.02426
|
||||
-0.15305
|
||||
-0.10803
|
||||
0.25628
|
||||
0.01291
|
||||
|
||||
@ -3,10 +3,11 @@ file_extension xyz
|
||||
|
||||
path_to_training_data_set "XYZ"
|
||||
path_to_test_data_set "XYZ"
|
||||
path_to_environment_configuration_set "XYZ"
|
||||
|
||||
fitting_weight_energy 100.0
|
||||
fitting_weight_force 1.0
|
||||
fitting_regularization_parameter 1e-10
|
||||
fitting_regularization_parameter 1e-12
|
||||
|
||||
error_analysis_for_training_data_set 1
|
||||
error_analysis_for_test_data_set 0
|
||||
@ -17,4 +18,3 @@ basename_for_output_files Ta
|
||||
# number of digits after the decimal point for pod coefficients
|
||||
precision_for_pod_coefficients 5
|
||||
|
||||
|
||||
|
||||
@ -1,4 +1,3 @@
|
||||
# DATE: 2022-11-30 UNITS: metal CONTRIBUTOR: Ngoc Cuong Nguyen, exapde@gmail.com CITATION: https://arxiv.org/abs/2209.02362
|
||||
# chemical element symbols
|
||||
species Ta
|
||||
|
||||
@ -11,22 +10,37 @@ rin 1.0
|
||||
# outer cut-off radius
|
||||
rcut 5.0
|
||||
|
||||
# use only for enviroment-adaptive potentials
|
||||
number_of_environment_clusters 1
|
||||
|
||||
# principal_components of local descriptors
|
||||
number_of_principal_components 2
|
||||
|
||||
# polynomial degrees for radial basis functions
|
||||
bessel_polynomial_degree 3
|
||||
inverse_polynomial_degree 6
|
||||
|
||||
# one-body potential
|
||||
onebody 1
|
||||
|
||||
# two-body linear POD potential
|
||||
twobody_number_radial_basis_functions 6
|
||||
|
||||
# three-body linear POD potential
|
||||
threebody_number_radial_basis_functions 5
|
||||
threebody_number_angular_basis_functions 5
|
||||
threebody_angular_degree 4
|
||||
|
||||
# four-body linear POD potential
|
||||
fourbody_number_radial_basis_functions 0
|
||||
fourbody_angular_degree 0
|
||||
|
||||
# five-body linear POD potential
|
||||
fivebody_number_radial_basis_functions 0
|
||||
fivebody_angular_degree 0
|
||||
|
||||
# six-body linear POD potential
|
||||
sixbody_number_radial_basis_functions 0
|
||||
sixbody_angular_degree 0
|
||||
|
||||
# seven-body linear POD potential
|
||||
sevenbody_number_radial_basis_functions 0
|
||||
sevenbody_angular_degree 0
|
||||
|
||||
# four-body linear SNAP potential
|
||||
fourbody_snap_twojmax 0
|
||||
|
||||
# quadratic POD potential
|
||||
quadratic_pod_potential 0
|
||||
|
||||
@ -1,387 +1,387 @@
|
||||
# Displaced_A15.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
1 64 -753.4412087 -754.220443 0.01217553565 7.734608752 8.398670477 0.1147177501
|
||||
2 64 -752.99206 -753.865255 0.01364367179 8.845831302 9.134430545 0.128875643
|
||||
3 64 -753.3230789 -754.0221 0.01092220404 8.320493902 9.017261102 0.1155421197
|
||||
4 64 -753.5972757 -754.279613 0.01066151964 7.709417684 8.381725092 0.1058659753
|
||||
5 64 -753.0554721 -753.777209 0.01127713895 8.89827564 9.478314477 0.1191609049
|
||||
6 64 -753.3515905 -754.048643 0.01089144564 7.808950564 8.465317938 0.1128142237
|
||||
7 64 -753.6515992 -754.317603 0.01040630929 7.441773668 8.127690491 0.1024025645
|
||||
8 64 -753.3305668 -753.969161 0.009978033993 8.524333384 9.425464952 0.1066300011
|
||||
9 64 -753.3982699 -754.141988 0.01162059588 8.165654685 8.821346913 0.1141641875
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
1 64 1191.016129 -753.1698421 -754.220443 0.01641563835 7.40295037 8.398670477 0.1439758999
|
||||
2 64 1191.016129 -752.7395784 -753.865255 0.01758869658 8.280515739 9.134430545 0.1607787343
|
||||
3 64 1191.016129 -753.08785 -754.0221 0.01459765574 7.697535492 9.017261102 0.1420603113
|
||||
4 64 1191.016129 -753.3517402 -754.279613 0.01449801277 7.132364917 8.381725092 0.1340575727
|
||||
5 64 1191.016129 -752.7757043 -753.777209 0.01564851147 8.360253864 9.478314477 0.1513006151
|
||||
6 64 1191.016129 -753.0381763 -754.048643 0.01578854208 7.591838888 8.465317938 0.1285134018
|
||||
7 64 1191.016129 -753.3574797 -754.317603 0.01500192578 7.082010429 8.127690491 0.1223953112
|
||||
8 64 1191.016129 -753.1004299 -753.969161 0.01357392266 7.903578432 9.425464952 0.1365521197
|
||||
9 64 1191.016129 -753.1947122 -754.141988 0.01480118465 7.516622986 8.821346913 0.1457127007
|
||||
# Displaced_BCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
10 54 -631.72742 -631.019667 0.01310653789 15.42892812 16.625876 0.264811012
|
||||
11 54 -632.2725892 -631.719595 0.01024063328 14.51788198 15.58666626 0.2236637006
|
||||
12 54 -631.9431698 -631.386255 0.01031323642 15.21539049 15.92378883 0.2259171686
|
||||
13 54 -633.0728554 -632.575826 0.00920424781 13.38472946 14.55977162 0.2050161952
|
||||
14 54 -630.8933737 -630.450212 0.008206698429 16.5539163 16.96340726 0.2366453149
|
||||
15 54 -632.0739208 -631.669379 0.007491515672 15.23887638 16.05757315 0.2280333831
|
||||
16 54 -632.8030856 -632.431277 0.006885343815 14.21127984 14.69810718 0.2026063598
|
||||
17 54 -631.6814096 -630.960068 0.01335817778 14.70924474 15.99073148 0.2283605143
|
||||
18 54 -625.0410285 -623.378198 0.03079315656 23.39224423 24.67640432 0.3504654115
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
10 54 988.0479474 -631.5404329 -631.019667 0.009643812587 15.64136862 16.625876 0.2725503749
|
||||
11 54 988.0479474 -632.1993857 -631.719595 0.008885012437 14.51345042 15.58666626 0.2369926956
|
||||
12 54 988.0479474 -631.7954039 -631.386255 0.007576831115 15.20757603 15.92378883 0.2310810758
|
||||
13 54 988.0479474 -633.0131535 -632.575826 0.00809865759 13.46782392 14.55977162 0.2185066317
|
||||
14 54 988.0479474 -630.6309514 -630.450212 0.003347025529 17.00218411 16.96340726 0.2580441627
|
||||
15 54 988.0479474 -631.9637644 -631.669379 0.00545158078 15.32548025 16.05757315 0.2336752679
|
||||
16 54 988.0479474 -632.6507522 -632.431277 0.004064355464 14.35795151 14.69810718 0.2158812969
|
||||
17 54 988.0479474 -631.5521869 -630.960068 0.0109651643 14.75319251 15.99073148 0.2285673047
|
||||
18 54 988.0479474 -624.854495 -623.378198 0.02733883252 23.58927768 24.67640432 0.3545478911
|
||||
# Displaced_FCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
19 48 -555.9696753 -555.899463 0.001462755232 6.079460735 6.084617063 0.07083484607
|
||||
20 48 -555.9506355 -555.922478 0.0005866147697 6.28112122 6.297071211 0.09285822038
|
||||
21 48 -555.8344979 -555.800269 0.000713101184 6.153574445 6.021098636 0.08137696888
|
||||
22 48 -556.2639568 -556.196151 0.00141262046 5.066504178 5.127955094 0.08649299664
|
||||
23 48 -555.6269121 -555.488929 0.002874647697 6.848109843 7.050223459 0.08116202322
|
||||
24 48 -556.1089332 -556.027926 0.001687649405 5.662035842 5.611881174 0.07953916326
|
||||
25 48 -556.0580873 -555.968399 0.001868505799 5.879931332 5.979217189 0.07470196865
|
||||
26 48 -556.0083267 -556.047132 0.0008084440258 5.752828608 5.544452585 0.08224848502
|
||||
27 48 -555.82441 -555.747848 0.001595040721 6.367423657 6.47892568 0.09497869851
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
19 48 889.0559462 -555.8989975 -555.899463 9.69792269e-06 6.387988875 6.084617063 0.07805905013
|
||||
20 48 889.0559462 -555.8789297 -555.922478 0.000907256654 6.632232564 6.297071211 0.1040918647
|
||||
21 48 889.0559462 -555.7628778 -555.800269 0.0007789836645 6.45057814 6.021098636 0.09471102034
|
||||
22 48 889.0559462 -556.2253041 -556.196151 0.0006073561042 5.301350042 5.127955094 0.09123176401
|
||||
23 48 889.0559462 -555.5406596 -555.488929 0.001077721414 7.195160551 7.050223459 0.08747135986
|
||||
24 48 889.0559462 -556.0330633 -556.027926 0.0001070272218 6.009103539 5.611881174 0.08935441647
|
||||
25 48 889.0559462 -555.9945281 -555.968399 0.0005443553218 6.212902066 5.979217189 0.081244274
|
||||
26 48 889.0559462 -555.9554151 -556.047132 0.001910769529 6.012019145 5.544452585 0.09545132709
|
||||
27 48 889.0559462 -555.7366233 -555.747848 0.0002338482448 6.764939057 6.47892568 0.1011665243
|
||||
# Elastic_BCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
28 2 -23.68353253 -23.689367 0.002917237243 0.0006486347527 0.0006222748589 7.696560647e-06
|
||||
29 2 -23.68281295 -23.689888 0.003537526523 0.0006442481331 0.0006166052222 7.353613433e-06
|
||||
30 2 -23.68293438 -23.689996 0.00353080996 0.0009115876426 0.0008810425642 1.183334558e-05
|
||||
31 2 -23.68108003 -23.690957 0.004938485589 1.044193543e-06 0 4.166082999e-07
|
||||
32 2 -23.67919793 -23.690521 0.005661535829 0.0006261455712 0.0005982273815 7.573309962e-06
|
||||
33 2 -23.67785535 -23.69038 0.006262326378 0.0006219476538 0.0005925723585 8.098703345e-06
|
||||
34 2 -23.68415292 -23.689202 0.00252453823 0.0006520193214 0.0006279363025 7.128171197e-06
|
||||
35 2 -23.68169552 -23.690482 0.004393238412 0.0009021557258 0.0008640138888 1.329061297e-05
|
||||
36 2 -23.68301023 -23.689902 0.003445886213 0.0006432418939 0.0006152154094 8.589463686e-06
|
||||
37 2 -23.68063814 -23.690563 0.004962429905 0.0006318669831 0.0006038725031 7.463726891e-06
|
||||
38 2 -23.68337588 -23.690207 0.003415557958 0.001118071502 0.00107369735 1.811741272e-05
|
||||
39 2 -23.68369233 -23.689285 0.00279633424 0.0009215683923 0.000890013483 1.127366011e-05
|
||||
40 2 -23.68344234 -23.689768 0.003162828655 0.001120158205 0.001080249045 1.630224161e-05
|
||||
41 2 -23.68224173 -23.68968 0.003719136062 0.0009070521506 0.0008680034562 1.339908745e-05
|
||||
42 2 -23.68259685 -23.690074 0.003738573623 0.00143649564 0.001373818765 2.432187597e-05
|
||||
43 2 -23.68469428 -23.688108 0.001706858485 0.0006587619148 0.0006336134468 7.932733888e-06
|
||||
44 2 -23.68405177 -23.689241 0.002594615211 0.0009223784492 0.0008880101351 1.189350098e-05
|
||||
45 2 -23.68384626 -23.68952 0.002836868987 0.0009181252225 0.0008860011287 1.116431522e-05
|
||||
46 2 -23.68524763 -23.686278 0.0005151850613 0.0006668258323 0.0006406777661 8.58562287e-06
|
||||
47 2 -23.67629396 -23.690097 0.006901518594 0.0008737523828 0.0008410160522 1.125104926e-05
|
||||
48 2 -23.67835169 -23.690811 0.006229654604 0.0008814028122 0.0008500070588 1.103963422e-05
|
||||
49 2 -23.67981574 -23.690266 0.005225130991 0.001091936388 0.001044322747 1.944706281e-05
|
||||
50 2 -23.68209703 -23.690597 0.004249983197 0.001105769275 0.001050833003 2.242828165e-05
|
||||
51 2 -23.68050418 -23.690673 0.005084408246 0.000631172526 0.0006038907186 7.85857762e-06
|
||||
52 2 -23.68185505 -23.690551 0.00434797299 0.0009022813915 0.0008590064028 1.486707593e-05
|
||||
53 2 -23.68191508 -23.690693 0.004388958442 0.0009013677777 0.0008590110593 1.516503239e-05
|
||||
54 2 -23.68097184 -23.69021 0.004619081961 0.0009000307855 0.0008730051546 9.670733045e-06
|
||||
55 2 -23.68426495 -23.688943 0.002339025274 0.0009232115961 0.0008800306813 1.619629586e-05
|
||||
56 2 -23.67842316 -23.690136 0.005856419419 0.0006239138245 0.000593996633 8.394193459e-06
|
||||
57 2 -23.6849427 -23.687444 0.001250651312 0.0009347957747 0.000903059245 1.290489522e-05
|
||||
58 2 -23.6836322 -23.689801 0.003084401813 0.0009160470298 0.0008740011442 1.424271291e-05
|
||||
59 2 -23.6814842 -23.690408 0.00446190038 8.690218902e-07 0 3.245696976e-07
|
||||
60 2 -23.68115817 -23.690362 0.004601914896 0.0006345480975 0.0006067503605 9.377221838e-06
|
||||
61 2 -23.67229452 -23.688881 0.008293240443 0.0008566684404 0.0008250054545 1.108928728e-05
|
||||
62 2 -23.6791352 -23.690515 0.005689901939 0.001534883496 0.001475779794 2.124695951e-05
|
||||
63 2 -23.67786743 -23.690551 0.006341785918 0.0006228264143 0.0005996599036 7.295416678e-06
|
||||
64 2 -23.68316372 -23.689487 0.003161641446 0.0006469755816 0.0006194384554 7.530154689e-06
|
||||
65 2 -23.6834063 -23.68986 0.003226849907 0.0009142334935 0.0008860124153 1.052672488e-05
|
||||
66 2 -23.68377813 -23.689288 0.002754934411 0.00145229412 0.001396479144 1.702826801e-05
|
||||
67 2 -23.67700773 -23.690457 0.006724637324 0.0006187196638 0.0005939831647 7.080762895e-06
|
||||
68 2 -23.67552804 -23.689792 0.007131981721 0.0008698720997 0.0008340587509 1.418233126e-05
|
||||
69 2 -23.67583966 -23.690006 0.007083167888 0.0006146073806 0.0005897694465 8.07065747e-06
|
||||
70 2 -23.6777397 -23.690571 0.006415648131 0.0006207500925 0.0005939781141 7.401996527e-06
|
||||
71 2 -23.68270064 -23.690213 0.003756180649 0.001112284016 0.001084315452 1.142137177e-05
|
||||
72 2 -23.67870666 -23.690617 0.005955171449 0.0006250314539 0.0006024682564 6.623275772e-06
|
||||
73 2 -23.68231586 -23.689761 0.00372256923 0.0009095463313 0.0008790688255 1.222939687e-05
|
||||
74 2 -23.67673328 -23.69027 0.006768359835 7.188704983e-07 0 2.129270726e-07
|
||||
75 2 -23.68164707 -23.690599 0.004475963334 0.0006376044826 0.0006137752031 6.574310078e-06
|
||||
76 2 -23.67997815 -23.69061 0.00531592353 9.698202031e-07 0 3.95870452e-07
|
||||
77 2 -23.68008634 -23.690603 0.005258328411 0.0008923489326 0.0008590331775 1.256831367e-05
|
||||
78 2 -23.68488966 -23.687908 0.001509170978 0.0009340324028 0.0009010105438 1.204104822e-05
|
||||
79 2 -23.6795094 -23.690688 0.005589299031 0.0008890828456 0.0008470064935 1.419626566e-05
|
||||
80 2 -23.68316126 -23.689988 0.003413372454 0.0006451612224 0.0006194465272 7.422528505e-06
|
||||
81 2 -23.68321956 -23.689613 0.003196718897 0.000912899593 0.0008740732235 1.539555522e-05
|
||||
82 2 -23.68181374 -23.690678 0.004432127652 0.0006373963006 0.0006123757017 7.454253265e-06
|
||||
83 2 -23.68196226 -23.69017 0.004103870298 0.0009041773842 0.0008750051428 9.854119736e-06
|
||||
84 2 -23.68483517 -23.687892 0.001528413806 0.001142179928 0.001112070142 1.229243027e-05
|
||||
85 2 -23.68271169 -23.690132 0.003710155487 0.0009085291666 0.000868018433 1.49999647e-05
|
||||
86 2 -23.68018066 -23.690843 0.005331170668 0.0006305009468 0.0006081134763 5.90881572e-06
|
||||
87 2 -23.67957976 -23.690598 0.005509118787 0.001259431767 0.001217674833 1.243374729e-05
|
||||
88 2 -23.67869549 -23.690656 0.005980257091 0.0006251939788 0.0006024765556 7.13023928e-06
|
||||
89 2 -23.67884961 -23.690254 0.005702197143 0.001084797449 0.001043496047 1.68662339e-05
|
||||
90 2 -23.67961701 -23.690694 0.005538492834 0.0006273834422 0.0006010740387 8.134278748e-06
|
||||
91 2 -23.68202458 -23.690097 0.004036211359 0.0009041492449 0.0008730234819 1.169617364e-05
|
||||
92 2 -23.68476212 -23.688402 0.001819942156 0.0006575509652 0.000632180354 7.7469499e-06
|
||||
93 2 -23.68425036 -23.688669 0.002209320265 0.001133553123 0.001092474256 1.677033392e-05
|
||||
94 2 -23.68017683 -23.690538 0.005180583191 0.0008923392716 0.0008610145179 1.053989885e-05
|
||||
95 2 -23.68290142 -23.689722 0.003410287964 0.0006465597037 0.0006251287867 7.275875006e-06
|
||||
96 2 -23.6789537 -23.690581 0.005813649829 7.452601432e-07 0 2.355432868e-07
|
||||
97 2 -23.6840847 -23.688755 0.002335150427 0.0006519723076 0.0006251143895 8.25078808e-06
|
||||
98 2 -23.67367881 -23.689312 0.007816596299 0.0008618264365 0.0008290597083 1.323477647e-05
|
||||
99 2 -23.68489152 -23.687388 0.001248238956 0.001145929445 0.001120237475 1.049029355e-05
|
||||
100 2 -23.68174648 -23.690664 0.004458761579 0.0006367386055 0.0006109402589 6.270984336e-06
|
||||
101 2 -23.67450636 -23.68941 0.007451817634 0.0006119997091 0.0005883553348 7.715800125e-06
|
||||
102 2 -23.68321442 -23.690035 0.003410290658 0.0009128748923 0.0008810062429 1.106310227e-05
|
||||
103 2 -23.67584952 -23.690015 0.007082738579 0.0008706222251 0.0008450195264 9.898495893e-06
|
||||
104 2 -23.67856154 -23.690752 0.006095232174 0.0006245583967 0.0005996415596 7.033875201e-06
|
||||
105 2 -23.68297614 -23.689825 0.00342442945 0.0009134966073 0.0008800215906 1.147892484e-05
|
||||
106 2 -23.67876135 -23.690562 0.00590032283 0.0008849512172 0.0008560011682 1.005528708e-05
|
||||
107 2 -23.67874342 -23.690622 0.005939288687 0.0008835043772 0.0008390017878 1.530603189e-05
|
||||
108 2 -23.6843441 -23.688764 0.002209950672 0.0009250850126 0.0008910185183 1.254407066e-05
|
||||
109 2 -23.68340608 -23.690011 0.003302460748 0.0006464901241 0.0006194287691 7.216590251e-06
|
||||
110 2 -23.68476306 -23.687696 0.001466471271 0.001143422035 0.001087589996 2.279977174e-05
|
||||
111 2 -23.67977853 -23.691019 0.005620235289 0.000888876189 0.0008540035129 1.1779733e-05
|
||||
112 2 -23.68440001 -23.689025 0.002312496017 6.723949094e-07 0 2.648676661e-07
|
||||
113 2 -23.68208689 -23.689952 0.003932553163 7.386833996e-07 0 2.88150653e-07
|
||||
114 2 -23.67935439 -23.69061 0.005627806504 0.0008872685213 0.0008580011655 1.019979918e-05
|
||||
115 2 -23.68099138 -23.690595 0.004801812376 0.0008956193373 0.0008680069124 9.843191998e-06
|
||||
116 2 -23.67743565 -23.690231 0.006397673953 0.0006194343635 0.0005925892338 8.542917156e-06
|
||||
117 2 -23.67809541 -23.690469 0.006186797077 0.0008802359765 0.0008500294113 1.182654414e-05
|
||||
118 2 -23.68279142 -23.690482 0.003845288647 0.0009078436148 0.0008740102974 1.225600095e-05
|
||||
119 2 -23.67443144 -23.689613 0.007590778783 0.0008650318724 0.0008320192305 1.23538989e-05
|
||||
120 2 -23.68501591 -23.687426 0.001205043669 0.001145633567 0.00109577735 2.03694619e-05
|
||||
121 2 -23.68302307 -23.689562 0.003269464306 0.0006474095532 0.0006265237426 6.532536015e-06
|
||||
122 2 -23.68134549 -23.6904 0.004527256823 4.272990756e-07 0 1.732352808e-07
|
||||
123 2 -23.67843015 -23.690561 0.006065426647 0.0006235069318 0.0005982273815 6.816496585e-06
|
||||
124 2 -23.67292129 -23.689107 0.00809285397 0.0008589766346 0.0008180073349 1.439377155e-05
|
||||
125 2 -23.68123551 -23.690145 0.004454742608 0.0009009679944 0.0008740766557 1.132072203e-05
|
||||
126 2 -23.67777646 -23.690482 0.006352769316 0.0006215821083 0.0005939983165 8.362048689e-06
|
||||
127 2 -23.68318209 -23.689864 0.003340952886 0.0009142894487 0.0008860124153 1.044271435e-05
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
28 2 36.40799882 -23.68590704 -23.689367 0.001729981765 0.0005857469375 0.0006222748589 9.806537327e-06
|
||||
29 2 36.47727251 -23.68481169 -23.689888 0.00253815708 0.0005821264542 0.0006166052222 8.797319207e-06
|
||||
30 2 36.47184897 -23.68494784 -23.689996 0.002524078869 0.0008240616654 0.0008810425642 2.037428468e-05
|
||||
31 2 36.62078348 -23.68225087 -23.690957 0.004353065844 9.422546395e-07 0 3.770200667e-07
|
||||
32 2 36.71197042 -23.67989944 -23.690521 0.005310779451 0.000566950477 0.0005982273815 8.158760804e-06
|
||||
33 2 36.77593928 -23.67819051 -23.69038 0.00609474427 0.0005635032259 0.0005925723585 7.849374173e-06
|
||||
34 2 36.36547558 -23.68676383 -23.689202 0.001219083545 0.0005885128327 0.0006279363025 1.053580541e-05
|
||||
35 2 36.55974375 -23.68319963 -23.690482 0.003641183354 0.000815464884 0.0008640138888 1.662920456e-05
|
||||
36 2 36.46414346 -23.68507116 -23.689902 0.002415420054 0.0005812774047 0.0006152154094 9.669302107e-06
|
||||
37 2 36.63368821 -23.6817672 -23.690563 0.004397900334 0.0005717456253 0.0006038725031 8.311567538e-06
|
||||
38 2 36.45345189 -23.68547117 -23.690207 0.002367914312 0.001009744333 0.00107369735 2.610693709e-05
|
||||
39 2 36.38484847 -23.68616091 -23.689285 0.001562044483 0.0008322058899 0.000890013483 1.991679691e-05
|
||||
40 2 36.43347895 -23.68567207 -23.689768 0.002047966899 0.001012061035 0.001080249045 2.782864008e-05
|
||||
41 2 36.50220719 -23.68411383 -23.68968 0.002783085738 0.0008199315614 0.0008680034562 1.637343483e-05
|
||||
42 2 36.50719109 -23.68445604 -23.690074 0.002808981302 0.001296718439 0.001373818765 2.64147971e-05
|
||||
43 2 36.28428565 -23.68777598 -23.688108 0.0001660085343 0.000594221946 0.0006336134468 1.099939509e-05
|
||||
44 2 36.3642236 -23.68663754 -23.689241 0.001301727662 0.0008329159633 0.0008880101351 1.874593476e-05
|
||||
45 2 36.40397469 -23.68626116 -23.68952 0.001629419996 0.0008297070704 0.0008860011287 1.917842744e-05
|
||||
46 2 36.15958616 -23.68901859 -23.686278 0.001370293226 0.0006010646632 0.0006406777661 1.138305654e-05
|
||||
47 2 36.85012426 -23.6762264 -23.690097 0.006935298115 0.0007925625457 0.0008410160522 1.643998947e-05
|
||||
48 2 36.76983294 -23.67871264 -23.690811 0.006049181932 0.0007984019479 0.0008500070588 1.765059262e-05
|
||||
49 2 36.6630398 -23.68078335 -23.690266 0.004741323226 0.0009871892379 0.001044322747 2.331514572e-05
|
||||
50 2 36.55357619 -23.68366573 -23.690597 0.003465633435 0.0009975988347 0.001050833003 2.173210926e-05
|
||||
51 2 36.65271066 -23.68154759 -23.690673 0.004562704504 0.0005710871669 0.0006038907186 8.900574077e-06
|
||||
52 2 36.56222224 -23.68337216 -23.690551 0.003589418943 0.0008144210952 0.0008590064028 1.523928952e-05
|
||||
53 2 36.56679849 -23.68340668 -23.690693 0.003643158311 0.0008137974304 0.0008590110593 1.595698248e-05
|
||||
54 2 36.59811665 -23.6823077 -23.69021 0.003951151804 0.0008145831598 0.0008730051546 2.003359235e-05
|
||||
55 2 36.34900278 -23.68697807 -23.688943 0.0009824644101 0.0008322110648 0.0008800306813 1.744870469e-05
|
||||
56 2 36.74034826 -23.67898787 -23.690136 0.005574066484 0.0005652132989 0.000593996633 7.92587851e-06
|
||||
57 2 36.23610366 -23.68828866 -23.687444 0.0004223293819 0.0008436278789 0.000903059245 2.177751265e-05
|
||||
58 2 36.42259639 -23.68591698 -23.689801 0.001942008249 0.0008265155784 0.0008740011442 1.602155127e-05
|
||||
59 2 36.58194 -23.68291534 -23.690408 0.003746329075 7.853116414e-07 0 2.932806621e-07
|
||||
60 2 36.59950783 -23.68250113 -23.690362 0.003930433448 0.0005739954417 0.0006067503605 1.009250412e-05
|
||||
61 2 37.02589653 -23.67131384 -23.688881 0.008783582181 0.0007776878254 0.0008250054545 1.619373008e-05
|
||||
62 2 36.71189602 -23.67982686 -23.690515 0.005344069182 0.001390387166 0.001475779794 3.436613175e-05
|
||||
63 2 36.78962367 -23.67814275 -23.690551 0.006204123773 0.0005637977551 0.0005996599036 1.001095778e-05
|
||||
64 2 36.42642467 -23.68541088 -23.689487 0.002038057601 0.0005844344049 0.0006194384554 9.105178613e-06
|
||||
65 2 36.4423543 -23.68559418 -23.68986 0.002132908295 0.0008266682194 0.0008860124153 2.074533254e-05
|
||||
66 2 36.39164409 -23.68624726 -23.689288 0.001520371922 0.001312283722 0.001396479144 2.724122629e-05
|
||||
67 2 36.83059874 -23.67704953 -23.690457 0.006703736699 0.0005605067938 0.0005939831647 8.903855256e-06
|
||||
68 2 36.8936692 -23.67527599 -23.689792 0.007258002565 0.000787658236 0.0008340587509 1.727027889e-05
|
||||
69 2 36.88495742 -23.67562381 -23.690006 0.007191094218 0.0005570824127 0.0005897694465 9.526352044e-06
|
||||
70 2 36.7928657 -23.67798232 -23.690571 0.00629434147 0.0005623157716 0.0005939781141 8.388724073e-06
|
||||
71 2 36.50844234 -23.6845524 -23.690213 0.002830300186 0.001007417856 0.001084315452 3.13901245e-05
|
||||
72 2 36.74419477 -23.67922697 -23.690617 0.005695015742 0.0005656413796 0.0006024682564 9.800558604e-06
|
||||
73 2 36.49448266 -23.68420852 -23.689761 0.002776239615 0.0008225588858 0.0008790688255 2.057348461e-05
|
||||
74 2 36.83933705 -23.67673911 -23.69027 0.006765442668 6.51984476e-07 0 1.932645324e-07
|
||||
75 2 36.5709148 -23.68309624 -23.690599 0.003751378046 0.0005763054751 0.0006137752031 9.640531893e-06
|
||||
76 2 36.67683082 -23.68088394 -23.69061 0.004863030461 8.763722169e-07 0 3.577227741e-07
|
||||
77 2 36.66115635 -23.68104805 -23.690603 0.004777472809 0.0008071491031 0.0008590331775 1.853779451e-05
|
||||
78 2 36.25583797 -23.68810086 -23.687908 9.643173451e-05 0.0008433322094 0.0009010105438 2.010525612e-05
|
||||
79 2 36.69315685 -23.68027964 -23.690688 0.005204178753 0.0008040458508 0.0008470064935 1.442630316e-05
|
||||
80 2 36.46769977 -23.68522986 -23.689988 0.002379071717 0.0005827976437 0.0006194465272 9.763878015e-06
|
||||
81 2 36.44434113 -23.68541392 -23.689613 0.00209953858 0.0008243238033 0.0008740732235 1.862099135e-05
|
||||
82 2 36.57453003 -23.68327227 -23.690678 0.003702863528 0.0005762034709 0.0006123757017 9.833686501e-06
|
||||
83 2 36.54218785 -23.68361157 -23.69017 0.003279215566 0.0008176791029 0.0008750051428 1.921467316e-05
|
||||
84 2 36.26350252 -23.68802292 -23.687892 6.545993121e-05 0.001032253376 0.001112070142 3.258468659e-05
|
||||
85 2 36.49725495 -23.68460293 -23.690132 0.002764534398 0.0008196684225 0.000868018433 1.73736591e-05
|
||||
86 2 36.66468316 -23.68110857 -23.690843 0.004867214139 0.0005702307406 0.0006081134763 9.414220345e-06
|
||||
87 2 36.69098146 -23.68038294 -23.690598 0.005107529327 0.001139059342 0.001217674833 2.06566425e-05
|
||||
88 2 36.7498524 -23.67919254 -23.690656 0.005731731866 0.0005658199144 0.0006024765556 1.012824587e-05
|
||||
89 2 36.72620595 -23.67950048 -23.690254 0.005376762214 0.0009822281627 0.001043496047 2.500732518e-05
|
||||
90 2 36.7046344 -23.68037755 -23.690694 0.00515822503 0.0005678245812 0.0006010740387 9.481625137e-06
|
||||
91 2 36.53215524 -23.6837194 -23.690097 0.00318880242 0.0008183268201 0.0008730234819 1.936710758e-05
|
||||
92 2 36.28988463 -23.68778953 -23.688402 0.000306233365 0.0005932101303 0.000632180354 1.068318322e-05
|
||||
93 2 36.330155 -23.68704981 -23.688669 0.0008095957127 0.001023514967 0.001092474256 2.815195409e-05
|
||||
94 2 36.65451876 -23.68118381 -23.690538 0.004677093696 0.0008073441427 0.0008610145179 1.797964322e-05
|
||||
95 2 36.46623662 -23.68497164 -23.689722 0.002375180903 0.0005838510966 0.0006251287867 1.162407198e-05
|
||||
96 2 36.73431174 -23.67954699 -23.690581 0.005517005254 6.747207861e-07 0 2.132659501e-07
|
||||
97 2 36.34544239 -23.68680631 -23.688755 0.0009743455055 0.0005885973278 0.0006251143895 1.022234556e-05
|
||||
98 2 36.9736935 -23.67299367 -23.689312 0.008159162687 0.0007819742447 0.0008290597083 1.76069415e-05
|
||||
99 2 36.24487417 -23.68822174 -23.687388 0.0004168686754 0.001036416473 0.001120237475 3.421810783e-05
|
||||
100 2 36.57555586 -23.68319244 -23.690664 0.003735779019 0.0005756998982 0.0006109402589 8.460885317e-06
|
||||
101 2 36.94151938 -23.67402837 -23.68941 0.00769081595 0.0005547944898 0.0005883553348 9.667605875e-06
|
||||
102 2 36.45547212 -23.68530561 -23.690035 0.002364692981 0.0008249402484 0.0008810062429 1.906781709e-05
|
||||
103 2 36.88496132 -23.67563424 -23.690015 0.007190382353 0.000790172518 0.0008450195264 1.940915801e-05
|
||||
104 2 36.76103389 -23.67899294 -23.690752 0.005879529841 0.0005653529749 0.0005996415596 9.061380987e-06
|
||||
105 2 36.45404349 -23.68506744 -23.689825 0.002378779626 0.0008251854421 0.0008800215906 1.852267093e-05
|
||||
106 2 36.74654739 -23.67929575 -23.690562 0.005633127253 0.000801763107 0.0008560011682 1.842443236e-05
|
||||
107 2 36.74084732 -23.67927675 -23.690622 0.005672626415 0.0007986783077 0.0008390017878 1.383930455e-05
|
||||
108 2 36.33025646 -23.68714468 -23.688764 0.0008096596348 0.0008354959994 0.0008910185183 1.950545073e-05
|
||||
109 2 36.44122368 -23.68556667 -23.690011 0.002222166915 0.0005839138329 0.0006194287691 9.095263256e-06
|
||||
110 2 36.25348342 -23.68799518 -23.687696 0.0001495917205 0.001029561919 0.001087589996 2.368346819e-05
|
||||
111 2 36.69693588 -23.68052902 -23.691019 0.005244990763 0.0008045111684 0.0008540035129 1.660792245e-05
|
||||
112 2 36.3425194 -23.68713615 -23.689025 0.0009444242204 6.048393422e-07 0 2.391864739e-07
|
||||
113 2 36.51656499 -23.68385666 -23.689952 0.003047669619 6.637963301e-07 0 2.603475835e-07
|
||||
114 2 36.71447816 -23.68006157 -23.69061 0.005274216197 0.0008035446124 0.0008580011655 1.851139775e-05
|
||||
115 2 36.62519495 -23.68220128 -23.690595 0.004196860391 0.0008113491541 0.0008680069124 1.944419979e-05
|
||||
116 2 36.80154127 -23.67766382 -23.690231 0.006283590712 0.0005612910408 0.0005925892338 9.235122707e-06
|
||||
117 2 36.77742539 -23.67845523 -23.690469 0.006006884644 0.0007980880228 0.0008500294113 1.88002833e-05
|
||||
118 2 36.50183296 -23.68462479 -23.690482 0.002928604258 0.0008206653147 0.0008740102974 1.862862483e-05
|
||||
119 2 36.93568763 -23.67391526 -23.689613 0.007848867984 0.0007836859568 0.0008320192305 1.723468539e-05
|
||||
120 2 36.23289183 -23.68838681 -23.687426 0.0004804048231 0.001032041797 0.00109577735 2.600453853e-05
|
||||
121 2 36.44295904 -23.68519521 -23.689562 0.002183395162 0.0005844757167 0.0006265237426 1.128889659e-05
|
||||
122 2 36.59751671 -23.68271637 -23.6904 0.003841815485 3.610825174e-07 0 1.4665868e-07
|
||||
123 2 36.76766724 -23.67885647 -23.690561 0.005852264977 0.0005645533896 0.0005982273815 8.625051998e-06
|
||||
124 2 37.00025894 -23.67207453 -23.689107 0.008516233835 0.0007781106616 0.0008180073349 1.390580399e-05
|
||||
125 2 36.58722353 -23.68265657 -23.690145 0.00374421628 0.0008159137665 0.0008740766557 2.136045675e-05
|
||||
126 2 36.79405605 -23.67803714 -23.690482 0.006222430293 0.0005630702013 0.0005939983165 8.85354297e-06
|
||||
127 2 36.45320348 -23.68530353 -23.689864 0.002280236365 0.0008267100988 0.0008860124153 2.061923922e-05
|
||||
# Elastic_FCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
128 4 -46.449456 -46.437936 0.002880000611 0.0007088173441 0.001265949446 0.0001573706237
|
||||
129 4 -46.45317307 -46.438504 0.003667267825 0.0007210982328 0.001492549497 0.0002032393675
|
||||
130 4 -46.44686167 -46.436378 0.002620918523 0.0004870837365 0.000810592376 0.0001107544174
|
||||
131 4 -46.45357979 -46.441551 0.003007196305 0.0008634182131 0.001283675193 0.0001231453909
|
||||
132 4 -46.42409677 -46.416957 0.001784942313 0.0007481922079 0.001186145859 0.0001205918882
|
||||
133 4 -46.45078882 -46.440495 0.002573455911 0.0007289008721 0.001212440514 0.0001119490174
|
||||
134 4 -46.4501363 -46.437972 0.003041076136 0.001116532125 0.002358226452 0.0003166808771
|
||||
135 4 -46.46241981 -46.44586 0.004139951294 0.001077737689 0.002033949852 0.0002702964015
|
||||
136 4 -46.44743429 -46.435744 0.002922571394 0.0008383971706 0.001690849491 0.0002711013554
|
||||
137 4 -46.45237555 -46.438209 0.003541637787 0.0007039962535 0.001160049999 0.0001096430557
|
||||
138 4 -46.43645451 -46.42629 0.002541127472 0.0004839683449 0.0005297018029 1.480491546e-05
|
||||
139 4 -46.45466199 -46.443301 0.002840247268 0.0008590849412 0.001818421568 0.0002395191538
|
||||
140 4 -46.4513559 -46.439002 0.003088474484 0.000980675092 0.001416973535 0.0001142710898
|
||||
141 4 -46.44224357 -46.432438 0.00245139227 0.0008958100898 0.001010469198 5.862303988e-05
|
||||
142 4 -46.41846428 -46.412654 0.001452568802 0.001104791425 0.001801959766 0.0001900084105
|
||||
143 4 -46.45594552 -46.443231 0.003178629143 0.0006959928784 0.001691590967 0.0002104366356
|
||||
144 4 -46.44141177 -46.431513 0.00247469212 0.001149659372 0.001680544852 0.0001329997121
|
||||
145 4 -46.44458344 -46.435608 0.00224385943 0.000711021509 0.0009593039143 5.831382606e-05
|
||||
146 4 -46.45129649 -46.437689 0.003401871689 0.0007271142738 0.001217708504 0.0001414871092
|
||||
147 4 -46.43755262 -46.428447 0.002276404472 0.0008708378565 0.002060081552 0.0003082033743
|
||||
148 4 -46.44295113 -46.432255 0.00267403188 0.0005315813764 0.0006274201144 5.596270268e-05
|
||||
149 4 -46.45482154 -46.442315 0.003126635324 0.0008653689406 0.002424436842 0.0004107290683
|
||||
150 4 -46.44918467 -46.436613 0.003142918309 0.0004839663128 0.0005321240457 3.890880543e-05
|
||||
151 4 -46.44094809 -46.430825 0.002530772174 0.0007559646277 0.001399987143 0.0001669802678
|
||||
152 4 -46.44335614 -46.43312 0.002559035587 0.0004859700309 0.0007272771136 6.315695513e-05
|
||||
153 4 -46.44518607 -46.434347 0.002709767129 0.0007148497795 0.001284451634 0.0001580665901
|
||||
154 4 -46.43969219 -46.430573 0.002279798333 0.00072875179 0.001315746176 0.000142372977
|
||||
155 4 -46.46201856 -46.445665 0.004088390852 0.0008369246217 0.00180789159 0.0002715757049
|
||||
156 4 -46.44738266 -46.435898 0.002871166201 0.0007118215897 0.001869300939 0.0002650888178
|
||||
157 4 -46.45279209 -46.442107 0.002671271631 0.0005099355574 0.0006020930161 3.155335447e-05
|
||||
158 4 -46.44687446 -46.434432 0.003110615714 0.0008364031703 0.001092982159 9.484366005e-05
|
||||
159 4 -46.45033825 -46.436308 0.003507562522 0.0009954281391 0.001839150891 0.0002479613631
|
||||
160 4 -46.43248168 -46.423938 0.002135919949 0.0007772193879 0.001463463016 0.0001986681069
|
||||
161 4 -46.43702199 -46.428115 0.002226747981 0.0005418219957 0.0008584497656 9.283863381e-05
|
||||
162 4 -46.43553597 -46.4269 0.002158992752 0.001008467413 0.001845719914 0.00024455962
|
||||
163 4 -46.43191737 -46.421142 0.00269384137 0.0009169914298 0.001309150106 9.335100097e-05
|
||||
164 4 -46.44107961 -46.432233 0.002211651338 0.0006944670911 0.0007253109678 2.446203898e-05
|
||||
165 4 -46.44097784 -46.429408 0.002892459649 0.0007189999753 0.001068327665 9.331287519e-05
|
||||
166 4 -46.45970672 -46.445145 0.003640430606 0.0008323398895 0.001776038288 0.000241778013
|
||||
167 4 -46.44583143 -46.435868 0.002490857628 0.001007239475 0.002376074704 0.0003893124404
|
||||
168 4 -46.4515773 -46.439663 0.002978574612 0.0004764710524 0.001119403413 0.0001156692402
|
||||
169 4 -46.43612447 -46.428287 0.00195936642 0.001036891264 0.001277000392 6.942055774e-05
|
||||
170 4 -46.4323966 -46.424584 0.001953149801 0.0005497544117 0.0008032957114 5.852281957e-05
|
||||
171 4 -46.41884421 -46.413045 0.001449803236 0.0009011718881 0.001248322074 7.333380516e-05
|
||||
172 4 -46.44596985 -46.436994 0.002243961387 0.0008480487041 0.001331939188 0.0001689650386
|
||||
173 4 -46.45736434 -46.443604 0.003440085706 0.0007046835731 0.001177046303 0.000122309487
|
||||
174 4 -46.4531541 -46.439718 0.003359024693 6.718665563e-07 0 1.784212677e-07
|
||||
175 4 -46.44922127 -46.435527 0.003423566396 0.0008698447035 0.0009338393866 5.635428662e-05
|
||||
176 4 -46.44518705 -46.434787 0.002600012526 0.0008890985417 0.00117329195 6.906839261e-05
|
||||
177 4 -46.44789017 -46.434929 0.00324029173 0.001006522874 0.001349491756 8.807224523e-05
|
||||
178 4 -46.43673847 -46.426499 0.002559868692 0.0009134543992 0.001248937949 9.133606536e-05
|
||||
179 4 -46.44932495 -46.437025 0.003074986544 0.0006805240432 0.000938418883 7.446008431e-05
|
||||
180 4 -46.43885209 -46.428937 0.002478772296 0.0009031344997 0.001286352984 0.0001081690229
|
||||
181 4 -46.45413306 -46.442516 0.002904263993 0.000506604563 0.00094855469 0.0001414866709
|
||||
182 4 -46.44060244 -46.428736 0.002966609134 0.0007579010233 0.001424321593 0.0001681832084
|
||||
183 4 -46.44430426 -46.433359 0.002736316202 0.0008950557387 0.001276381604 0.0001027241271
|
||||
184 4 -46.45260002 -46.438799 0.00345025532 0.0006868717473 0.0008186940821 3.675916237e-05
|
||||
185 4 -46.45478935 -46.441993 0.003199088629 0.000703010985 0.001887735151 0.0002666518851
|
||||
186 4 -46.44949137 -46.439033 0.002614591408 0.0006795560995 0.000821568013 5.214373405e-05
|
||||
187 4 -46.44856954 -46.436967 0.002900635979 0.000860448627 0.001482323514 0.0001802503616
|
||||
188 4 -46.43759968 -46.427245 0.00258867094 0.0008795521813 0.001293885621 0.0001012099865
|
||||
189 4 -46.45133388 -46.438046 0.003321969731 0.0009940752633 0.001627288542 0.000174152867
|
||||
190 4 -46.42813695 -46.420083 0.002013486722 0.001161998446 0.002395244873 0.0003650969018
|
||||
191 4 -46.46060362 -46.445247 0.003839154837 0.0006909751141 0.001219330964 0.0001271217748
|
||||
192 4 -46.45903895 -46.446044 0.003248736964 0.0006847065621 0.001305329077 0.0001398957152
|
||||
193 4 -46.44724817 -46.434472 0.003194042613 0.0007061519125 0.0008323340675 6.681050285e-05
|
||||
194 4 -46.45649776 -46.44458 0.002979439009 0.0004998748498 0.0009744208536 8.547729233e-05
|
||||
195 4 -46.45403889 -46.441776 0.003065721535 0.0008652918641 0.001339231869 0.0001389938291
|
||||
196 4 -46.44933689 -46.436389 0.003236972034 0.001007551549 0.001786741168 0.0002029508895
|
||||
197 4 -46.459873 -46.446416 0.00336425035 0.0004914989987 0.0006588778339 6.549510811e-05
|
||||
198 4 -46.46569473 -46.449806 0.003972183676 0.000943305002 0.002135055034 0.0003137851731
|
||||
199 4 -46.43467991 -46.427189 0.00187272638 0.0007726175275 0.001050788276 7.135568315e-05
|
||||
200 4 -46.43621938 -46.427857 0.002090594118 0.0007686546978 0.001487666629 0.0001823668299
|
||||
201 4 -46.45576365 -46.44004 0.003930912967 0.0005030079851 0.000757202747 5.770676907e-05
|
||||
202 4 -46.4483913 -46.437214 0.002794325435 0.0007102028538 0.001505586265 0.000179529909
|
||||
203 4 -46.43168209 -46.422628 0.002263521917 0.0007374332623 0.001601713458 0.0002609325883
|
||||
204 4 -46.45732644 -46.443535 0.00344786022 0.0009811025521 0.001590304373 0.0001690672254
|
||||
205 4 -46.45144079 -46.439922 0.002879696366 0.0008698700101 0.001530493385 0.0001528171002
|
||||
206 4 -46.44960522 -46.437675 0.002982555611 0.00112440729 0.002440246094 0.0004061057502
|
||||
207 4 -46.45839808 -46.445558 0.003210018941 0.0006780842253 0.00113392416 0.0001196075532
|
||||
208 4 -46.45130112 -46.439106 0.003048781046 0.0009934671927 0.001830731002 0.000245168776
|
||||
209 4 -46.45826105 -46.443073 0.003797013279 0.0004759445984 0.0005766870902 2.863834812e-05
|
||||
210 4 -46.4536082 -46.4397 0.003477049491 0.0006982622456 0.001204174406 0.0001154782847
|
||||
211 4 -46.44819434 -46.436374 0.002955085327 0.0007363684621 0.001461656594 0.0002277550157
|
||||
212 4 -46.43668282 -46.426557 0.00253145389 0.0007326220467 0.001359624213 0.0001251472548
|
||||
213 4 -46.44485583 -46.434009 0.002711707903 0.000870647096 0.001391131194 0.0001541542453
|
||||
214 4 -46.44732696 -46.436262 0.002766239028 0.001116549362 0.002503347159 0.0003211377445
|
||||
215 4 -46.44414241 -46.434505 0.002409352177 0.0008685662223 0.001041637173 4.942106462e-05
|
||||
216 4 -46.45095913 -46.438768 0.003047783488 0.0008482298138 0.001098285027 8.657909629e-05
|
||||
217 4 -46.45111242 -46.440254 0.002714605501 0.0004892442432 0.0006069892915 5.824568303e-05
|
||||
218 4 -46.43463407 -46.42286 0.002943517186 0.0004976409931 0.0007365242698 7.564906264e-05
|
||||
219 4 -46.42611144 -46.418078 0.002008360417 0.001053243552 0.002028412187 0.0002473380313
|
||||
220 4 -46.45344976 -46.440513 0.003234189608 0.0007024129954 0.001158189967 0.0001371889048
|
||||
221 4 -46.41584187 -46.409824 0.001504467167 0.0007558580012 0.001759573812 0.0002386003087
|
||||
222 4 -46.45494987 -46.440329 0.003655216631 0.0005034620022 0.0009534044263 0.0001064495091
|
||||
223 4 -46.45000759 -46.43773 0.003069396495 0.0006831478015 0.000926180328 7.390298375e-05
|
||||
224 4 -46.42538863 -46.416525 0.002215907169 0.0005605993692 0.0007573664899 5.946405938e-05
|
||||
225 4 -46.45386072 -46.440293 0.003391930454 0.0006980795454 0.0007725386722 1.86450807e-05
|
||||
226 4 -46.4527969 -46.43839 0.003601726069 0.0005103417187 0.0005612022808 1.656002337e-05
|
||||
227 4 -46.45374294 -46.438916 0.00370673382 0.0006956794369 0.001650878554 0.0002154167998
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
128 4 74.14589882 -46.45131085 -46.437936 0.003343711499 0.0008256456522 0.001265949446 0.0001479290162
|
||||
129 4 74.26852111 -46.45483689 -46.438504 0.00408322283 0.0008748833702 0.001492549497 0.0001669960806
|
||||
130 4 74.05957274 -46.44875622 -46.436378 0.00309455485 0.0005424811735 0.000810592376 0.0001015808542
|
||||
131 4 74.30647158 -46.45520791 -46.441551 0.003414228451 0.001024641 0.001283675193 8.610021967e-05
|
||||
132 4 73.40902276 -46.4265266 -46.416957 0.002392400067 0.0008639837782 0.001186145859 9.385948781e-05
|
||||
133 4 74.1804881 -46.45258342 -46.440495 0.003022104862 0.0008837693055 0.001212440514 7.54705377e-05
|
||||
134 4 74.17596744 -46.45191353 -46.437972 0.00348538317 0.001290912634 0.002358226452 0.0002715207448
|
||||
135 4 74.73528136 -46.46363987 -46.44586 0.004444967559 0.001259032014 0.002033949852 0.0002223899959
|
||||
136 4 74.0787509 -46.44925412 -46.435744 0.003377531217 0.0009337469328 0.001690849491 0.0002527015084
|
||||
137 4 74.24609528 -46.45412062 -46.438209 0.003977905441 0.0008183472184 0.001160049999 8.303212282e-05
|
||||
138 4 73.73005434 -46.43863377 -46.42629 0.003085943173 0.0005398665308 0.0005297018029 9.433755819e-06
|
||||
139 4 74.33993289 -46.45634184 -46.443301 0.003260209859 0.001019667847 0.001818421568 0.0002031714008
|
||||
140 4 74.20715045 -46.45310823 -46.439002 0.003526557791 0.001120917878 0.001416973535 8.385490094e-05
|
||||
141 4 73.89686848 -46.44426829 -46.432438 0.002957572572 0.001055104669 0.001010469198 5.761635655e-05
|
||||
142 4 73.27773838 -46.42097352 -46.412654 0.002079881174 0.001288759108 0.001801959766 0.0001651013922
|
||||
143 4 74.40027968 -46.45756841 -46.443231 0.003584351835 0.0008139750432 0.001691590967 0.0002012572515
|
||||
144 4 73.86123747 -46.44349423 -46.431513 0.002995306686 0.00134586635 0.001680544852 8.973225319e-05
|
||||
145 4 73.96908649 -46.4465827 -46.435608 0.002743674619 0.0008335711035 0.0009593039143 3.003885348e-05
|
||||
146 4 74.18717232 -46.45311791 -46.437689 0.003857228017 0.0008866862425 0.001217708504 0.0001038986229
|
||||
147 4 73.76897316 -46.43964365 -46.428447 0.002799161691 0.0009977338004 0.002060081552 0.0002905770514
|
||||
148 4 73.9161373 -46.44497446 -46.432255 0.003179865353 0.0006398887096 0.0006274201144 6.119155431e-05
|
||||
149 4 74.36502962 -46.45637695 -46.442315 0.003515486518 0.001024758209 0.002424436842 0.0003681838217
|
||||
150 4 74.11860796 -46.45104156 -46.436613 0.003607139707 0.000542307804 0.0005321240457 4.066198978e-05
|
||||
151 4 73.86741001 -46.44297515 -46.430825 0.003037538607 0.0009095490857 0.001399987143 0.000130785128
|
||||
152 4 73.94132612 -46.44533403 -46.43312 0.003053507676 0.0005400988424 0.0007272771136 5.413031343e-05
|
||||
153 4 73.9811119 -46.44719039 -46.434347 0.003210848405 0.0008341122771 0.001284451634 0.0001304096221
|
||||
154 4 73.82698041 -46.441812 -46.430573 0.002809749316 0.0008428066075 0.001315746176 0.0001159814943
|
||||
155 4 74.70690467 -46.4633092 -46.445665 0.004411050207 0.001032736499 0.00180789159 0.0002150498129
|
||||
156 4 74.08446722 -46.44922009 -46.435898 0.003330522688 0.0008301151804 0.001869300939 0.0002469789922
|
||||
157 4 74.25274774 -46.45452028 -46.442107 0.003103319043 0.0006221716513 0.0006020930161 2.151286804e-05
|
||||
158 4 74.05043726 -46.44881316 -46.434432 0.003595289303 0.0009353943426 0.001092982159 7.589096221e-05
|
||||
159 4 74.16653794 -46.45216046 -46.436308 0.003963116012 0.001165997488 0.001839150891 0.0002017849653
|
||||
160 4 73.62293094 -46.43471139 -46.423938 0.002693346975 0.0009282950076 0.001463463016 0.0001806433153
|
||||
161 4 73.74948122 -46.43915587 -46.428115 0.002760218433 0.000645515606 0.0008584497656 7.555218569e-05
|
||||
162 4 73.70731572 -46.4377108 -46.4269 0.002702698795 0.001146432571 0.001845719914 0.0002177014657
|
||||
163 4 73.59054722 -46.43424497 -46.421142 0.003275743402 0.001070285015 0.001309150106 6.310130391e-05
|
||||
164 4 73.85798892 -46.44313986 -46.432233 0.002726715023 0.000770442732 0.0007253109678 2.477634456e-05
|
||||
165 4 73.86179419 -46.44300648 -46.429408 0.003399620631 0.000833457346 0.001068327665 6.682329804e-05
|
||||
166 4 74.58468636 -46.46113881 -46.445145 0.003998452755 0.0009654561253 0.001776038288 0.0002133574173
|
||||
167 4 74.02247797 -46.44776713 -46.435868 0.002974783408 0.001172308278 0.002376074704 0.0003537233362
|
||||
168 4 74.20501804 -46.45335725 -46.439663 0.003423562793 0.0005357335948 0.001119403413 0.0001057861048
|
||||
169 4 73.72492498 -46.43827692 -46.428287 0.00249748019 0.001199172287 0.001277000392 3.442241395e-05
|
||||
170 4 73.62492908 -46.43462391 -46.424584 0.002509976491 0.0006543042024 0.0008032957114 4.113076772e-05
|
||||
171 4 73.28647 -46.42133993 -46.413045 0.002073732867 0.001025290654 0.001248322074 5.004201967e-05
|
||||
172 4 74.01119894 -46.44792434 -46.436994 0.002732584481 0.0009408903639 0.001331939188 0.0001513955587
|
||||
173 4 74.45838911 -46.45890245 -46.443604 0.003824612242 0.0008652237342 0.001177046303 0.0001036876632
|
||||
174 4 74.29439096 -46.45481655 -46.439718 0.003774637959 7.937739607e-07 0 2.16900779e-07
|
||||
175 4 74.12581885 -46.45104078 -46.435527 0.003878446058 0.001033999404 0.0009338393866 5.850821011e-05
|
||||
176 4 73.97170625 -46.44716581 -46.434787 0.003094701764 0.001051431266 0.00117329195 5.01747675e-05
|
||||
177 4 74.0799757 -46.44974298 -46.434929 0.003703495842 0.001176626647 0.001349491756 5.454636617e-05
|
||||
178 4 73.74433679 -46.4388625 -46.426499 0.003090875895 0.001072266841 0.001248937949 5.553437534e-05
|
||||
179 4 74.14770713 -46.45110145 -46.437025 0.003519111637 0.0007601929639 0.000938418883 6.871857646e-05
|
||||
180 4 73.80957625 -46.44091488 -46.428937 0.002994470545 0.001060607401 0.001286352984 7.2762261e-05
|
||||
181 4 74.32407369 -46.45577946 -46.442516 0.003315864517 0.0006130126198 0.00094855469 0.0001237589752
|
||||
182 4 73.84764949 -46.44267435 -46.428736 0.003484586658 0.0009114051058 0.001424321593 0.0001319991106
|
||||
183 4 73.97111028 -46.44621408 -46.433359 0.003213769843 0.001054983475 0.001276381604 6.67936474e-05
|
||||
184 4 74.25298337 -46.45429983 -46.438799 0.003875207653 0.0007658804804 0.0008186940821 3.523360132e-05
|
||||
185 4 74.36513571 -46.45635746 -46.441993 0.003591113969 0.0008209061886 0.001887735151 0.0002392272687
|
||||
186 4 74.14572274 -46.45131062 -46.439033 0.003069403991 0.0007583547125 0.000821568013 4.304382184e-05
|
||||
187 4 74.11964094 -46.45043541 -46.436967 0.003367101873 0.0009904274689 0.001482323514 0.0001528507492
|
||||
188 4 73.76706483 -46.43970043 -46.427245 0.003113856835 0.001008693047 0.001293885621 8.257978381e-05
|
||||
189 4 74.21830016 -46.45309069 -46.438046 0.003761172827 0.00116354854 0.001627288542 0.0001286952583
|
||||
190 4 73.51075683 -46.43047578 -46.420083 0.00259819585 0.001334826131 0.002395244873 0.0003392003683
|
||||
191 4 74.62704502 -46.46197961 -46.445247 0.004183151461 0.0008490345633 0.001219330964 8.984638543e-05
|
||||
192 4 74.54172989 -46.46048301 -46.446044 0.003609751612 0.0008018136666 0.001305329077 0.0001126246298
|
||||
193 4 74.05152275 -46.4491333 -46.434472 0.003665324806 0.0008288481706 0.0008323340675 5.797426995e-05
|
||||
194 4 74.415732 -46.45806324 -46.44458 0.003370810956 0.0006130004847 0.0009744208536 6.665443495e-05
|
||||
195 4 74.3298536 -46.45570744 -46.441776 0.003482860273 0.001025864906 0.001339231869 0.0001026437813
|
||||
196 4 74.14951222 -46.45110489 -46.436389 0.003678973505 0.00117751644 0.001786741168 0.0001566147507
|
||||
197 4 74.58621137 -46.46129862 -46.446416 0.003720653765 0.0006013410942 0.0006588778339 4.718503395e-05
|
||||
198 4 74.93791818 -46.4668018 -46.449806 0.00424894914 0.001116402603 0.002135055034 0.0002754987197
|
||||
199 4 73.6789527 -46.43686767 -46.427189 0.002419668309 0.0009202462101 0.001050788276 3.832148023e-05
|
||||
200 4 73.72666848 -46.43838466 -46.427857 0.002631914057 0.000916598926 0.001487666629 0.0001502215435
|
||||
201 4 74.38554824 -46.45730744 -46.44004 0.004316858848 0.0006147077527 0.000757202747 3.915525299e-05
|
||||
202 4 74.09024992 -46.45025082 -46.437214 0.003259204623 0.000823112906 0.001505586265 0.0001621804833
|
||||
203 4 73.60013606 -46.433967 -46.422628 0.002834751082 0.0008553071125 0.001601713458 0.000233732131
|
||||
204 4 74.47827164 -46.45874769 -46.443535 0.00380317303 0.001150644704 0.001590304373 0.0001312331936
|
||||
205 4 74.22558703 -46.45321801 -46.439922 0.003324001852 0.001030412749 0.001530493385 0.0001208769886
|
||||
206 4 74.15291432 -46.45141844 -46.437675 0.003435859942 0.001323881965 0.002440246094 0.000351523644
|
||||
207 4 74.50981896 -46.45987915 -46.445558 0.003580287949 0.0008016583891 0.00113392416 9.087921501e-05
|
||||
208 4 74.19814905 -46.45309789 -46.439106 0.003497972207 0.001159709328 0.001830731002 0.0002004464824
|
||||
209 4 74.51720313 -46.45968457 -46.443073 0.004152892794 0.0005327789399 0.0005766870902 1.911195046e-05
|
||||
210 4 74.29924604 -46.45529068 -46.4397 0.003897668752 0.0008203202583 0.001204174406 8.707934353e-05
|
||||
211 4 74.09425795 -46.45003681 -46.436374 0.003415701915 0.0008937039936 0.001461656594 0.0001906816478
|
||||
212 4 73.73717548 -46.43887502 -46.426557 0.003079503833 0.0008473432438 0.001359624213 0.0001078467328
|
||||
213 4 73.99983876 -46.44675075 -46.434009 0.00318543858 0.0009993979373 0.001391131194 0.000126864771
|
||||
214 4 74.07916779 -46.4492147 -46.436262 0.003238173905 0.0012911873 0.002503347159 0.0002946038716
|
||||
215 4 73.94744484 -46.44611874 -46.434505 0.0029034362 0.0009930846846 0.001041637173 1.44560542e-05
|
||||
216 4 74.2021224 -46.45267242 -46.438768 0.003476105557 0.0009790325482 0.001098285027 5.900684038e-05
|
||||
217 4 74.20389194 -46.45287404 -46.440254 0.003155011025 0.0005440222637 0.0006069892915 4.917760806e-05
|
||||
218 4 73.66782167 -46.43682196 -46.42286 0.003490490208 0.0005521691303 0.0007365242698 6.657586723e-05
|
||||
219 4 73.46349993 -46.42843317 -46.418078 0.002588792975 0.001215695483 0.002028412187 0.0002117690174
|
||||
220 4 74.30307454 -46.45509879 -46.440513 0.003646448628 0.0008205757569 0.001158189967 0.000110036346
|
||||
221 4 73.21819832 -46.41838058 -46.409824 0.002139145869 0.000869266353 0.001759573812 0.0002125030952
|
||||
222 4 74.35772636 -46.45658501 -46.440329 0.004064003047 0.0006179175264 0.0009534044263 8.737057714e-05
|
||||
223 4 74.17615527 -46.45177345 -46.43773 0.003510862689 0.0007631781991 0.000926180328 6.446679043e-05
|
||||
224 4 73.43860935 -46.4277585 -46.416525 0.002808375906 0.0006623119965 0.0007573664899 4.251239635e-05
|
||||
225 4 74.31356506 -46.45553467 -46.440293 0.003810416894 0.0008201864367 0.0007725386722 1.244767351e-05
|
||||
226 4 74.25452523 -46.45450406 -46.43839 0.004028515986 0.000624431309 0.0005612022808 1.898088401e-05
|
||||
227 4 74.27331932 -46.45546024 -46.438916 0.004136060657 0.0008098609869 0.001650878554 0.0001889274693
|
||||
# GSF_110.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
228 24 -278.7403996 -279.068761 0.01368172569 2.282668754 1.756353161 0.0474563559
|
||||
229 24 -279.902595 -279.784296 0.004929123882 0.9479314831 0.9057668891 0.02403120774
|
||||
230 24 -279.9942014 -279.901657 0.003856015841 0.2795933118 0.001565946359 0.01120665859
|
||||
231 24 -279.6335344 -279.584238 0.002054016531 1.573004204 1.035572248 0.05514377891
|
||||
232 24 -279.9025974 -279.784283 0.004929767703 0.947921084 0.9056396189 0.02406018404
|
||||
233 24 -279.1817177 -279.302158 0.005018345952 2.388096516 1.771965137 0.06275542538
|
||||
234 24 -279.5900705 -279.55564 0.001434605813 1.950503627 1.405626506 0.05370441115
|
||||
235 24 -279.0106063 -279.246939 0.00984719392 1.577003357 0.4813964151 0.08190583543
|
||||
236 24 -279.1817217 -279.302157 0.005018138375 2.388094324 1.771953347 0.06275588675
|
||||
237 24 -279.0107548 -279.246935 0.009840841347 1.576191869 0.4809484798 0.0819682416
|
||||
238 24 -279.9941671 -279.896025 0.004089255845 0.2809227604 0.01060549839 0.01118927817
|
||||
239 24 -279.6337951 -279.584237 0.002064919631 1.571895405 1.035836121 0.05510997377
|
||||
240 24 -278.8616595 -279.124427 0.0109486445 2.383512182 1.809545887 0.06232801199
|
||||
241 24 -279.2927133 -279.379366 0.003610531084 1.779238829 0.8982692706 0.07658702105
|
||||
242 24 -279.292656 -279.37937 0.003613082676 1.779203263 0.898081355 0.0765940488
|
||||
243 24 -278.8616573 -279.124427 0.01094873842 2.383511745 1.809523374 0.06232387507
|
||||
244 24 -279.9942014 -279.901657 0.003856015842 0.27959331 0.001570374478 0.01120603916
|
||||
245 24 -279.9072278 -279.79264 0.004774491325 0.8361247356 0.8392614852 0.02418251879
|
||||
246 24 -279.9941671 -279.896025 0.004089255843 0.2809227622 0.01060243293 0.01118973247
|
||||
247 24 -278.8973689 -279.206496 0.01288029691 1.390234609 0.005326518563 0.06648378416
|
||||
248 24 -279.590075 -279.55564 0.001434791018 1.950495712 1.4056319 0.05370353355
|
||||
249 24 -279.9072386 -279.79264 0.004774943229 0.8361385582 0.8392625708 0.02418484015
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
228 24 828.0362386 -278.8410589 -279.068761 0.009487586046 2.726148177 1.756353161 0.06344241374
|
||||
229 24 828.0362386 -280.0438878 -279.784296 0.01081632552 1.025836691 0.9057668891 0.03431923408
|
||||
230 24 828.0362386 -280.1389453 -279.901657 0.009887011104 0.3820870056 0.001565946359 0.02063932212
|
||||
231 24 828.0362386 -279.7578636 -279.584238 0.007234400289 1.646483877 1.035572248 0.06317254006
|
||||
232 24 828.0362386 -280.0438905 -279.784283 0.01081698125 1.025825697 0.9056396189 0.03433377902
|
||||
233 24 828.0362386 -279.2779929 -279.302158 0.001006879708 2.597392642 1.771965137 0.07498219236
|
||||
234 24 828.0362386 -279.7119341 -279.55564 0.006512252548 2.085996302 1.405626506 0.06414553539
|
||||
235 24 828.0362386 -279.1342144 -279.246939 0.004696857796 1.7145726 0.4813964151 0.09091186796
|
||||
236 24 828.0362386 -279.2779974 -279.302157 0.001006650079 2.59739139 1.771953347 0.07498197018
|
||||
237 24 828.0362386 -279.1342234 -279.246935 0.004696316576 1.714140427 0.4809484798 0.09087969403
|
||||
238 24 828.0362386 -280.1388645 -279.896025 0.01011831143 0.3833172699 0.01060549839 0.0205724723
|
||||
239 24 828.0362386 -279.7581378 -279.584237 0.007245866604 1.645952103 1.035836121 0.06318595533
|
||||
240 24 828.0362386 -278.9562357 -279.124427 0.007007972259 2.699607205 1.809545887 0.07438804482
|
||||
241 24 828.0362386 -279.4052861 -279.379366 0.00108000439 1.874556392 0.8982692706 0.08646596743
|
||||
242 24 828.0362386 -279.4051598 -279.37937 0.001074574944 1.874858028 0.898081355 0.08649971418
|
||||
243 24 828.0362386 -278.9562334 -279.124427 0.007008065732 2.699608673 1.809523374 0.07438947193
|
||||
244 24 828.0362386 -280.1389453 -279.901657 0.009887011104 0.382087008 0.001570374478 0.02063718463
|
||||
245 24 828.0362386 -280.0482205 -279.79264 0.01064918897 0.9069086057 0.8392614852 0.03243659951
|
||||
246 24 828.0362386 -280.1388645 -279.896025 0.01011831143 0.3833172675 0.01060243293 0.02057250032
|
||||
247 24 828.0362386 -279.0366628 -279.206496 0.007076382361 1.638514407 0.005326518563 0.08048168704
|
||||
248 24 828.0362386 -279.7119391 -279.55564 0.006512460902 2.085987992 1.4056319 0.06414586851
|
||||
249 24 828.0362386 -280.0482407 -279.79264 0.01065002958 0.9067922986 0.8392625708 0.03242814224
|
||||
# GSF_112.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
250 30 -345.1428414 -345.175835 0.001099787279 2.717783384 1.057395322 0.1393371019
|
||||
251 30 -346.8213325 -346.361714 0.01532061701 1.6320981 1.220284939 0.1010819808
|
||||
252 30 -346.3061373 -345.795524 0.01702044399 2.435031121 2.112860875 0.1171529224
|
||||
253 30 -344.8834516 -345.164602 0.009371679668 3.314987489 1.765832199 0.1576958872
|
||||
254 30 -346.9668291 -346.593523 0.01244353764 1.327935537 0.01148867129 0.08670065177
|
||||
255 30 -346.7938009 -346.396186 0.01325383111 1.743989434 0.9954683928 0.09783463277
|
||||
256 30 -345.0939055 -345.319406 0.007516682784 3.756566851 1.772040852 0.1806000978
|
||||
257 30 -345.6468551 -345.594794 0.001735368441 3.432645857 1.516014157 0.1670589876
|
||||
258 30 -346.2843474 -345.98566 0.00995624537 2.709563559 1.406252265 0.1356658489
|
||||
259 30 -345.7058793 -345.383994 0.01072951129 2.464665654 0.963574308 0.13389942
|
||||
260 30 -346.9664564 -346.582564 0.01279641284 1.32870642 0.0126740587 0.08670344939
|
||||
261 30 -345.3305431 -345.452139 0.004053195139 4.515828739 2.787719406 0.1519418929
|
||||
262 30 -346.966836 -346.593523 0.01244376534 1.327919807 0.01148834 0.08669988209
|
||||
263 30 -345.5935851 -345.281949 0.01038786965 2.922665543 1.873142686 0.1300383724
|
||||
264 30 -346.157169 -345.928661 0.007616932828 3.42803556 2.100874472 0.1330089569
|
||||
265 30 -344.6836135 -345.111657 0.01426811685 4.87813643 3.358068319 0.1517605656
|
||||
266 30 -346.8140968 -346.367123 0.01489912587 1.700448289 1.335797131 0.1014030448
|
||||
267 30 -346.9664062 -346.582565 0.0127947081 1.328695393 0.01254743735 0.08670444025
|
||||
268 30 -344.5284456 -344.91356 0.012837147 4.30679737 3.441834403 0.1293440404
|
||||
269 30 -346.3471173 -345.836703 0.01701381162 2.177883948 1.608769148 0.1178087924
|
||||
270 30 -344.9135302 -344.984307 0.002359225816 3.517317775 2.542628782 0.122092966
|
||||
271 30 -346.7846048 -346.393931 0.01302245877 1.941770224 1.211680725 0.09898842713
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
250 30 1075.650827 -344.9605863 -345.175835 0.007174958242 2.758670703 1.057395322 0.1516335449
|
||||
251 30 1075.650827 -346.7372372 -346.361714 0.01251744041 1.674795336 1.220284939 0.09596889278
|
||||
252 30 1075.650827 -346.1686186 -345.795524 0.0124364868 2.551456187 2.112860875 0.1075528655
|
||||
253 30 1075.650827 -344.7305027 -345.164602 0.01446997708 3.364761651 1.765832199 0.1653996104
|
||||
254 30 1075.650827 -346.8954513 -346.593523 0.01006427628 1.339499001 0.01148867129 0.08728299447
|
||||
255 30 1075.650827 -346.7069529 -346.396186 0.01035889705 1.846653887 0.9954683928 0.09979294451
|
||||
256 30 1075.650827 -344.9126927 -345.319406 0.01355711006 3.783666815 1.772040852 0.1835364962
|
||||
257 30 1075.650827 -345.4584504 -345.594794 0.004544785139 3.694055398 1.516014157 0.1747792869
|
||||
258 30 1075.650827 -346.1486771 -345.98566 0.005433903845 2.934925394 1.406252265 0.1397537934
|
||||
259 30 1075.650827 -345.5181007 -345.383994 0.00447022439 2.558293398 0.963574308 0.1353120293
|
||||
260 30 1075.650827 -346.8950741 -346.582564 0.01041700207 1.340303074 0.0126740587 0.08735503715
|
||||
261 30 1075.650827 -345.1232455 -345.452139 0.01096311715 4.843836394 2.787719406 0.158731815
|
||||
262 30 1075.650827 -346.8954617 -346.593523 0.01006462208 1.339471584 0.01148834 0.08728175252
|
||||
263 30 1075.650827 -345.3878123 -345.281949 0.003528777779 3.04388336 1.873142686 0.1266226401
|
||||
264 30 1075.650827 -346.0211337 -345.928661 0.003082422836 3.704012447 2.100874472 0.1385926656
|
||||
265 30 1075.650827 -344.4666474 -345.111657 0.0215003205 5.060940978 3.358068319 0.1556709723
|
||||
266 30 1075.650827 -346.731384 -346.367123 0.01214203185 1.743704774 1.335797131 0.0964003512
|
||||
267 30 1075.650827 -346.8950084 -346.582565 0.0104147809 1.34025766 0.01254743735 0.08735400875
|
||||
268 30 1075.650827 -344.3283906 -344.91356 0.01950564575 4.516603649 3.441834403 0.1385132929
|
||||
269 30 1075.650827 -346.2085633 -345.836703 0.01239534254 2.265804409 1.608769148 0.108126121
|
||||
270 30 1075.650827 -344.700705 -344.984307 0.009453398382 3.625655349 2.542628782 0.1276641348
|
||||
271 30 1075.650827 -346.7005545 -346.393931 0.01022078221 2.065166442 1.211680725 0.1018842071
|
||||
# Liquid.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
272 100 -1104.74829 -1105.601723 0.008534329546 31.13590643 31.39853886 0.5826598142
|
||||
273 100 -1099.007356 -1099.673012 0.006656557481 34.30763539 32.03167218 0.6355970492
|
||||
274 100 -1123.744375 -1121.31506 0.0242931528 23.69463257 20.81076453 0.4843518851
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
272 100 2002.996789 -1105.503318 -1105.601723 0.0009840495195 33.67286942 31.39853886 0.5196524511
|
||||
273 100 2002.996789 -1100.916702 -1099.673012 0.01243689799 34.89745034 32.03167218 0.569788481
|
||||
274 100 2002.996789 -1125.248108 -1121.31506 0.03933048075 23.1042808 20.81076453 0.4236223924
|
||||
# Surface.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
275 24 -279.9941674 -279.911828 0.003430809358 0.2809230274 0.002753093533 0.01155715982
|
||||
276 48 -551.0953781 -555.359452 0.08883487284 6.541312712 0.003020630398 0.1949601982
|
||||
277 40 -458.209131 -459.216162 0.02517577443 5.605061426 5.0461364 0.1098503638
|
||||
278 40 -459.8554229 -461.144076 0.03221632783 2.691145822 0.005582740008 0.0817493
|
||||
279 24 -279.8970746 -279.635146 0.01091369091 1.238573481 1.288799837 0.008644383713
|
||||
280 30 -346.9668295 -346.592525 0.01247681774 1.32793475 0.008446203407 0.08664452133
|
||||
281 30 -345.8871537 -345.744506 0.004754921864 3.992236552 3.124961367 0.08594721633
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
275 24 828.0362197 -280.1388649 -279.911828 0.009459870394 0.3833165637 0.002753093533 0.0209958793
|
||||
276 48 1756.536679 -551.9765065 -555.359452 0.07047803038 5.695770431 0.003020630398 0.1710474815
|
||||
277 40 1394.433693 -457.8965908 -459.216162 0.03298927919 6.47605009 5.0461364 0.1141155284
|
||||
278 40 1394.433693 -459.4317427 -461.144076 0.04280833158 2.948762022 0.005582740008 0.1122771088
|
||||
279 24 828.0362197 -279.9357878 -279.635146 0.01252674323 2.282528363 1.288799837 0.0489285834
|
||||
280 30 1075.65076 -346.8954518 -346.592525 0.01009756105 1.339498529 0.008446203407 0.08713647389
|
||||
281 30 1075.65076 -345.7511061 -345.744506 0.0002200037964 4.894457614 3.124961367 0.1246204459
|
||||
# Volume_A15.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
282 8 -66.46788051 -66.990732 0.06535643627 8.928342366e-15 0 1.501728429e-15
|
||||
283 8 -72.67646146 -72.957807 0.03516819273 3.04869178e-14 0 5.1001593e-15
|
||||
284 8 -94.20621366 -94.145745 0.00755858243 1.880283026e-14 0 2.444387059e-15
|
||||
285 8 -94.43981933 -94.554682 0.01435783313 5.684495802e-15 0 8.992080697e-16
|
||||
286 8 -79.39814886 -79.438363 0.005026767696 1.186991025e-14 0 1.998979685e-15
|
||||
287 8 -69.38946962 -69.627817 0.02979342197 5.582708452e-15 0 9.058870552e-16
|
||||
288 8 -83.05531805 -82.604907 0.05630138147 5.067400154e-15 0 8.060681752e-16
|
||||
289 8 14.36690687 14.89048 0.0654466408 7.096605716e-14 0 9.778491674e-15
|
||||
290 8 -94.13472519 -94.367599 0.02910922586 1.767991013e-14 0 2.1395518e-15
|
||||
291 8 -89.38757156 -89.248227 0.01741807051 8.884610804e-15 0 1.30769238e-15
|
||||
292 8 -87.49741165 -87.211997 0.03567683079 8.006170389e-15 0 1.152290069e-15
|
||||
293 8 -93.42285179 -93.66897 0.03076477666 2.280172604e-15 0 3.891032311e-16
|
||||
294 8 -8.05187323 -7.989166 0.007838403785 7.482512497e-14 0 1.195728177e-14
|
||||
295 8 -85.3779751 -84.982834 0.04939263793 3.220622406e-15 0 4.863008144e-16
|
||||
296 8 -92.37490481 -92.536373 0.0201835236 1.673164165e-14 0 2.290124109e-15
|
||||
297 8 -26.56925158 -26.77612 0.02585855302 4.751528484e-14 0 7.423756449e-15
|
||||
298 8 -77.90929192 -77.544107 0.04564811452 4.617032687e-15 0 7.294873617e-16
|
||||
299 8 -80.55632181 -80.114217 0.05526310126 8.324980615e-15 0 1.201946528e-15
|
||||
300 8 -41.83202596 -42.143041 0.03887688062 3.384606082e-14 0 5.356279237e-15
|
||||
301 8 -91.02235339 -91.040671 0.002289700675 3.337550263e-15 0 5.490399801e-16
|
||||
302 8 -84.76781055 -84.499231 0.03357244376 3.246108052e-14 0 5.927694678e-15
|
||||
303 8 -60.71236154 -61.825173 0.1391014324 7.918599116e-15 0 1.30776466e-15
|
||||
304 8 -91.5794594 -91.156873 0.05282330009 3.642169681e-15 0 5.988997276e-16
|
||||
305 8 -54.28408457 -54.658744 0.04683242815 8.878350559e-14 0 1.511496461e-14
|
||||
306 8 -72.29317827 -72.277255 0.00199040924 2.467731222e-15 0 3.339523392e-16
|
||||
307 8 -75.14428628 -74.923334 0.02761903549 3.575872549e-15 0 5.510457542e-16
|
||||
308 8 -64.41647714 -64.798066 0.04769860741 1.525236831e-14 0 2.48556962e-15
|
||||
309 8 -93.29905733 -93.048342 0.03133941583 1.463792794e-14 0 2.408158856e-15
|
||||
310 8 -63.56375833 -64.38702 0.1029077093 2.897725758e-15 0 5.108399236e-16
|
||||
311 8 -88.81067445 -88.352871 0.05722543104 1.077500255e-14 0 1.707889472e-15
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
282 8 300.763 -66.50302875 -66.990732 0.06096290674 1.941277332e-14 0 3.37325783e-15
|
||||
283 8 97.336 -72.75000964 -72.957807 0.0259746695 1.351006698e-13 0 2.177344384e-14
|
||||
284 8 140.608 -94.15533163 -94.145745 0.001198328985 4.044529328e-14 0 6.693247629e-15
|
||||
285 8 148.877 -94.40707977 -94.554682 0.01845027858 6.513916874e-14 0 1.052717644e-14
|
||||
286 8 103.823 -79.45083178 -79.438363 0.001558598047 1.722214314e-13 0 2.77785865e-14
|
||||
287 8 287.496 -69.43914664 -69.627817 0.02358379473 1.869801108e-14 0 2.486725909e-15
|
||||
288 8 226.981 -83.07759076 -82.604907 0.05908546939 1.580586786e-14 0 2.506150792e-15
|
||||
289 8 64 14.38834339 14.89048 0.06276707625 3.142551462e-13 0 4.611672661e-14
|
||||
290 8 157.464 -94.121065 -94.367599 0.03081674996 4.627906691e-14 0 7.060581015e-15
|
||||
291 8 195.112 -89.39236133 -89.248227 0.01801679107 2.992297744e-14 0 4.401789389e-15
|
||||
292 8 205.379 -87.50415023 -87.211997 0.03651915426 2.29993221e-14 0 3.752044138e-15
|
||||
293 8 166.375 -93.42125038 -93.66897 0.03096495278 2.907694533e-14 0 4.724788551e-15
|
||||
294 8 68.921 -8.019333034 -7.989166 0.003770879216 3.356694228e-13 0 6.09434176e-14
|
||||
295 8 216 -85.39060668 -84.982834 0.0509715856 9.263122354e-15 0 1.424782104e-15
|
||||
296 8 175.616 -92.37850178 -92.536373 0.01973390211 3.567976799e-14 0 6.038472675e-15
|
||||
297 8 74.088 -26.52314912 -26.77612 0.03162135966 2.830510779e-13 0 4.116147259e-14
|
||||
298 8 250.047 -77.95455874 -77.544107 0.05130646772 1.722828231e-14 0 2.531351199e-15
|
||||
299 8 238.328 -80.59031991 -80.114217 0.05951286389 1.790178605e-14 0 2.961270842e-15
|
||||
300 8 79.507 -41.81723354 -42.143041 0.04072593188 2.017987815e-13 0 3.254206583e-14
|
||||
301 8 185.193 -91.02736742 -91.040671 0.001662947812 2.413722535e-14 0 4.098218376e-15
|
||||
302 8 110.592 -84.77992099 -84.499231 0.035086249 6.257383276e-14 0 9.730565054e-15
|
||||
303 8 328.509 -60.69292469 -61.825173 0.1415310384 2.336487667e-14 0 4.192320181e-15
|
||||
304 8 125 -91.53133052 -91.156873 0.04680718995 4.580314378e-14 0 7.417918736e-15
|
||||
305 8 85.184 -54.31160005 -54.658744 0.04339299436 2.081820808e-13 0 3.494754179e-14
|
||||
306 8 274.625 -72.34854762 -72.277255 0.008911577286 3.722472678e-15 0 6.21411631e-16
|
||||
307 8 262.144 -75.19753913 -74.923334 0.03427564069 1.368884593e-14 0 2.258168709e-15
|
||||
308 8 91.125 -64.47776048 -64.798066 0.04003818964 1.208370656e-13 0 1.995060684e-14
|
||||
309 8 132.651 -93.2347704 -93.048342 0.02330355033 5.798970328e-14 0 9.670321353e-15
|
||||
310 8 314.432 -63.5755377 -64.38702 0.1014352879 7.556804155e-15 0 1.29652209e-15
|
||||
311 8 117.649 -88.79067694 -88.352871 0.05472574302 7.470145864e-14 0 1.29226998e-14
|
||||
# Volume_BCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
312 2 -16.38936242 -16.763625 0.1871312901 5.164700352e-16 0 1.827242061e-16
|
||||
313 2 16.19675433 16.314145 0.05869533666 6.530646709e-14 0 1.921032777e-14
|
||||
314 2 -21.24238574 -21.209071 0.01665736942 1.908874745e-15 0 7.170229344e-16
|
||||
315 2 -15.80560502 -15.780524 0.01254051029 3.122816732e-14 0 1.231252513e-14
|
||||
316 2 -19.05526774 -19.002205 0.02653137194 7.555287577e-15 0 2.037557095e-15
|
||||
317 2 -22.67434567 -22.620568 0.02688883674 1.349360652e-15 0 4.857225733e-16
|
||||
318 2 4.04311049 4.096885 0.02688725502 1.772872048e-14 0 6.601201067e-15
|
||||
319 2 56.2105911 56.26276 0.02608445186 1.377801077e-13 0 4.795418557e-14
|
||||
320 2 -22.55797904 -22.585113 0.01356697915 3.380715703e-15 0 1.276756478e-15
|
||||
321 2 -21.75972417 -21.795501 0.0178884163 1.168374574e-15 0 4.533410684e-16
|
||||
322 2 33.30678917 33.110078 0.09835558332 3.387360342e-14 0 9.173217741e-15
|
||||
323 2 -20.82125169 -20.885998 0.0323731563 9.918492908e-16 0 3.654484123e-16
|
||||
324 2 -23.55239721 -23.601336 0.02446939304 2.356479148e-15 0 7.090682208e-16
|
||||
325 2 -23.17147126 -23.207313 0.01792086946 1.448170847e-15 0 4.901445524e-16
|
||||
326 2 -19.78146338 -19.898089 0.05831281177 7.349099448e-15 0 2.984880861e-15
|
||||
327 2 -23.45038238 -23.405474 0.02245418985 2.124472575e-15 0 7.6356745e-16
|
||||
328 2 -4.653232293 -4.781324 0.06404585371 1.121589994e-14 0 3.980033895e-15
|
||||
329 2 -18.67517238 -18.864936 0.09488180756 4.972820174e-16 0 1.896631e-16
|
||||
330 2 -17.53439276 -17.813086 0.1393466189 8.350923499e-16 0 3.215020842e-16
|
||||
331 2 -11.04889659 -11.197201 0.07415220345 1.822150476e-14 0 6.092637968e-15
|
||||
332 2 -23.68489671 -23.696705 0.00590414498 1.240124986e-15 0 4.153217122e-16
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
312 2 74.088 -16.41904746 -16.763625 0.172288768 8.881784197e-16 0 2.960594732e-16
|
||||
313 2 13.824 16.2292442 16.314145 0.04245040205 6.132313711e-13 0 2.290852693e-13
|
||||
314 2 27 -21.2109771 -21.209071 0.0009530502432 1.123466673e-14 0 3.552712694e-15
|
||||
315 2 21.952 -15.82599793 -15.780524 0.02273696393 2.538428743e-13 0 1.020665034e-13
|
||||
316 2 24.389 -19.01309058 -19.002205 0.005442789013 7.306210466e-15 0 2.50031477e-15
|
||||
317 2 29.791 -22.67048776 -22.620568 0.02495988117 2.031435111e-14 0 8.215650382e-15
|
||||
318 2 15.625 4.095802366 4.096885 0.0005413171271 6.359497134e-14 0 2.069640755e-14
|
||||
319 2 10.648 56.21520101 56.26276 0.0237794968 6.137452342e-13 0 2.262703913e-13
|
||||
320 2 46.656 -22.54194179 -22.585113 0.02158560454 1.006819876e-14 0 3.996802889e-15
|
||||
321 2 50.653 -21.73865048 -21.795501 0.0284252602 1.776356839e-15 0 5.921189465e-16
|
||||
322 2 12.167 33.26085588 33.110078 0.0753889407 1.720476052e-13 0 4.707345624e-14
|
||||
323 2 54.872 -20.80030783 -20.885998 0.04284508708 1.538370149e-15 0 5.921189465e-16
|
||||
324 2 39.304 -23.54386901 -23.601336 0.02873349282 4.528839094e-15 0 1.480297366e-15
|
||||
325 2 42.875 -23.16144784 -23.207313 0.02293258231 2.082963029e-15 0 7.401486831e-16
|
||||
326 2 59.319 -19.76694674 -19.898089 0.06557112796 4.389974022e-14 0 1.776356839e-14
|
||||
327 2 32.768 -23.46365391 -23.405474 0.0290899572 1.331156944e-14 0 5.403085387e-15
|
||||
328 2 17.576 -4.6700202 -4.781324 0.05565189983 4.987657631e-14 0 1.465494393e-14
|
||||
329 2 64 -18.67254286 -18.864936 0.09619657243 8.881784197e-16 0 2.960594732e-16
|
||||
330 2 68.921 -17.54726713 -17.813086 0.1329094363 1.371024298e-15 0 4.440892099e-16
|
||||
331 2 19.683 -11.12327165 -11.197201 0.03696467615 4.343228798e-14 0 1.539509261e-14
|
||||
332 2 35.937 -23.68985458 -23.696705 0.003425208911 8.588276581e-15 0 2.812564996e-15
|
||||
# Volume_FCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
333 4 -19.13390887 -19.075994 0.01447871809 1.022152812e-14 0 2.293587909e-15
|
||||
334 4 -35.26038882 -34.873619 0.0966924543 1.299038035e-15 0 3.09937261e-16
|
||||
335 4 -43.93272346 -43.950003 0.004319884816 1.839067075e-15 0 3.483902981e-16
|
||||
336 4 -41.03733831 -40.991909 0.01135732773 4.481141716e-15 0 9.930207698e-16
|
||||
337 4 -43.4228254 -43.453929 0.007775899668 3.563251054e-14 0 1.025252039e-14
|
||||
338 4 -42.67289278 -42.686077 0.003296053998 3.08362874e-15 0 8.245357522e-16
|
||||
339 4 -33.58842759 -33.224653 0.09094364633 7.806891681e-16 0 2.054201716e-16
|
||||
340 4 -27.01189372 -26.862709 0.03729618105 6.429823751e-15 0 1.469359846e-15
|
||||
341 4 -25.59030438 -25.519883 0.01760534598 1.262126674e-15 0 3.031429274e-16
|
||||
342 4 3.441093749 3.463071 0.005494312714 2.222300041e-14 0 5.686075706e-15
|
||||
343 4 -31.9073245 -31.59595 0.07784362479 8.772505365e-16 0 2.178523565e-16
|
||||
344 4 -45.06068744 -45.100466 0.009944641012 2.844345405e-15 0 6.141228113e-16
|
||||
345 4 -46.03981427 -46.052258 0.0031109323 3.085311895e-15 0 7.534482297e-16
|
||||
346 4 -30.24326213 -30.001189 0.06051828302 1.033301257e-15 0 2.648344507e-16
|
||||
347 4 -22.957351 -22.8504 0.02673775024 1.649470508e-15 0 4.625206468e-16
|
||||
348 4 -9.130654755 -9.164691 0.008509061334 1.441769296e-14 0 2.967949237e-15
|
||||
349 4 -24.21746226 -24.150343 0.01677981454 9.080179666e-16 0 2.344767898e-16
|
||||
350 4 -46.44761241 -46.426795 0.005204351765 1.356833237e-15 0 3.249715312e-16
|
||||
351 4 -28.62111495 -28.451145 0.04249248833 8.73448718e-15 0 2.511662753e-15
|
||||
352 4 40.31615798 40.341566 0.006352005142 4.072809775e-14 0 8.11641299e-15
|
||||
353 4 19.51151427 19.617912 0.02659943252 2.395447746e-14 0 5.536534686e-15
|
||||
354 4 -27.06356399 -26.954384 0.02729499736 7.989451601e-16 0 1.662443331e-16
|
||||
355 4 -46.3678929 -46.323696 0.01104922394 3.225354336e-15 0 8.604228441e-16
|
||||
356 4 -45.87221055 -45.828947 0.01081588677 3.654195723e-15 0 9.691321819e-16
|
||||
357 4 -38.47076405 -38.16029 0.0776185126 1.743572283e-15 0 4.628820475e-16
|
||||
358 4 -33.06813795 -32.919741 0.03709923634 1.476523661e-14 0 4.182418301e-15
|
||||
359 4 -41.34431995 -41.272675 0.01791123821 3.354385367e-15 0 9.014870014e-16
|
||||
360 4 -39.95757678 -39.753322 0.05106369446 1.803308855e-15 0 4.257287097e-16
|
||||
361 4 -37.66252943 -37.547435 0.02877360828 4.901403086e-15 0 1.0480621e-15
|
||||
362 4 -36.89659259 -36.52595 0.09266064636 2.659569984e-15 0 6.744460314e-16
|
||||
363 4 -45.03250721 -45.016087 0.004105053075 1.580168365e-15 0 3.385601984e-16
|
||||
config # atoms volume energy DFT energy energy error force DFT force force error
|
||||
333 4 39.304 -19.04121551 -19.075994 0.008694621404 9.324046941e-14 0 2.550216982e-14
|
||||
334 4 140.608 -35.2532829 -34.873619 0.09491597439 7.957989483e-17 0 1.134599845e-17
|
||||
335 4 97.336 -43.90903851 -43.950003 0.01024112333 9.677895068e-15 0 2.24135791e-15
|
||||
336 4 54.872 -41.05446227 -40.991909 0.01563831765 1.98280496e-14 0 4.875440329e-15
|
||||
337 4 59.319 -43.40999789 -43.453929 0.01098277702 9.570074295e-14 0 2.719164593e-14
|
||||
338 4 103.823 -42.63532355 -42.686077 0.01268836179 2.539930576e-15 0 4.806204543e-16
|
||||
339 4 148.877 -33.58964546 -33.224653 0.09124811554 2.796923066e-17 0 3.296205444e-18
|
||||
340 4 42.875 -26.8499756 -26.862709 0.003183350784 4.824942051e-14 0 1.148213469e-14
|
||||
341 4 195.112 -25.5782856 -25.519883 0.01460065124 2.683808864e-16 0 5.477307421e-17
|
||||
342 4 32.768 3.274215348 3.463071 0.04721391298 1.751484723e-13 0 4.608697683e-14
|
||||
343 4 157.464 -31.91218763 -31.59595 0.07905940659 3.590442267e-17 0 4.231376791e-18
|
||||
344 4 64 -45.05473725 -45.100466 0.01143218825 7.235555613e-15 0 1.620123306e-15
|
||||
345 4 68.921 -46.04331302 -46.052258 0.002236244179 5.893206675e-15 0 1.299708229e-15
|
||||
346 4 166.375 -30.2468098 -30.001189 0.06140519937 2.820758891e-16 0 5.580616674e-17
|
||||
347 4 216 -22.95485577 -22.8504 0.02611394167 1.164554524e-16 0 2.312964635e-17
|
||||
348 4 35.937 -9.215415964 -9.164691 0.01268124103 4.893101434e-14 0 1.156092005e-14
|
||||
349 4 205.379 -24.20645978 -24.150343 0.01402919404 2.781506505e-18 0 3.278036852e-19
|
||||
350 4 74.088 -46.44951294 -46.426795 0.005679484598 2.411816735e-15 0 4.763070257e-16
|
||||
351 4 175.616 -28.61960857 -28.451145 0.04211589328 1.078338842e-14 0 3.09506759e-15
|
||||
352 4 27 40.45415396 40.341566 0.02814698887 1.556900619e-13 0 3.789568123e-14
|
||||
353 4 29.791 19.42166568 19.617912 0.04906157941 1.398773649e-13 0 3.335786504e-14
|
||||
354 4 185.193 -27.05578105 -26.954384 0.02534926276 2.758936733e-16 0 5.630535877e-17
|
||||
355 4 79.507 -46.36425384 -46.323696 0.01013945879 2.152124725e-15 0 4.437884935e-16
|
||||
356 4 85.184 -45.86352273 -45.828947 0.008643933117 3.448840532e-14 0 9.539924949e-15
|
||||
357 4 125 -38.44027502 -38.16029 0.06999625463 1.884407826e-15 0 4.44194105e-16
|
||||
358 4 46.656 -32.97168631 -32.919741 0.01298632653 1.142146022e-13 0 2.894877625e-14
|
||||
359 4 110.592 -41.29864314 -41.272675 0.006492033936 3.342024128e-14 0 9.358862094e-15
|
||||
360 4 117.649 -39.91686354 -39.753322 0.04088538603 7.303704341e-15 0 1.704201263e-15
|
||||
361 4 50.653 -37.65718147 -37.547435 0.02743661628 2.105764443e-14 0 5.292352205e-15
|
||||
362 4 132.651 -36.87810682 -36.52595 0.08803920465 3.379802923e-17 0 3.983135944e-18
|
||||
363 4 91.125 -45.01844387 -45.016087 0.0005892174087 1.081458604e-14 0 2.513809578e-15
|
||||
|
||||
@ -2,19 +2,19 @@
|
||||
---------------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
---------------------------------------------------------------------------------------------------
|
||||
Displaced_A15.xyz 9 576 0.011286 0.011334 0.113353 0.141650
|
||||
Displaced_BCC.xyz 9 486 0.012178 0.014005 0.240613 0.312191
|
||||
Displaced_FCC.xyz 9 432 0.001445 0.001591 0.082688 0.103800
|
||||
Elastic_BCC.xyz 100 200 0.004452 0.004783 0.000010 0.000013
|
||||
Elastic_FCC.xyz 100 400 0.002865 0.002923 0.000146 0.000207
|
||||
GSF_110.xyz 22 528 0.005804 0.006853 0.047276 0.097819
|
||||
GSF_112.xyz 22 660 0.010588 0.011555 0.123342 0.191090
|
||||
Liquid.xyz 3 300 0.013161 0.015355 0.567536 0.757847
|
||||
Surface.xyz 7 236 0.025400 0.037555 0.096121 0.295623
|
||||
Volume_A15.xyz 30 240 0.039281 0.048678 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.049766 0.067554 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.030056 0.041738 0.000000 0.000000
|
||||
Displaced_A15.xyz 9 576 0.015324 0.015365 0.140594 0.184797
|
||||
Displaced_BCC.xyz 9 486 0.009486 0.011643 0.249983 0.320375
|
||||
Displaced_FCC.xyz 9 432 0.000686 0.000880 0.091420 0.113585
|
||||
Elastic_BCC.xyz 100 200 0.003796 0.004379 0.000015 0.000020
|
||||
Elastic_FCC.xyz 100 400 0.003332 0.003372 0.000122 0.000178
|
||||
GSF_110.xyz 22 528 0.007027 0.007797 0.057637 0.115638
|
||||
GSF_112.xyz 22 660 0.010396 0.011347 0.125237 0.198553
|
||||
Liquid.xyz 3 300 0.017584 0.023822 0.504354 0.660300
|
||||
Surface.xyz 7 236 0.025511 0.034302 0.107190 0.285034
|
||||
Volume_A15.xyz 30 240 0.038624 0.048355 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.044423 0.061685 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.030062 0.041271 0.000000 0.000000
|
||||
---------------------------------------------------------------------------------------------------
|
||||
All files 363 4224 0.012917 0.025797 0.122473 0.260052
|
||||
All files 363 4224 0.012618 0.024806 0.125879 0.247229
|
||||
---------------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
|
||||
@ -1,5 +1 @@
|
||||
# Demonstrate fitpod for POD potential
|
||||
|
||||
units metal
|
||||
fitpod Ta_param.pod Ta_data.pod
|
||||
|
||||
fitpod Ta_param.pod Ta_data.pod
|
||||
@ -44,4 +44,3 @@ velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
|
||||
|
||||
|
||||
52
examples/PACKAGES/pod/Ta/in.pod.compute
Normal file
52
examples/PACKAGES/pod/Ta/in.pod.compute
Normal file
@ -0,0 +1,52 @@
|
||||
# Demonstrate bispectrum computes
|
||||
|
||||
# initialize simulation
|
||||
|
||||
variable nsteps index 0
|
||||
variable nrep equal 2
|
||||
variable a equal 2.0
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable ny equal ${nrep}
|
||||
variable nz equal ${nrep}
|
||||
|
||||
boundary p p p
|
||||
|
||||
atom_modify map hash
|
||||
lattice bcc $a
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
create_box 2 box
|
||||
create_atoms 2 box
|
||||
|
||||
mass * 180.88
|
||||
|
||||
displace_atoms all random 0.1 0.1 0.1 123456
|
||||
|
||||
# set up dummy potential to satisfy cutoff
|
||||
variable rcutfac equal 6.0
|
||||
pair_style zero ${rcutfac}
|
||||
pair_coeff * *
|
||||
|
||||
# set up per-atom computes
|
||||
|
||||
compute ld all pod/atom Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
compute dd all podd/atom Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
|
||||
# set up compute snap generating global array
|
||||
|
||||
compute gdd all pod/global Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
#fix gdd all ave/time 1 1 1 c_gdd[*] file pod.gdd.dat mode vector
|
||||
|
||||
compute ldd all pod/local Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
#fix ldd all ave/time 1 1 1 c_ldd[*] file pod.ldd.dat mode vector
|
||||
|
||||
#dump mydump_ld all custom 1000 dump_ld id c_ld[*]
|
||||
#dump mydump_dd all custom 1000 dump_dd id c_dd[*]
|
||||
|
||||
variable sample_ld1 equal C_ld[1][10] # Arbitrary local descriptor
|
||||
fix ldprint all print 1 "${sample_ld1}"
|
||||
|
||||
run ${nsteps}
|
||||
@ -1,32 +1,37 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-177-g86abf4f680-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate fitpod for POD potential
|
||||
|
||||
units metal
|
||||
fitpod Ta_param.pod Ta_data.pod
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 0
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 0
|
||||
total number of descriptors for all potentials: 32
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Data File ****************
|
||||
@ -34,6 +39,8 @@ file format: extxyz
|
||||
file extension: xyz
|
||||
path to training data set: XYZ
|
||||
path to test data set: XYZ
|
||||
path to environment configuration set: XYZ
|
||||
basename for output files: Ta
|
||||
training fraction: 1
|
||||
test fraction: 1
|
||||
randomize training data set: 1
|
||||
@ -45,7 +52,8 @@ energy/force calculation for test data set: 0
|
||||
fitting weight for energy: 100
|
||||
fitting weight for force: 1
|
||||
fitting weight for stress: 0
|
||||
fitting regularization parameter: 1e-10
|
||||
save pod descriptors: 0
|
||||
compute pod descriptors: 0
|
||||
**************** End of Data File ****************
|
||||
**************** Begin of Training Data Set ****************
|
||||
---------------------------------------------------------------
|
||||
@ -74,8 +82,7 @@ maximum number of atoms: 100
|
||||
maximum number of atoms in periodic domain: 100
|
||||
maximum number of atoms in extended domain: 2700
|
||||
maximum number of neighbors in extended domain: 270000
|
||||
size of double memory: 223201
|
||||
size of int memory: 14709
|
||||
size of double memory: 232128
|
||||
size of descriptor matrix: 32 x 32
|
||||
**************** End of Memory Allocation ****************
|
||||
**************** Begin of Least-Squares Fitting ****************
|
||||
@ -83,7 +90,6 @@ Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
**************** End of Least-Squares Fitting ****************
|
||||
**************** Begin of Error Calculation ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
@ -94,21 +100,20 @@ Configuration: # 301
|
||||
---------------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
---------------------------------------------------------------------------------------------------
|
||||
Displaced_A15.xyz 9 576 0.011286 0.011334 0.113353 0.141650
|
||||
Displaced_BCC.xyz 9 486 0.012178 0.014005 0.240613 0.312191
|
||||
Displaced_FCC.xyz 9 432 0.001445 0.001591 0.082688 0.103800
|
||||
Elastic_BCC.xyz 100 200 0.004452 0.004783 0.000010 0.000013
|
||||
Elastic_FCC.xyz 100 400 0.002865 0.002923 0.000146 0.000207
|
||||
GSF_110.xyz 22 528 0.005804 0.006853 0.047276 0.097819
|
||||
GSF_112.xyz 22 660 0.010588 0.011555 0.123342 0.191090
|
||||
Liquid.xyz 3 300 0.013161 0.015355 0.567536 0.757847
|
||||
Surface.xyz 7 236 0.025400 0.037555 0.096121 0.295623
|
||||
Volume_A15.xyz 30 240 0.039281 0.048678 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.049766 0.067554 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.030056 0.041738 0.000000 0.000000
|
||||
Displaced_A15.xyz 9 576 0.015324 0.015365 0.140594 0.184797
|
||||
Displaced_BCC.xyz 9 486 0.009486 0.011643 0.249983 0.320375
|
||||
Displaced_FCC.xyz 9 432 0.000686 0.000880 0.091420 0.113585
|
||||
Elastic_BCC.xyz 100 200 0.003796 0.004379 0.000015 0.000020
|
||||
Elastic_FCC.xyz 100 400 0.003332 0.003372 0.000122 0.000178
|
||||
GSF_110.xyz 22 528 0.007027 0.007797 0.057637 0.115638
|
||||
GSF_112.xyz 22 660 0.010396 0.011347 0.125237 0.198553
|
||||
Liquid.xyz 3 300 0.017584 0.023822 0.504354 0.660300
|
||||
Surface.xyz 7 236 0.025511 0.034302 0.107190 0.285034
|
||||
Volume_A15.xyz 30 240 0.038624 0.048355 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.044423 0.061685 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.030062 0.041271 0.000000 0.000000
|
||||
---------------------------------------------------------------------------------------------------
|
||||
All files 363 4224 0.012917 0.025797 0.122473 0.260052
|
||||
All files 363 4224 0.012618 0.024806 0.125879 0.247229
|
||||
---------------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
|
||||
Total wall time: 0:00:00
|
||||
@ -1,32 +1,37 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-177-g86abf4f680-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate fitpod for POD potential
|
||||
|
||||
units metal
|
||||
fitpod Ta_param.pod Ta_data.pod
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 0
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 0
|
||||
total number of descriptors for all potentials: 32
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Data File ****************
|
||||
@ -34,6 +39,8 @@ file format: extxyz
|
||||
file extension: xyz
|
||||
path to training data set: XYZ
|
||||
path to test data set: XYZ
|
||||
path to environment configuration set: XYZ
|
||||
basename for output files: Ta
|
||||
training fraction: 1
|
||||
test fraction: 1
|
||||
randomize training data set: 1
|
||||
@ -45,7 +52,8 @@ energy/force calculation for test data set: 0
|
||||
fitting weight for energy: 100
|
||||
fitting weight for force: 1
|
||||
fitting weight for stress: 0
|
||||
fitting regularization parameter: 1e-10
|
||||
save pod descriptors: 0
|
||||
compute pod descriptors: 0
|
||||
**************** End of Data File ****************
|
||||
**************** Begin of Training Data Set ****************
|
||||
---------------------------------------------------------------
|
||||
@ -74,8 +82,7 @@ maximum number of atoms: 100
|
||||
maximum number of atoms in periodic domain: 100
|
||||
maximum number of atoms in extended domain: 2700
|
||||
maximum number of neighbors in extended domain: 270000
|
||||
size of double memory: 223201
|
||||
size of int memory: 14709
|
||||
size of double memory: 232128
|
||||
size of descriptor matrix: 32 x 32
|
||||
**************** End of Memory Allocation ****************
|
||||
**************** Begin of Least-Squares Fitting ****************
|
||||
@ -83,7 +90,6 @@ Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
**************** End of Least-Squares Fitting ****************
|
||||
**************** Begin of Error Calculation ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
@ -94,21 +100,20 @@ Configuration: # 301
|
||||
---------------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
---------------------------------------------------------------------------------------------------
|
||||
Displaced_A15.xyz 9 576 0.011286 0.011334 0.113353 0.141650
|
||||
Displaced_BCC.xyz 9 486 0.012178 0.014005 0.240613 0.312191
|
||||
Displaced_FCC.xyz 9 432 0.001445 0.001591 0.082688 0.103800
|
||||
Elastic_BCC.xyz 100 200 0.004452 0.004783 0.000010 0.000013
|
||||
Elastic_FCC.xyz 100 400 0.002865 0.002923 0.000146 0.000207
|
||||
GSF_110.xyz 22 528 0.005804 0.006853 0.047276 0.097819
|
||||
GSF_112.xyz 22 660 0.010588 0.011555 0.123342 0.191090
|
||||
Liquid.xyz 3 300 0.013161 0.015355 0.567536 0.757847
|
||||
Surface.xyz 7 236 0.025400 0.037555 0.096121 0.295623
|
||||
Volume_A15.xyz 30 240 0.039281 0.048678 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.049766 0.067554 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.030056 0.041738 0.000000 0.000000
|
||||
Displaced_A15.xyz 9 576 0.015324 0.015365 0.140594 0.184797
|
||||
Displaced_BCC.xyz 9 486 0.009486 0.011643 0.249983 0.320375
|
||||
Displaced_FCC.xyz 9 432 0.000686 0.000880 0.091420 0.113585
|
||||
Elastic_BCC.xyz 100 200 0.003796 0.004379 0.000015 0.000020
|
||||
Elastic_FCC.xyz 100 400 0.003332 0.003372 0.000122 0.000178
|
||||
GSF_110.xyz 22 528 0.007027 0.007797 0.057637 0.115638
|
||||
GSF_112.xyz 22 660 0.010396 0.011347 0.125237 0.198553
|
||||
Liquid.xyz 3 300 0.017584 0.023822 0.504354 0.660300
|
||||
Surface.xyz 7 236 0.025511 0.034302 0.107190 0.285034
|
||||
Volume_A15.xyz 30 240 0.038624 0.048355 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.044423 0.061685 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.030062 0.041271 0.000000 0.000000
|
||||
---------------------------------------------------------------------------------------------------
|
||||
All files 363 4224 0.012917 0.025797 0.122473 0.260052
|
||||
All files 363 4224 0.012618 0.024806 0.125879 0.247229
|
||||
---------------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
|
||||
Total wall time: 0:00:01
|
||||
Total wall time: 0:00:00
|
||||
293
examples/PACKAGES/pod/Ta/log.22May24.pod.compute.g++.1
Normal file
293
examples/PACKAGES/pod/Ta/log.22May24.pod.compute.g++.1
Normal file
@ -0,0 +1,293 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-177-g86abf4f680-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate bispectrum computes
|
||||
|
||||
# initialize simulation
|
||||
|
||||
variable nsteps index 0
|
||||
variable nrep equal 2
|
||||
variable a equal 2.0
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 2
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 2
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 2
|
||||
|
||||
boundary p p p
|
||||
|
||||
atom_modify map hash
|
||||
lattice bcc $a
|
||||
lattice bcc 2
|
||||
Lattice spacing in x,y,z = 2 2 2
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 2 0 ${ny} 0 ${nz}
|
||||
region box block 0 2 0 2 0 ${nz}
|
||||
region box block 0 2 0 2 0 2
|
||||
create_box 2 box
|
||||
Created orthogonal box = (0 0 0) to (4 4 4)
|
||||
1 by 1 by 1 MPI processor grid
|
||||
create_atoms 2 box
|
||||
Created 16 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (4 4 4)
|
||||
create_atoms CPU = 0.001 seconds
|
||||
|
||||
mass * 180.88
|
||||
|
||||
displace_atoms all random 0.1 0.1 0.1 123456
|
||||
Displacing atoms ...
|
||||
|
||||
# set up dummy potential to satisfy cutoff
|
||||
variable rcutfac equal 6.0
|
||||
pair_style zero ${rcutfac}
|
||||
pair_style zero 6
|
||||
pair_coeff * *
|
||||
|
||||
# set up per-atom computes
|
||||
|
||||
compute ld all pod/atom Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
compute dd all podd/atom Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
|
||||
# set up compute snap generating global array
|
||||
|
||||
compute gdd all pod/gdd Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
#fix gdd all ave/time 1 1 1 c_gdd[*] file pod.gdd.dat mode vector
|
||||
|
||||
compute ldd all pod/ldd Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
#fix ldd all ave/time 1 1 1 c_ldd[*] file pod.ldd.dat mode vector
|
||||
|
||||
#dump mydump_ld all custom 1000 dump_ld id c_ld[*]
|
||||
#dump mydump_dd all custom 1000 dump_dd id c_dd[*]
|
||||
|
||||
variable sample_ld1 equal C_ld[1][10] # Arbitrary local descriptor
|
||||
fix ldprint all print 1 "${sample_ld1}"
|
||||
|
||||
run ${nsteps}
|
||||
run 0
|
||||
WARNING: No fixes with time integration, atoms won't move (src/verlet.cpp:60)
|
||||
Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_pod_atom.cpp:87)
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_podd_atom.cpp:87)
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_pod_global.cpp:87)
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_pod_local.cpp:89)
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 8
|
||||
ghost atom cutoff = 8
|
||||
binsize = 4, bins = 1 1 1
|
||||
5 neighbor lists, perpetual/occasional/extra = 1 4 0
|
||||
(1) pair zero, perpetual
|
||||
attributes: half, newton on
|
||||
pair build: half/bin/atomonly/newton
|
||||
stencil: half/bin/3d
|
||||
bin: standard
|
||||
(2) compute pod/atom, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
(3) compute podd/atom, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
(4) compute pod/gdd, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
(5) compute pod/ldd, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
0.344594831165384
|
||||
Per MPI rank memory allocation (min/avg/max) = 6.326 | 6.326 | 6.326 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 0 0 0 0 0
|
||||
Loop time of 1.207e-06 on 1 procs for 0 steps with 16 atoms
|
||||
|
||||
165.7% CPU use with 1 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Output | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Modify | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Other | | 1.207e-06 | | |100.00
|
||||
|
||||
Nlocal: 16 ave 16 max 16 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 1984 ave 1984 max 1984 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 4311 ave 4311 max 4311 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 8623 ave 8623 max 8623 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 8623
|
||||
Ave neighs/atom = 538.9375
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
Total wall time: 0:00:00
|
||||
155
examples/PACKAGES/pod/Ta/log.22May24.pod.g++.1
Normal file
155
examples/PACKAGES/pod/Ta/log.22May24.pod.g++.1
Normal file
@ -0,0 +1,155 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-177-g86abf4f680-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD Ta potential
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 3.316
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice bcc $a
|
||||
lattice bcc 3.316
|
||||
Lattice spacing in x,y,z = 3.316 3.316 3.316
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 1 box
|
||||
Created orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
1 by 1 by 1 MPI processor grid
|
||||
create_atoms 1 box
|
||||
Created 128 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
create_atoms CPU = 0.001 seconds
|
||||
|
||||
mass 1 180.88
|
||||
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * Ta_param.pod Ta_coeff.pod Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 5 5 5
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.207 | 3.207 | 3.207 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -11.842971 0 -11.804496 -24843.054
|
||||
10 296.87227 -11.84257 0 -11.804496 -24609.859
|
||||
20 287.65971 -11.841388 0 -11.804496 -23926.722
|
||||
30 272.87511 -11.839492 0 -11.804496 -22841.672
|
||||
40 253.34724 -11.836988 0 -11.804496 -21429.268
|
||||
50 230.17169 -11.834015 0 -11.804496 -19782.77
|
||||
60 204.64408 -11.830741 0 -11.804496 -18004.755
|
||||
70 178.17888 -11.827347 0 -11.804495 -16197.482
|
||||
80 152.21769 -11.824017 0 -11.804495 -14454.425
|
||||
90 128.13189 -11.820928 0 -11.804495 -12854.075
|
||||
100 107.12666 -11.818234 0 -11.804495 -11456.437
|
||||
Loop time of 0.394952 on 1 procs for 100 steps with 128 atoms
|
||||
|
||||
Performance: 10.938 ns/day, 2.194 hours/ns, 253.196 timesteps/s, 32.409 katom-step/s
|
||||
97.4% CPU use with 1 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 0.39249 | 0.39249 | 0.39249 | 0.0 | 99.38
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.00087496 | 0.00087496 | 0.00087496 | 0.0 | 0.22
|
||||
Output | 0.00030885 | 0.00030885 | 0.00030885 | 0.0 | 0.08
|
||||
Modify | 0.00053218 | 0.00053218 | 0.00053218 | 0.0 | 0.13
|
||||
Other | | 0.0007481 | | | 0.19
|
||||
|
||||
Nlocal: 128 ave 128 max 128 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 727 ave 727 max 727 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 7424 ave 7424 max 7424 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 7424
|
||||
Ave neighs/atom = 58
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
Total wall time: 0:00:00
|
||||
155
examples/PACKAGES/pod/Ta/log.22May24.pod.g++.4
Normal file
155
examples/PACKAGES/pod/Ta/log.22May24.pod.g++.4
Normal file
@ -0,0 +1,155 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-177-g86abf4f680-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD Ta potential
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 3.316
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice bcc $a
|
||||
lattice bcc 3.316
|
||||
Lattice spacing in x,y,z = 3.316 3.316 3.316
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 1 box
|
||||
Created orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
1 by 2 by 2 MPI processor grid
|
||||
create_atoms 1 box
|
||||
Created 128 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
create_atoms CPU = 0.001 seconds
|
||||
|
||||
mass 1 180.88
|
||||
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * Ta_param.pod Ta_coeff.pod Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 5 5 5
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.187 | 3.187 | 3.187 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -11.842971 0 -11.804496 -24843.054
|
||||
10 296.87227 -11.84257 0 -11.804496 -24609.859
|
||||
20 287.65971 -11.841388 0 -11.804496 -23926.722
|
||||
30 272.87511 -11.839492 0 -11.804496 -22841.672
|
||||
40 253.34724 -11.836988 0 -11.804496 -21429.268
|
||||
50 230.17169 -11.834015 0 -11.804496 -19782.77
|
||||
60 204.64408 -11.830741 0 -11.804496 -18004.755
|
||||
70 178.17888 -11.827347 0 -11.804495 -16197.482
|
||||
80 152.21769 -11.824017 0 -11.804495 -14454.425
|
||||
90 128.13189 -11.820928 0 -11.804495 -12854.075
|
||||
100 107.12666 -11.818234 0 -11.804495 -11456.437
|
||||
Loop time of 0.153961 on 4 procs for 100 steps with 128 atoms
|
||||
|
||||
Performance: 28.059 ns/day, 0.855 hours/ns, 649.516 timesteps/s, 83.138 katom-step/s
|
||||
96.2% CPU use with 4 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 0.1281 | 0.12977 | 0.1312 | 0.3 | 84.29
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.01967 | 0.021169 | 0.022796 | 0.8 | 13.75
|
||||
Output | 0.00045049 | 0.00053796 | 0.00078459 | 0.0 | 0.35
|
||||
Modify | 0.00039544 | 0.0004393 | 0.00048043 | 0.0 | 0.29
|
||||
Other | | 0.002049 | | | 1.33
|
||||
|
||||
Nlocal: 32 ave 32 max 32 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 431 ave 431 max 431 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 1856 ave 1856 max 1856 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 7424
|
||||
Ave neighs/atom = 58
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
Total wall time: 0:00:00
|
||||
@ -1,39 +1,46 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-179-g353121c942-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate fitpod for POD potential
|
||||
|
||||
units metal
|
||||
fitpod Ta_param.pod Ta_data.pod
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 1
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 150
|
||||
total number of descriptors for all potentials: 182
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Data File ****************
|
||||
file format: extxyz
|
||||
file extension: xyz
|
||||
path to training data set: ../Ta/XYZ
|
||||
path to test data set: ../Ta/XYZ
|
||||
path to training data set: XYZ
|
||||
path to test data set: XYZ
|
||||
path to environment configuration set: XYZ
|
||||
basename for output files: Ta
|
||||
training fraction: 1
|
||||
test fraction: 1
|
||||
randomize training data set: 1
|
||||
@ -45,7 +52,8 @@ energy/force calculation for test data set: 0
|
||||
fitting weight for energy: 100
|
||||
fitting weight for force: 1
|
||||
fitting weight for stress: 0
|
||||
fitting regularization parameter: 1e-10
|
||||
save pod descriptors: 0
|
||||
compute pod descriptors: 0
|
||||
**************** End of Data File ****************
|
||||
**************** Begin of Training Data Set ****************
|
||||
---------------------------------------------------------------
|
||||
@ -74,16 +82,14 @@ maximum number of atoms: 100
|
||||
maximum number of atoms in periodic domain: 100
|
||||
maximum number of atoms in extended domain: 2700
|
||||
maximum number of neighbors in extended domain: 270000
|
||||
size of double memory: 223201
|
||||
size of int memory: 14709
|
||||
size of descriptor matrix: 182 x 182
|
||||
size of double memory: 232128
|
||||
size of descriptor matrix: 32 x 32
|
||||
**************** End of Memory Allocation ****************
|
||||
**************** Begin of Least-Squares Fitting ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
**************** End of Least-Squares Fitting ****************
|
||||
**************** Begin of Error Calculation ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
@ -94,21 +100,20 @@ Configuration: # 301
|
||||
---------------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
---------------------------------------------------------------------------------------------------
|
||||
Displaced_A15.xyz 9 576 0.000554 0.000680 0.066393 0.083014
|
||||
Displaced_BCC.xyz 9 486 0.004724 0.005103 0.108253 0.139461
|
||||
Displaced_FCC.xyz 9 432 0.001704 0.001900 0.077531 0.097471
|
||||
Elastic_BCC.xyz 100 200 0.000444 0.000446 0.000001 0.000002
|
||||
Elastic_FCC.xyz 100 400 0.000273 0.000327 0.000110 0.000163
|
||||
GSF_110.xyz 22 528 0.001852 0.002260 0.027302 0.044765
|
||||
GSF_112.xyz 22 660 0.001839 0.002404 0.051415 0.080350
|
||||
Liquid.xyz 3 300 0.000674 0.000758 0.217921 0.276109
|
||||
Surface.xyz 7 236 0.009115 0.011661 0.047949 0.105123
|
||||
Volume_A15.xyz 30 240 0.001407 0.001693 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.001497 0.002077 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.000870 0.001139 0.000000 0.000000
|
||||
Displaced_A15.xyz 9 576 0.015324 0.015365 0.140594 0.184797
|
||||
Displaced_BCC.xyz 9 486 0.009486 0.011643 0.249983 0.320375
|
||||
Displaced_FCC.xyz 9 432 0.000686 0.000880 0.091420 0.113585
|
||||
Elastic_BCC.xyz 100 200 0.003796 0.004379 0.000015 0.000020
|
||||
Elastic_FCC.xyz 100 400 0.003332 0.003372 0.000122 0.000178
|
||||
GSF_110.xyz 22 528 0.007027 0.007797 0.057637 0.115638
|
||||
GSF_112.xyz 22 660 0.010396 0.011347 0.125237 0.198553
|
||||
Liquid.xyz 3 300 0.017584 0.023822 0.504354 0.660300
|
||||
Surface.xyz 7 236 0.025511 0.034302 0.107190 0.285034
|
||||
Volume_A15.xyz 30 240 0.038624 0.048355 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.044423 0.061685 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.030062 0.041271 0.000000 0.000000
|
||||
---------------------------------------------------------------------------------------------------
|
||||
All files 363 4224 0.001053 0.002171 0.059051 0.106960
|
||||
All files 363 4224 0.012618 0.024806 0.125879 0.247229
|
||||
---------------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
|
||||
Total wall time: 0:00:00
|
||||
293
examples/PACKAGES/pod/Ta/log.24June24.pod.compute.g++.1
Normal file
293
examples/PACKAGES/pod/Ta/log.24June24.pod.compute.g++.1
Normal file
@ -0,0 +1,293 @@
|
||||
LAMMPS (17 Apr 2024 - Development - patch_17Apr2024-179-g353121c942-modified)
|
||||
OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate bispectrum computes
|
||||
|
||||
# initialize simulation
|
||||
|
||||
variable nsteps index 0
|
||||
variable nrep equal 2
|
||||
variable a equal 2.0
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 2
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 2
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 2
|
||||
|
||||
boundary p p p
|
||||
|
||||
atom_modify map hash
|
||||
lattice bcc $a
|
||||
lattice bcc 2
|
||||
Lattice spacing in x,y,z = 2 2 2
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 2 0 ${ny} 0 ${nz}
|
||||
region box block 0 2 0 2 0 ${nz}
|
||||
region box block 0 2 0 2 0 2
|
||||
create_box 2 box
|
||||
Created orthogonal box = (0 0 0) to (4 4 4)
|
||||
1 by 1 by 1 MPI processor grid
|
||||
create_atoms 2 box
|
||||
Created 16 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (4 4 4)
|
||||
create_atoms CPU = 0.001 seconds
|
||||
|
||||
mass * 180.88
|
||||
|
||||
displace_atoms all random 0.1 0.1 0.1 123456
|
||||
Displacing atoms ...
|
||||
|
||||
# set up dummy potential to satisfy cutoff
|
||||
variable rcutfac equal 6.0
|
||||
pair_style zero ${rcutfac}
|
||||
pair_style zero 6
|
||||
pair_coeff * *
|
||||
|
||||
# set up per-atom computes
|
||||
|
||||
compute ld all pod/atom Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
compute dd all podd/atom Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
|
||||
# set up compute snap generating global array
|
||||
|
||||
compute gdd all pod/global Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
#fix gdd all ave/time 1 1 1 c_gdd[*] file pod.gdd.dat mode vector
|
||||
|
||||
compute ldd all pod/local Ta_param.pod Ta_coefficients.pod Ta Ta
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
number of environment clusters: 1
|
||||
number of principal compoments: 2
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body radial basis functions: 6
|
||||
three-body radial basis functions: 5
|
||||
three-body angular degree: 4
|
||||
four-body radial basis functions: 0
|
||||
four-body angular degree: 0
|
||||
five-body radial basis functions: 0
|
||||
five-body angular degree: 0
|
||||
six-body radial basis functions: 0
|
||||
six-body angular degree: 0
|
||||
seven-body radial basis functions: 0
|
||||
seven-body angular degree: 0
|
||||
number of local descriptors per element for one-body potential: 1
|
||||
number of local descriptors per element for two-body potential: 6
|
||||
number of local descriptors per element for three-body potential: 25
|
||||
number of local descriptors per element for four-body potential: 0
|
||||
number of local descriptors per element for five-body potential: 0
|
||||
number of local descriptors per element for six-body potential: 0
|
||||
number of local descriptors per element for seven-body potential: 0
|
||||
number of local descriptors per element for all potentials: 32
|
||||
number of global descriptors: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Model Coefficients ****************
|
||||
total number of coefficients for POD potential: 32
|
||||
total number of elements for PCA projection matrix: 0
|
||||
total number of elements for PCA centroids: 0
|
||||
**************** End of Model Coefficients ****************
|
||||
|
||||
#fix ldd all ave/time 1 1 1 c_ldd[*] file pod.ldd.dat mode vector
|
||||
|
||||
#dump mydump_ld all custom 1000 dump_ld id c_ld[*]
|
||||
#dump mydump_dd all custom 1000 dump_dd id c_dd[*]
|
||||
|
||||
variable sample_ld1 equal C_ld[1][10] # Arbitrary local descriptor
|
||||
fix ldprint all print 1 "${sample_ld1}"
|
||||
|
||||
run ${nsteps}
|
||||
run 0
|
||||
WARNING: No fixes with time integration, atoms won't move (src/verlet.cpp:60)
|
||||
Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_pod_atom.cpp:87)
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_podd_atom.cpp:87)
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_pod_global.cpp:87)
|
||||
WARNING: More than one compute pod (src/ML-POD/compute_pod_local.cpp:89)
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 8
|
||||
ghost atom cutoff = 8
|
||||
binsize = 4, bins = 1 1 1
|
||||
5 neighbor lists, perpetual/occasional/extra = 1 4 0
|
||||
(1) pair zero, perpetual
|
||||
attributes: half, newton on
|
||||
pair build: half/bin/atomonly/newton
|
||||
stencil: half/bin/3d
|
||||
bin: standard
|
||||
(2) compute pod/atom, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
(3) compute podd/atom, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
(4) compute pod/global, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
(5) compute pod/local, occasional
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
0.344594831165384
|
||||
Per MPI rank memory allocation (min/avg/max) = 6.326 | 6.326 | 6.326 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 0 0 0 0 0
|
||||
Loop time of 1.23e-06 on 1 procs for 0 steps with 16 atoms
|
||||
|
||||
243.9% CPU use with 1 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Output | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Modify | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Other | | 1.23e-06 | | |100.00
|
||||
|
||||
Nlocal: 16 ave 16 max 16 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 1984 ave 1984 max 1984 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 4311 ave 4311 max 4311 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 8623 ave 8623 max 8623 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 8623
|
||||
Ave neighs/atom = 538.9375
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
Total wall time: 0:00:00
|
||||
@ -1,142 +0,0 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD Ta potential
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 3.316
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice bcc $a
|
||||
lattice bcc 3.316
|
||||
Lattice spacing in x,y,z = 3.316 3.316 3.316
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 1 box
|
||||
Created orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
1 by 1 by 1 MPI processor grid
|
||||
create_atoms 1 box
|
||||
Created 128 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
create_atoms CPU = 0.000 seconds
|
||||
|
||||
mass 1 180.88
|
||||
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * Ta_param.pod Ta_coeff.pod Ta
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 0
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 0
|
||||
total number of descriptors for all potentials: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 5 5 5
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.082 | 3.082 | 3.082 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -11.841512 0 -11.803037 -15933.622
|
||||
10 296.91721 -11.841117 0 -11.803037 -15691.904
|
||||
20 287.83555 -11.839952 0 -11.803037 -14982.977
|
||||
30 273.25574 -11.838082 0 -11.803037 -13853.44
|
||||
40 253.98821 -11.835611 0 -11.803037 -12375.459
|
||||
50 231.10664 -11.832676 0 -11.803037 -10639.774
|
||||
60 205.8844 -11.829441 0 -11.803037 -8747.2222
|
||||
70 179.71599 -11.826085 0 -11.803037 -6799.8371
|
||||
80 154.02711 -11.822791 0 -11.803037 -4892.7805
|
||||
90 130.17821 -11.819732 0 -11.803036 -3108.1226
|
||||
100 109.36842 -11.817063 0 -11.803036 -1510.9592
|
||||
Loop time of 1.51641 on 1 procs for 100 steps with 128 atoms
|
||||
|
||||
Performance: 2.849 ns/day, 8.425 hours/ns, 65.945 timesteps/s, 8.441 katom-step/s
|
||||
99.9% CPU use with 1 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 1.5158 | 1.5158 | 1.5158 | 0.0 | 99.96
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.00023616 | 0.00023616 | 0.00023616 | 0.0 | 0.02
|
||||
Output | 0.00010779 | 0.00010779 | 0.00010779 | 0.0 | 0.01
|
||||
Modify | 9.7284e-05 | 9.7284e-05 | 9.7284e-05 | 0.0 | 0.01
|
||||
Other | | 0.0001254 | | | 0.01
|
||||
|
||||
Nlocal: 128 ave 128 max 128 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 727 ave 727 max 727 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 7424 ave 7424 max 7424 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 7424
|
||||
Ave neighs/atom = 58
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
|
||||
Total wall time: 0:00:01
|
||||
@ -1,142 +0,0 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD Ta potential
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 3.316
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice bcc $a
|
||||
lattice bcc 3.316
|
||||
Lattice spacing in x,y,z = 3.316 3.316 3.316
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 1 box
|
||||
Created orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
1 by 2 by 2 MPI processor grid
|
||||
create_atoms 1 box
|
||||
Created 128 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
create_atoms CPU = 0.000 seconds
|
||||
|
||||
mass 1 180.88
|
||||
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * Ta_param.pod Ta_coeff.pod Ta
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 0
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 0
|
||||
total number of descriptors for all potentials: 32
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 5 5 5
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.062 | 3.062 | 3.062 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -11.841512 0 -11.803037 -15933.622
|
||||
10 296.91721 -11.841117 0 -11.803037 -15691.904
|
||||
20 287.83555 -11.839952 0 -11.803037 -14982.977
|
||||
30 273.25574 -11.838082 0 -11.803037 -13853.44
|
||||
40 253.98821 -11.835611 0 -11.803037 -12375.459
|
||||
50 231.10664 -11.832676 0 -11.803037 -10639.774
|
||||
60 205.8844 -11.829441 0 -11.803037 -8747.2222
|
||||
70 179.71599 -11.826085 0 -11.803037 -6799.8371
|
||||
80 154.02711 -11.822791 0 -11.803037 -4892.7805
|
||||
90 130.17821 -11.819732 0 -11.803036 -3108.1226
|
||||
100 109.36842 -11.817063 0 -11.803036 -1510.9592
|
||||
Loop time of 0.437423 on 4 procs for 100 steps with 128 atoms
|
||||
|
||||
Performance: 9.876 ns/day, 2.430 hours/ns, 228.612 timesteps/s, 29.262 katom-step/s
|
||||
98.0% CPU use with 4 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 0.41133 | 0.41882 | 0.42464 | 0.7 | 95.75
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.011279 | 0.017302 | 0.024975 | 3.7 | 3.96
|
||||
Output | 0.00012956 | 0.00029493 | 0.00077991 | 0.0 | 0.07
|
||||
Modify | 4.2093e-05 | 4.7838e-05 | 5.3039e-05 | 0.0 | 0.01
|
||||
Other | | 0.0009598 | | | 0.22
|
||||
|
||||
Nlocal: 32 ave 32 max 32 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 431 ave 431 max 431 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 1856 ave 1856 max 1856 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 7424
|
||||
Ave neighs/atom = 58
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
|
||||
Total wall time: 0:00:00
|
||||
@ -1,183 +0,0 @@
|
||||
POD_coefficients: 182
|
||||
-4.35182
|
||||
3.57837
|
||||
2.25497
|
||||
4.84612
|
||||
-2.06319
|
||||
-1.17070
|
||||
-0.23842
|
||||
9.17160
|
||||
36.02366
|
||||
16.65304
|
||||
-141.18403
|
||||
37.17722
|
||||
0.46028
|
||||
-9.76148
|
||||
-0.03681
|
||||
15.64520
|
||||
2.29791
|
||||
0.02143
|
||||
2.69735
|
||||
-0.35336
|
||||
0.51108
|
||||
-2.36290
|
||||
0.18617
|
||||
-0.13079
|
||||
1.02666
|
||||
0.21514
|
||||
0.08075
|
||||
-0.28347
|
||||
-0.45059
|
||||
-0.24762
|
||||
-1.13671
|
||||
-0.30577
|
||||
0.60504
|
||||
0.31285
|
||||
-0.10639
|
||||
-0.06957
|
||||
0.21961
|
||||
-0.10426
|
||||
0.80318
|
||||
-11.41460
|
||||
-10.26102
|
||||
-0.03887
|
||||
-18.86071
|
||||
-4.47372
|
||||
-1.76858
|
||||
-0.92503
|
||||
0.42654
|
||||
0.35849
|
||||
0.56611
|
||||
-0.79354
|
||||
5.65136
|
||||
8.75283
|
||||
-6.22283
|
||||
-4.34623
|
||||
10.20031
|
||||
6.53360
|
||||
7.16688
|
||||
2.19236
|
||||
5.90789
|
||||
3.52173
|
||||
7.97264
|
||||
0.21104
|
||||
-0.01015
|
||||
0.01023
|
||||
0.03088
|
||||
0.10222
|
||||
0.05366
|
||||
-0.08037
|
||||
-3.17612
|
||||
-3.45669
|
||||
-0.79282
|
||||
-2.38323
|
||||
-0.69797
|
||||
-1.44780
|
||||
-0.03351
|
||||
-0.05645
|
||||
0.01901
|
||||
-0.01923
|
||||
0.05401
|
||||
-0.02095
|
||||
1.45651
|
||||
1.58812
|
||||
1.41188
|
||||
2.18122
|
||||
3.04893
|
||||
1.09294
|
||||
3.03781
|
||||
1.07249
|
||||
0.50262
|
||||
0.81150
|
||||
0.35997
|
||||
0.64602
|
||||
-0.04245
|
||||
0.00113
|
||||
-0.02894
|
||||
0.04382
|
||||
-0.06556
|
||||
0.00052
|
||||
4.67541
|
||||
0.11812
|
||||
1.52428
|
||||
-0.17075
|
||||
0.20231
|
||||
0.36857
|
||||
0.61744
|
||||
0.20190
|
||||
-0.00816
|
||||
0.16194
|
||||
-0.12948
|
||||
-0.02136
|
||||
-2.19271
|
||||
0.62510
|
||||
0.20030
|
||||
-0.27621
|
||||
-0.58116
|
||||
-0.21792
|
||||
-1.82295
|
||||
-0.32166
|
||||
-0.64550
|
||||
-0.11580
|
||||
-0.02438
|
||||
-0.08057
|
||||
0.19538
|
||||
0.04119
|
||||
0.00323
|
||||
0.06530
|
||||
-0.02547
|
||||
-0.01404
|
||||
0.22336
|
||||
-0.48191
|
||||
-0.10715
|
||||
-0.25685
|
||||
-0.65069
|
||||
-0.31428
|
||||
-0.06947
|
||||
0.11924
|
||||
0.05467
|
||||
0.12105
|
||||
-0.03980
|
||||
-0.00295
|
||||
-2.14413
|
||||
0.82345
|
||||
0.23083
|
||||
-0.24925
|
||||
-0.36678
|
||||
-0.16709
|
||||
1.20410
|
||||
-0.47756
|
||||
-0.11104
|
||||
0.09587
|
||||
0.03722
|
||||
0.00309
|
||||
-0.29879
|
||||
-0.06463
|
||||
-0.10236
|
||||
-0.02276
|
||||
-0.06012
|
||||
-0.02985
|
||||
12.06876
|
||||
-3.39995
|
||||
0.85590
|
||||
-0.77481
|
||||
-1.13392
|
||||
-0.40511
|
||||
-0.08005
|
||||
-0.07162
|
||||
-0.05978
|
||||
-0.02407
|
||||
-0.06031
|
||||
-0.02307
|
||||
-10.24105
|
||||
2.49356
|
||||
-1.14052
|
||||
0.70453
|
||||
0.99988
|
||||
0.33862
|
||||
2.43469
|
||||
-1.16557
|
||||
-0.23708
|
||||
0.03482
|
||||
-0.05280
|
||||
-0.02735
|
||||
@ -1,33 +0,0 @@
|
||||
# DATE: 2022-11-30 UNITS: metal CONTRIBUTOR: Ngoc Cuong Nguyen, exapde@gmail.com CITATION: https://arxiv.org/abs/2209.02362
|
||||
# chemical element symbols
|
||||
species Ta
|
||||
|
||||
# periodic boundary conditions
|
||||
pbc 1 1 1
|
||||
|
||||
# inner cut-off radius
|
||||
rin 1.0
|
||||
|
||||
# outer cut-off radius
|
||||
rcut 5.0
|
||||
|
||||
# polynomial degrees for radial basis functions
|
||||
bessel_polynomial_degree 3
|
||||
inverse_polynomial_degree 6
|
||||
|
||||
# one-body potential
|
||||
onebody 1
|
||||
|
||||
# two-body linear POD potential
|
||||
twobody_number_radial_basis_functions 6
|
||||
|
||||
# three-body linear POD potential
|
||||
threebody_number_radial_basis_functions 5
|
||||
threebody_number_angular_basis_functions 5
|
||||
|
||||
# four-body linear SNAP potential
|
||||
fourbody_snap_twojmax 0
|
||||
|
||||
# quadratic POD potential
|
||||
quadratic_pod_potential 1
|
||||
|
||||
@ -1,387 +0,0 @@
|
||||
# Displaced_A15.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
1 64 -754.2481469 -754.220443 0.0004328739544 8.011514562 8.398670477 0.06376624845
|
||||
2 64 -753.8045629 -753.865255 0.0009483144042 9.036674821 9.134430545 0.07283326238
|
||||
3 64 -754.1013214 -754.0221 0.001237834258 8.637024088 9.017261102 0.06364800593
|
||||
4 64 -754.2847414 -754.279613 8.013173542e-05 8.107730622 8.381725092 0.06510174353
|
||||
5 64 -753.8382044 -753.777209 0.0009530527364 9.104258904 9.478314477 0.07200164536
|
||||
6 64 -754.0793448 -754.048643 0.0004797149286 8.152198894 8.465317938 0.06707941365
|
||||
7 64 -754.3310528 -754.317603 0.0002101531052 7.9440922 8.127690491 0.05987172107
|
||||
8 64 -754.0070856 -753.969161 0.0005925720361 9.179443805 9.425464952 0.06695320222
|
||||
9 64 -754.1450602 -754.141988 4.800358611e-05 8.574170786 8.821346913 0.06628506232
|
||||
# Displaced_BCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
10 54 -630.8081935 -631.019667 0.003916175555 15.97497534 16.625876 0.1021118679
|
||||
11 54 -631.4580134 -631.719595 0.004844103559 15.24068949 15.58666626 0.1043856792
|
||||
12 54 -631.1667566 -631.386255 0.004064785931 15.46091788 15.92378883 0.1062824093
|
||||
13 54 -632.3004944 -632.575826 0.005098733346 14.4261974 14.55977162 0.0983914465
|
||||
14 54 -630.089475 -630.450212 0.006680315456 16.78432947 16.96340726 0.1085102316
|
||||
15 54 -631.3402507 -631.669379 0.006094968558 15.8289421 16.05757315 0.1000888617
|
||||
16 54 -632.0447348 -632.431277 0.007158189539 14.73098416 14.69810718 0.09621569386
|
||||
17 54 -630.7186536 -630.960068 0.004470636457 15.62236511 15.99073148 0.1063789621
|
||||
18 54 -623.3884977 -623.378198 0.0001907343232 23.9739298 24.67640432 0.1519105596
|
||||
# Displaced_FCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
19 48 -556.0112403 -555.899463 0.002328692864 5.300795546 6.084617063 0.07215982294
|
||||
20 48 -555.9884377 -555.922478 0.001374159425 5.509767245 6.297071211 0.08438730171
|
||||
21 48 -555.8765558 -555.800269 0.001589309295 5.420812146 6.021098636 0.07404418561
|
||||
22 48 -556.2511475 -556.196151 0.001145760427 4.541854917 5.127955094 0.06609455537
|
||||
23 48 -555.6590668 -555.488929 0.003544536845 6.087063152 7.050223459 0.09107542897
|
||||
24 48 -556.1020655 -556.027926 0.001544573067 5.048523277 5.611881174 0.06751584111
|
||||
25 48 -556.0607474 -555.968399 0.001923924855 5.209756732 5.979217189 0.08024047849
|
||||
26 48 -556.0598015 -556.047132 0.0002639485133 4.995519804 5.544452585 0.07745361595
|
||||
27 48 -555.8256424 -555.747848 0.00162071731 5.762702675 6.47892568 0.08480576837
|
||||
# Elastic_BCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
28 2 -23.69025375 -23.689367 0.0004433751768 0.0006229111456 0.0006222748589 9.850534294e-07
|
||||
29 2 -23.690768 -23.689888 0.0004399996606 0.0006181832344 0.0006166052222 1.005063831e-06
|
||||
30 2 -23.69082186 -23.689996 0.0004129292199 0.0008798076914 0.0008810425642 1.748431771e-06
|
||||
31 2 -23.69166748 -23.690957 0.0003552395228 1.000599546e-06 0 4.011214433e-07
|
||||
32 2 -23.69137648 -23.690521 0.0004277406839 0.0005992884516 0.0005982273815 7.219402767e-07
|
||||
33 2 -23.69120607 -23.69038 0.000413036746 0.000594795449 0.0005925723585 9.949794864e-07
|
||||
34 2 -23.6900782 -23.689202 0.000438099978 0.0006263336007 0.0006279363025 1.111474332e-06
|
||||
35 2 -23.69121642 -23.690482 0.0003672088475 0.00086350893 0.0008640138888 1.400551425e-06
|
||||
36 2 -23.69074792 -23.689902 0.0004229601404 0.0006176589245 0.0006152154094 9.894995842e-07
|
||||
37 2 -23.6914111 -23.690563 0.0004240514006 0.0006052368582 0.0006038725031 4.148713688e-07
|
||||
38 2 -23.69095105 -23.690207 0.0003720253444 0.001071999394 0.00107369735 7.195087511e-07
|
||||
39 2 -23.69007856 -23.689285 0.0003967806815 0.0008875291033 0.000890013483 1.187797446e-06
|
||||
40 2 -23.69061639 -23.689768 0.0004241940528 0.00107874486 0.001080249045 1.09850755e-06
|
||||
41 2 -23.69064479 -23.68968 0.0004823957182 0.0008702114429 0.0008680034562 8.482668094e-07
|
||||
42 2 -23.6910243 -23.690074 0.0004751495365 0.001368926593 0.001373818765 2.351835771e-06
|
||||
43 2 -23.68910107 -23.688108 0.0004965341502 0.0006334704764 0.0006336134468 5.990110163e-07
|
||||
44 2 -23.69003986 -23.689241 0.0003994287496 0.0008886654529 0.0008880101351 1.319380731e-06
|
||||
45 2 -23.69042994 -23.68952 0.0004549677771 0.0008868888968 0.0008860011287 4.688590432e-07
|
||||
46 2 -23.68738487 -23.686278 0.0005534329248 0.0006426681164 0.0006406777661 9.718938063e-07
|
||||
47 2 -23.69095089 -23.690097 0.0004269463837 0.0008409065407 0.0008410160522 1.331153983e-06
|
||||
48 2 -23.69158161 -23.690811 0.0003853032969 0.0008464480591 0.0008500070588 1.611890257e-06
|
||||
49 2 -23.69114597 -23.690266 0.0004399838162 0.001039354626 0.001044322747 3.354760892e-06
|
||||
50 2 -23.6914223 -23.690597 0.0004126524984 0.001045529019 0.001050833003 2.164890519e-06
|
||||
51 2 -23.69157045 -23.690673 0.000448723371 0.0006045419676 0.0006038907186 7.138092253e-07
|
||||
52 2 -23.69135377 -23.690551 0.0004013838132 0.0008554941993 0.0008590064028 1.199818147e-06
|
||||
53 2 -23.6914855 -23.690693 0.0003962481391 0.0008561040807 0.0008590110593 1.062310127e-06
|
||||
54 2 -23.69110782 -23.69021 0.0004489100066 0.0008699576152 0.0008730051546 1.100920756e-06
|
||||
55 2 -23.68987142 -23.688943 0.0004642105928 0.0008789741194 0.0008800306813 8.92018913e-07
|
||||
56 2 -23.69108099 -23.690136 0.0004724937378 0.0005971006713 0.000593996633 9.809423198e-07
|
||||
57 2 -23.6884849 -23.687444 0.0005204491042 0.000904649919 0.000903059245 1.159812589e-06
|
||||
58 2 -23.69061659 -23.689801 0.0004077963743 0.0008734822906 0.0008740011442 2.825876968e-07
|
||||
59 2 -23.69129673 -23.690408 0.0004443659273 8.294238722e-07 0 3.094976672e-07
|
||||
60 2 -23.69128183 -23.690362 0.0004599146039 0.0006083806397 0.0006067503605 7.610598464e-07
|
||||
61 2 -23.68992958 -23.688881 0.0005242884644 0.000821029922 0.0008250054545 1.71686782e-06
|
||||
62 2 -23.6913441 -23.690515 0.0004145518648 0.001475621399 0.001475779794 2.84677577e-06
|
||||
63 2 -23.69141171 -23.690551 0.0004303564504 0.0005957866015 0.0005996599036 1.20514709e-06
|
||||
64 2 -23.69029628 -23.689487 0.0004046403158 0.0006212225944 0.0006194384554 9.873937532e-07
|
||||
65 2 -23.69072139 -23.68986 0.0004306945962 0.0008858828979 0.0008860124153 5.860284088e-07
|
||||
66 2 -23.69018379 -23.689288 0.0004478949008 0.001400963016 0.001396479144 1.244329984e-06
|
||||
67 2 -23.69129611 -23.690457 0.0004195546182 0.0005914019669 0.0005939831647 1.147186262e-06
|
||||
68 2 -23.69084551 -23.689792 0.0005267528672 0.0008274902414 0.0008340587509 2.923475453e-06
|
||||
69 2 -23.69101454 -23.690006 0.0005042723904 0.0005874526839 0.0005897694465 1.183912924e-06
|
||||
70 2 -23.69137638 -23.690571 0.000402691994 0.0005935054979 0.0005939781141 8.884918862e-07
|
||||
71 2 -23.69114123 -23.690213 0.0004641143201 0.001085937193 0.001084315452 6.623820068e-07
|
||||
72 2 -23.69146017 -23.690617 0.0004215869658 0.0005980165481 0.0006024682564 1.268404944e-06
|
||||
73 2 -23.69063494 -23.689761 0.0004369696294 0.0008787872001 0.0008790688255 2.274049375e-06
|
||||
74 2 -23.69116059 -23.69027 0.0004452958397 6.913233052e-07 0 2.060281613e-07
|
||||
75 2 -23.69134793 -23.690599 0.0003744660576 0.0006108390866 0.0006137752031 6.96527736e-07
|
||||
76 2 -23.69149586 -23.69061 0.0004429283645 9.198413091e-07 0 3.754401369e-07
|
||||
77 2 -23.69139951 -23.690603 0.0003982565418 0.0008543320292 0.0008590331775 1.578633627e-06
|
||||
78 2 -23.68884519 -23.687908 0.0004685934904 0.0009053957054 0.0009010105438 1.657834627e-06
|
||||
79 2 -23.69142551 -23.690688 0.0003687527847 0.0008461959647 0.0008470064935 1.246502358e-06
|
||||
80 2 -23.69088798 -23.689988 0.0004499883039 0.0006191457459 0.0006194465272 7.974697206e-07
|
||||
81 2 -23.69054504 -23.689613 0.0004660181693 0.0008740608763 0.0008740732235 7.595219281e-07
|
||||
82 2 -23.69150291 -23.690678 0.0004124547512 0.000610815565 0.0006123757017 8.071847352e-07
|
||||
83 2 -23.69107508 -23.69017 0.0004525405781 0.0008712164372 0.0008750051428 1.391960695e-06
|
||||
84 2 -23.68888774 -23.687892 0.0004978720826 0.001115255323 0.001112070142 1.300271383e-06
|
||||
85 2 -23.69100617 -23.690132 0.0004370853773 0.0008623539978 0.000868018433 1.989797184e-06
|
||||
86 2 -23.69156961 -23.690843 0.0003633026522 0.0006034844173 0.0006081134763 1.367563513e-06
|
||||
87 2 -23.6914135 -23.690598 0.0004077495027 0.001205622469 0.001217674833 4.139579599e-06
|
||||
88 2 -23.69152569 -23.690656 0.0004348453461 0.0005982210923 0.0006024765556 1.339909066e-06
|
||||
89 2 -23.69122964 -23.690254 0.00048782182 0.001039614512 0.001043496047 2.818899799e-06
|
||||
90 2 -23.69160573 -23.690694 0.0004558641588 0.0006005238032 0.0006010740387 4.468144277e-07
|
||||
91 2 -23.69097667 -23.690097 0.0004398327929 0.0008742196236 0.0008730234819 9.401054078e-07
|
||||
92 2 -23.68931978 -23.688402 0.000458891277 0.0006323492378 0.000632180354 2.788895255e-07
|
||||
93 2 -23.68957636 -23.688669 0.0004536814608 0.001093068336 0.001092474256 1.597403354e-06
|
||||
94 2 -23.69136079 -23.690538 0.0004113951269 0.0008559692215 0.0008610145179 1.717480332e-06
|
||||
95 2 -23.69064046 -23.689722 0.0004592296819 0.0006203235661 0.0006251287867 1.466428815e-06
|
||||
96 2 -23.69148677 -23.690581 0.0004528827615 7.127210559e-07 0 2.255863159e-07
|
||||
97 2 -23.68967251 -23.688755 0.0004587561741 0.0006269092047 0.0006251143895 8.456044924e-07
|
||||
98 2 -23.69038245 -23.689312 0.0005352258985 0.0008260738577 0.0008290597083 1.434578094e-06
|
||||
99 2 -23.6885155 -23.687388 0.000563750435 0.001127068066 0.001120237475 2.790106364e-06
|
||||
100 2 -23.69147138 -23.690664 0.0004036883861 0.0006101343713 0.0006109402589 2.333308226e-07
|
||||
101 2 -23.69059185 -23.68941 0.0005909264985 0.0005851627979 0.0005883553348 1.578359791e-06
|
||||
102 2 -23.69082355 -23.690035 0.0003942730081 0.0008795919888 0.0008810062429 8.322915827e-07
|
||||
103 2 -23.69101815 -23.690015 0.0005015766298 0.0008420116739 0.0008450195264 1.339928081e-06
|
||||
104 2 -23.6915919 -23.690752 0.0004199497676 0.0005974770628 0.0005996415596 9.70808844e-07
|
||||
105 2 -23.69060481 -23.689825 0.0003899065755 0.0008774617579 0.0008800215906 1.681761199e-06
|
||||
106 2 -23.69149834 -23.690562 0.0004681676 0.0008527074936 0.0008560011682 1.11226924e-06
|
||||
107 2 -23.69145561 -23.690622 0.0004168050595 0.0008363624298 0.0008390017878 8.930611273e-07
|
||||
108 2 -23.68965306 -23.688764 0.0004445297309 0.0008936263738 0.0008910185183 1.309339573e-06
|
||||
109 2 -23.69077552 -23.690011 0.0003822592712 0.0006203793746 0.0006194287691 3.133550229e-07
|
||||
110 2 -23.68867102 -23.687696 0.0004875100015 0.001086068328 0.001087589996 1.327020171e-06
|
||||
111 2 -23.69172933 -23.691019 0.0003551646935 0.000852013148 0.0008540035129 9.847230007e-07
|
||||
112 2 -23.68991099 -23.689025 0.000442996005 6.46227386e-07 0 2.557212911e-07
|
||||
113 2 -23.69080506 -23.689952 0.0004265318142 7.012777671e-07 0 2.758977769e-07
|
||||
114 2 -23.69152793 -23.69061 0.0004589654148 0.0008542966264 0.0008580011655 1.338482046e-06
|
||||
115 2 -23.69153556 -23.690595 0.0004702783823 0.000867974804 0.0008680069124 6.687384672e-07
|
||||
116 2 -23.69117399 -23.690231 0.000471493636 0.0005924023762 0.0005925892338 1.259776007e-07
|
||||
117 2 -23.69139497 -23.690469 0.0004629856458 0.0008486906688 0.0008500294113 6.344879116e-07
|
||||
118 2 -23.69122801 -23.690482 0.0003730070077 0.0008734801582 0.0008740102974 2.172190141e-07
|
||||
119 2 -23.69055118 -23.689613 0.0004690919274 0.0008237358825 0.0008320192305 2.927942421e-06
|
||||
120 2 -23.68847553 -23.687426 0.0005247657372 0.001093739709 0.00109577735 8.307823424e-07
|
||||
121 2 -23.69041353 -23.689562 0.000425762889 0.0006210724415 0.0006265237426 1.574752432e-06
|
||||
122 2 -23.69137916 -23.6904 0.0004895814578 3.712921801e-07 0 1.509058252e-07
|
||||
123 2 -23.69152029 -23.690561 0.0004796427403 0.0005964911748 0.0005982273815 1.201511775e-06
|
||||
124 2 -23.69012377 -23.689107 0.0005083837539 0.0008124995989 0.0008180073349 1.97846325e-06
|
||||
125 2 -23.69112303 -23.690145 0.000489014125 0.0008742245309 0.0008740766557 1.981010569e-06
|
||||
126 2 -23.6913827 -23.690482 0.00045035056 0.0005944563316 0.0005939983165 2.227151791e-07
|
||||
127 2 -23.69071568 -23.689864 0.0004258388591 0.0008855411376 0.0008860124153 7.974985004e-07
|
||||
# Elastic_FCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
128 4 -46.43709855 -46.437936 0.0002093617328 0.0008950059332 0.001265949446 0.0001464529791
|
||||
129 4 -46.4407039 -46.438504 0.0005499744469 0.0009975948265 0.001492549497 0.0001384062515
|
||||
130 4 -46.43497365 -46.436378 0.0003510867184 0.0005521282525 0.000810592376 9.989141969e-05
|
||||
131 4 -46.44077415 -46.441551 0.0001942123898 0.001132197907 0.001283675193 6.296966657e-05
|
||||
132 4 -46.41517164 -46.416957 0.0004463408133 0.000917990147 0.001186145859 8.226324971e-05
|
||||
133 4 -46.43849879 -46.440495 0.0004990529713 0.001000780113 0.001212440514 6.935590465e-05
|
||||
134 4 -46.43777706 -46.437972 4.873595839e-05 0.001389269665 0.002358226452 0.0002414827518
|
||||
135 4 -46.44772061 -46.44586 0.0004651524929 0.00136379307 0.002033949852 0.0001874009366
|
||||
136 4 -46.43566097 -46.435744 2.075858871e-05 0.0009531675039 0.001690849491 0.0002499304712
|
||||
137 4 -46.4397151 -46.438209 0.0003765248409 0.0008871611703 0.001160049999 6.827992039e-05
|
||||
138 4 -46.42609455 -46.42629 4.886349894e-05 0.0005556350766 0.0005297018029 1.21651498e-05
|
||||
139 4 -46.44149051 -46.443301 0.0004526223375 0.001132510738 0.001818421568 0.0001734412988
|
||||
140 4 -46.43896893 -46.439002 8.267473937e-06 0.001179879164 0.001416973535 6.937478941e-05
|
||||
141 4 -46.43123555 -46.432438 0.0003006112875 0.001147766739 0.001010469198 6.008540236e-05
|
||||
142 4 -46.41017485 -46.412654 0.0006197883649 0.001371501311 0.001801959766 0.0001610014112
|
||||
143 4 -46.44246774 -46.443231 0.0001908144167 0.0008879088126 0.001691590967 0.0001867981938
|
||||
144 4 -46.43057135 -46.431513 0.0002354128564 0.001455115574 0.001680544852 7.970584502e-05
|
||||
145 4 -46.43314849 -46.435608 0.0006148766383 0.000895665005 0.0009593039143 1.661569891e-05
|
||||
146 4 -46.43895751 -46.437689 0.0003171270659 0.001001644887 0.001217708504 8.864745791e-05
|
||||
147 4 -46.4271122 -46.428447 0.0003336990143 0.001053852574 0.002060081552 0.0002791878204
|
||||
148 4 -46.43182739 -46.432255 0.000106902789 0.0007125255966 0.0006274201144 7.371627608e-05
|
||||
149 4 -46.44177161 -46.442315 0.0001358463057 0.001140463867 0.002424436842 0.0003371037421
|
||||
150 4 -46.43717254 -46.436613 0.000139884251 0.0005515470124 0.0005321240457 4.25980675e-05
|
||||
151 4 -46.43004027 -46.430825 0.0001961823592 0.001008902912 0.001399987143 0.0001075255834
|
||||
152 4 -46.43208405 -46.43312 0.0002589881882 0.0005518528033 0.0007272771136 5.274203147e-05
|
||||
153 4 -46.43371444 -46.434347 0.000158140244 0.0008969169177 0.001284451634 0.000116451331
|
||||
154 4 -46.42879982 -46.430573 0.0004432948912 0.0009069765322 0.001315746176 0.0001014266222
|
||||
155 4 -46.44729799 -46.445665 0.0004082485341 0.001210137892 0.00180789159 0.0001638465464
|
||||
156 4 -46.43544342 -46.435898 0.0001136447769 0.0008978231434 0.001869300939 0.0002335504461
|
||||
157 4 -46.44021163 -46.442107 0.0004738424917 0.0007064270827 0.0006020930161 3.471655618e-05
|
||||
158 4 -46.43498956 -46.434432 0.0001393896227 0.0009533481605 0.001092982159 7.242855265e-05
|
||||
159 4 -46.43803608 -46.436308 0.0004320210529 0.001263659168 0.001839150891 0.0001727461868
|
||||
160 4 -46.42268734 -46.423938 0.0003126642441 0.001014412719 0.001463463016 0.0001717552709
|
||||
161 4 -46.42662921 -46.428115 0.0003714482928 0.0007136207063 0.0008584497656 6.405723837e-05
|
||||
162 4 -46.42531434 -46.4269 0.0003964160099 0.001206355349 0.001845719914 0.0002046485876
|
||||
163 4 -46.42224822 -46.421142 0.00027655517 0.001156356408 0.001309150106 4.994079618e-05
|
||||
164 4 -46.4302643 -46.432233 0.0004921743842 0.0007882966199 0.0007253109678 2.466489974e-05
|
||||
165 4 -46.43017473 -46.429408 0.0001916835518 0.000899021915 0.001068327665 6.208651635e-05
|
||||
166 4 -46.44541887 -46.445145 6.846642975e-05 0.001028604344 0.001776038288 0.0001975509563
|
||||
167 4 -46.43410132 -46.435868 0.0004416698523 0.00126629641 0.002376074704 0.0003279007933
|
||||
168 4 -46.43919494 -46.439663 0.0001170158831 0.0005441672792 0.001119403413 0.0001039537827
|
||||
169 4 -46.42584101 -46.428287 0.0006114968909 0.001286554794 0.001277000392 3.606396056e-05
|
||||
170 4 -46.42254993 -46.424584 0.000508517271 0.0007166928246 0.0008032957114 3.058246984e-05
|
||||
171 4 -46.41053526 -46.413045 0.0006274344802 0.001077488731 0.001248322074 4.395073797e-05
|
||||
172 4 -46.43440112 -46.436994 0.0006482191497 0.0009567631962 0.001331939188 0.0001491134491
|
||||
173 4 -46.44377744 -46.443604 4.335911262e-05 0.0009956173287 0.001177046303 8.761456142e-05
|
||||
174 4 -46.44028269 -46.439718 0.0001411716593 9.067044161e-07 0 2.475504855e-07
|
||||
175 4 -46.43723548 -46.435527 0.0004271206705 0.001133620344 0.0009338393866 8.014312499e-05
|
||||
176 4 -46.43396161 -46.434787 0.0002063465503 0.001150111339 0.00117329195 4.934565354e-05
|
||||
177 4 -46.43612253 -46.434929 0.0002983823621 0.001267526966 0.001349491756 5.093502218e-05
|
||||
178 4 -46.42638491 -46.426499 2.852244117e-05 0.001164859691 0.001248937949 4.347949244e-05
|
||||
179 4 -46.43717201 -46.437025 3.675245971e-05 0.0007725496777 0.000938418883 6.831038049e-05
|
||||
180 4 -46.4281895 -46.428937 0.0001868757356 0.001151243959 0.001286352984 4.994282406e-05
|
||||
181 4 -46.44116364 -46.442516 0.0003380892793 0.0007032387465 0.00094855469 0.0001088604201
|
||||
182 4 -46.42978258 -46.428736 0.0002616440103 0.001009629916 0.001424321593 0.0001089615662
|
||||
183 4 -46.43305551 -46.433359 7.587361447e-05 0.001156682853 0.001276381604 4.128766832e-05
|
||||
184 4 -46.44006475 -46.438799 0.0003164382753 0.0007752996065 0.0008186940821 3.548756745e-05
|
||||
185 4 -46.44169053 -46.441993 7.561864672e-05 0.0008970969052 0.001887735151 0.0002223397932
|
||||
186 4 -46.43727222 -46.439033 0.0004401954936 0.0007708721088 0.000821568013 4.107007018e-05
|
||||
187 4 -46.43632517 -46.436967 0.0001604574289 0.001052390296 0.001482323514 0.0001388091482
|
||||
188 4 -46.42718259 -46.427245 1.560352526e-05 0.001072419721 0.001293885621 7.709435507e-05
|
||||
189 4 -46.43874841 -46.438046 0.0001756024201 0.001260671216 0.001627288542 0.0001002074435
|
||||
190 4 -46.41877429 -46.420083 0.0003271768634 0.00142160315 0.002395244873 0.0003233098312
|
||||
191 4 -46.44621445 -46.445247 0.0002418615665 0.0009904374428 0.001219330964 5.687306262e-05
|
||||
192 4 -46.44511464 -46.446044 0.0002323410927 0.0008790838348 0.001305329077 0.0001107509197
|
||||
193 4 -46.43564394 -46.434472 0.0002929851777 0.000890378693 0.0008323340675 4.743679034e-05
|
||||
194 4 -46.44317175 -46.44458 0.0003520619573 0.0007034014662 0.0009744208536 5.172015881e-05
|
||||
195 4 -46.44087095 -46.441776 0.0002262624122 0.00113922313 0.001339231869 8.765052415e-05
|
||||
196 4 -46.43719326 -46.436389 0.0002010659177 0.001277508928 0.001786741168 0.0001303767454
|
||||
197 4 -46.44563996 -46.446416 0.0001940097871 0.0007007387602 0.0006588778339 5.645487424e-05
|
||||
198 4 -46.44980864 -46.449806 6.606823266e-07 0.001232826529 0.002135055034 0.0002384857832
|
||||
199 4 -46.42466674 -46.427189 0.0006305654832 0.001011828255 0.001050788276 2.797047454e-05
|
||||
200 4 -46.42588993 -46.427857 0.000491766418 0.001010915484 0.001487666629 0.0001398462887
|
||||
201 4 -46.44273693 -46.44004 0.0006742317456 0.0007050795233 0.000757202747 2.506458135e-05
|
||||
202 4 -46.43659247 -46.437214 0.0001553829854 0.0008924045914 0.001505586265 0.0001475571029
|
||||
203 4 -46.42189527 -46.422628 0.0001831835233 0.0009120248848 0.001601713458 0.0002207350143
|
||||
204 4 -46.44387014 -46.443535 8.378431277e-05 0.001253187495 0.001590304373 0.0001006147174
|
||||
205 4 -46.4386991 -46.439922 0.0003057254875 0.001138308324 0.001530493385 0.0001018467819
|
||||
206 4 -46.43732669 -46.437675 8.707637653e-05 0.00144833639 0.002440246094 0.0003149341193
|
||||
207 4 -46.44459348 -46.445558 0.0002411303465 0.0008716893522 0.00113392416 7.56134454e-05
|
||||
208 4 -46.43888136 -46.439106 5.615896373e-05 0.001259801268 0.001830731002 0.0001709222499
|
||||
209 4 -46.44452218 -46.443073 0.000362294488 0.0005355233492 0.0005766870902 1.79131844e-05
|
||||
210 4 -46.44072829 -46.4397 0.0002570727366 0.0008912594074 0.001204174406 7.190949652e-05
|
||||
211 4 -46.43632905 -46.436374 1.123701302e-05 0.00100454144 0.001461656594 0.0001640759619
|
||||
212 4 -46.42622449 -46.426557 8.312836801e-05 0.0009090508417 0.001359624213 9.618645017e-05
|
||||
213 4 -46.43334095 -46.434009 0.0001670117853 0.001064727099 0.001391131194 0.0001118380718
|
||||
214 4 -46.43528491 -46.436262 0.0002442735765 0.001381671175 0.002503347159 0.0002862586192
|
||||
215 4 -46.43302209 -46.434505 0.0003707286996 0.001050895795 0.001041637173 1.894959196e-05
|
||||
216 4 -46.43866543 -46.438768 2.564354619e-05 0.001038218613 0.001098285027 4.514351427e-05
|
||||
217 4 -46.43867092 -46.440254 0.000395771139 0.0005510961745 0.0006069892915 4.783705107e-05
|
||||
218 4 -46.42481603 -46.42286 0.0004890086715 0.0005673661918 0.0007365242698 6.506184883e-05
|
||||
219 4 -46.41707211 -46.418078 0.0002514715464 0.001292943265 0.002028412187 0.0002017017408
|
||||
220 4 -46.44058128 -46.440513 1.706961588e-05 0.0008917162415 0.001158189967 9.459271337e-05
|
||||
221 4 -46.40786735 -46.409824 0.000489161666 0.000915995593 0.001759573812 0.0002027400318
|
||||
222 4 -46.44176165 -46.440329 0.0003581615225 0.0007050784001 0.0009534044263 7.330945846e-05
|
||||
223 4 -46.43764613 -46.43773 2.096761683e-05 0.000774718051 0.000926180328 6.358620287e-05
|
||||
224 4 -46.41646676 -46.416525 1.456068592e-05 0.0007183862165 0.0007573664899 3.367541267e-05
|
||||
225 4 -46.44086814 -46.440293 0.0001437843048 0.0008909024924 0.0007725386722 2.803785114e-05
|
||||
226 4 -46.44027213 -46.43839 0.0004705337314 0.000707862011 0.0005612022808 3.305821092e-05
|
||||
227 4 -46.44117428 -46.438916 0.0005645706045 0.0008843758872 0.001650878554 0.0001728226219
|
||||
# GSF_110.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
228 24 -278.9717069 -279.068761 0.004043919984 1.716820818 1.756353161 0.02195804808
|
||||
229 24 -279.8354387 -279.784296 0.002130947227 0.8360148085 0.9057668891 0.02306494198
|
||||
230 24 -279.920921 -279.901657 0.0008026661363 0.2958425997 0.001565946359 0.01411644584
|
||||
231 24 -279.6113309 -279.584238 0.001128870276 1.136927478 1.035572248 0.0268109436
|
||||
232 24 -279.8354404 -279.784283 0.002131557004 0.8360112083 0.9056396189 0.02305363685
|
||||
233 24 -279.302435 -279.302158 1.154096848e-05 1.736732738 1.771965137 0.03376130194
|
||||
234 24 -279.5958843 -279.55564 0.001676844981 1.457718936 1.405626506 0.02601748107
|
||||
235 24 -279.1575825 -279.246939 0.003723187357 0.7701803397 0.4813964151 0.04047323625
|
||||
236 24 -279.3024375 -279.302157 1.168852836e-05 1.736736025 1.771953347 0.03376039536
|
||||
237 24 -279.1575946 -279.246935 0.003722518226 0.7692677843 0.4809484798 0.04044520421
|
||||
238 24 -279.9208868 -279.896025 0.001035907873 0.2963184571 0.01060549839 0.01410249844
|
||||
239 24 -279.6115695 -279.584237 0.001138852664 1.13770573 1.035836121 0.02686761528
|
||||
240 24 -279.064529 -279.124427 0.002495750967 1.76375665 1.809545887 0.03536482035
|
||||
241 24 -279.3562359 -279.379366 0.000963755899 1.070359933 0.8982692706 0.03586365384
|
||||
242 24 -279.3561337 -279.37937 0.0009681791432 1.070187041 0.898081355 0.03582334182
|
||||
243 24 -279.0645273 -279.124427 0.002495818902 1.763753116 1.809523374 0.03536507377
|
||||
244 24 -279.920921 -279.901657 0.0008026661364 0.295842601 0.001570374478 0.01411415473
|
||||
245 24 -279.835369 -279.79264 0.001780376182 0.7694168746 0.8392614852 0.02365583077
|
||||
246 24 -279.9208868 -279.896025 0.001035907873 0.2963184557 0.01060243293 0.01410273421
|
||||
247 24 -279.0819585 -279.206496 0.005189061107 0.548788431 0.005326518563 0.03225764062
|
||||
248 24 -279.5958869 -279.55564 0.001676956181 1.457719116 1.4056319 0.02601845486
|
||||
249 24 -279.8353874 -279.79264 0.001781141415 0.7694021079 0.8392625708 0.0236575616
|
||||
# GSF_112.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
250 30 -345.1958147 -345.175835 0.0006659888828 1.417827685 1.057395322 0.04924259711
|
||||
251 30 -346.4091654 -346.361714 0.001581712645 1.014644886 1.220284939 0.04659093523
|
||||
252 30 -345.9623042 -345.795524 0.005559340233 1.678459906 2.112860875 0.06265040874
|
||||
253 30 -345.1047773 -345.164602 0.001994157897 1.817583015 1.765832199 0.05258058387
|
||||
254 30 -346.5687925 -346.593523 0.0008243492414 0.5266160053 0.01148867129 0.03755504848
|
||||
255 30 -346.4165137 -346.396186 0.0006775885975 1.101956458 0.9954683928 0.04399110332
|
||||
256 30 -345.2521553 -345.319406 0.00224168982 2.024011434 1.772040852 0.05936118376
|
||||
257 30 -345.5898528 -345.594794 0.0001647082757 2.048144835 1.516014157 0.06040121307
|
||||
258 30 -346.0297765 -345.98566 0.001470549283 1.767327791 1.406252265 0.05243702855
|
||||
259 30 -345.5053828 -345.383994 0.004046292585 1.336428571 0.963574308 0.05104895348
|
||||
260 30 -346.5686342 -346.582564 0.0004643258311 0.5264214865 0.0126740587 0.03760971825
|
||||
261 30 -345.4208872 -345.452139 0.001041727499 3.011665478 2.787719406 0.06345649484
|
||||
262 30 -346.5687922 -346.593523 0.000824358736 0.5266293188 0.01148834 0.03755660424
|
||||
263 30 -345.4303122 -345.281949 0.004945440141 1.947208063 1.873142686 0.05337069289
|
||||
264 30 -345.95932 -345.928661 0.001021967701 2.362723976 2.100874472 0.05002108374
|
||||
265 30 -345.0137677 -345.111657 0.003262976998 3.19378163 3.358068319 0.06536423133
|
||||
266 30 -346.4078756 -346.367123 0.001358420679 1.085591236 1.335797131 0.04639235845
|
||||
267 30 -346.5685864 -346.582565 0.0004659529893 0.5264879505 0.01254743735 0.03760890253
|
||||
268 30 -344.8663405 -344.91356 0.001573984549 2.930408919 3.441834403 0.06926998065
|
||||
269 30 -345.9709087 -345.836703 0.004473521714 1.391835251 1.608769148 0.0557054003
|
||||
270 30 -345.0229891 -344.984307 0.001289401895 2.372016819 2.542628782 0.05571749983
|
||||
271 30 -346.4089445 -346.393931 0.0005004501598 1.297845976 1.211680725 0.04319349672
|
||||
# Liquid.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
272 100 -1105.559726 -1105.601723 0.0004199683753 30.70196346 31.39853886 0.2273901869
|
||||
273 100 -1099.629534 -1099.673012 0.0004347802829 31.98646736 32.03167218 0.2226202775
|
||||
274 100 -1121.43168 -1121.31506 0.001166195007 21.23863202 20.81076453 0.2037539309
|
||||
# Surface.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
275 24 -279.9208871 -279.911828 0.0003774634676 0.2963192975 0.002753093533 0.01433131958
|
||||
276 48 -554.241479 -555.359452 0.02329110353 1.363109446 0.003020630398 0.0573825018
|
||||
277 40 -459.5808398 -459.216162 0.009116945293 3.33149843 5.0461364 0.07877996461
|
||||
278 40 -460.5932467 -461.144076 0.01377073163 0.8854479197 0.005582740008 0.03813349763
|
||||
279 24 -279.8214986 -279.635146 0.007764693427 0.982012045 1.288799837 0.01857540863
|
||||
280 30 -346.5687933 -346.592525 0.000791056775 0.5266154723 0.008446203407 0.03726637101
|
||||
281 30 -346.0051971 -345.744506 0.008689702509 2.266739618 3.124961367 0.06591070739
|
||||
# Volume_A15.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
282 8 -67.00264003 -66.990732 0.001488503243 8.978495355e-15 0 1.554167674e-15
|
||||
283 8 -72.95775645 -72.957807 6.318335608e-06 6.173563626e-14 0 9.086337007e-15
|
||||
284 8 -94.15079079 -94.145745 0.0006307242955 1.257001279e-14 0 1.651353601e-15
|
||||
285 8 -94.55576971 -94.554682 0.0001359640227 7.864226848e-15 0 1.351609702e-15
|
||||
286 8 -79.41650989 -79.438363 0.002731638712 2.922311383e-14 0 4.6112564e-15
|
||||
287 8 -69.6319055 -69.627817 0.0005110626381 3.131450246e-15 0 5.512083845e-16
|
||||
288 8 -82.6140242 -82.604907 0.001139650038 1.015341342e-14 0 1.573105072e-15
|
||||
289 8 14.8871533 14.89048 0.0004158371788 2.179622647e-13 0 3.718594804e-14
|
||||
290 8 -94.35602701 -94.367599 0.001446498413 1.681327296e-14 0 2.430951383e-15
|
||||
291 8 -89.2494361 -89.248227 0.0001511372198 1.602695388e-14 0 2.27566808e-15
|
||||
292 8 -87.22359357 -87.211997 0.001449571359 5.891018761e-15 0 1.023486851e-15
|
||||
293 8 -93.64917633 -93.66897 0.002474209194 1.737070481e-15 0 2.726891929e-16
|
||||
294 8 -7.974970896 -7.989166 0.001774387948 5.346466786e-13 0 7.317740119e-14
|
||||
295 8 -84.99735697 -84.982834 0.001815371577 1.628985705e-15 0 2.68014777e-16
|
||||
296 8 -92.51696442 -92.536373 0.002426072159 3.702813287e-14 0 5.965135793e-15
|
||||
297 8 -26.79883523 -26.77612 0.002839403163 2.314654929e-13 0 3.768467838e-14
|
||||
298 8 -77.53738473 -77.544107 0.0008402842141 2.975839122e-15 0 5.1405639e-16
|
||||
299 8 -80.11476757 -80.114217 6.882064461e-05 9.414427891e-15 0 1.325473296e-15
|
||||
300 8 -42.12903262 -42.143041 0.001751047533 2.610061598e-13 0 3.565304919e-14
|
||||
301 8 -91.02990946 -91.040671 0.001345192241 8.368513177e-15 0 1.310872707e-15
|
||||
302 8 -84.50933121 -84.499231 0.001262526145 5.714110441e-14 0 1.066782658e-14
|
||||
303 8 -61.79844789 -61.825173 0.003340638518 6.62953849e-15 0 1.015391475e-15
|
||||
304 8 -91.13057644 -91.156873 0.003287069749 4.719369293e-15 0 6.76336609e-16
|
||||
305 8 -54.64916677 -54.658744 0.001197153514 1.464956394e-13 0 2.113576767e-14
|
||||
306 8 -72.27319255 -72.277255 0.0005078062019 8.658199332e-16 0 1.410908427e-16
|
||||
307 8 -74.9147183 -74.923334 0.001076962465 4.434219242e-15 0 6.615078855e-16
|
||||
308 8 -64.81833247 -64.798066 0.002533308735 3.748412002e-14 0 5.576268614e-15
|
||||
309 8 -93.03489726 -93.048342 0.001680592822 1.857310674e-14 0 2.604235054e-15
|
||||
310 8 -64.39098013 -64.38702 0.0004950167019 5.001001166e-15 0 5.722057666e-16
|
||||
311 8 -88.36401125 -88.352871 0.001392531574 1.47982807e-14 0 2.645507511e-15
|
||||
# Volume_BCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
312 2 -16.76594323 -16.763625 0.0011591154 3.058627912e-16 0 7.979727989e-17
|
||||
313 2 16.31372699 16.314145 0.0002090027274 8.186542193e-13 0 2.624717573e-13
|
||||
314 2 -21.21034402 -21.209071 0.000636508568 6.029606478e-15 0 1.688464572e-15
|
||||
315 2 -15.7845968 -15.780524 0.002036397536 5.051396178e-14 0 1.863971217e-14
|
||||
316 2 -18.99841038 -19.002205 0.001897311189 3.70201696e-14 0 1.247006253e-14
|
||||
317 2 -22.6245193 -22.620568 0.001975650815 3.866866338e-15 0 1.424786215e-15
|
||||
318 2 4.098164527 4.096885 0.0006397634862 6.334293648e-14 0 2.151519703e-14
|
||||
319 2 56.26275599 56.26276 2.005221472e-06 2.247995559e-12 0 7.580021273e-13
|
||||
320 2 -22.58944012 -22.585113 0.002163562406 1.113168148e-15 0 3.747002708e-16
|
||||
321 2 -21.79724015 -21.795501 0.0008695760695 1.09344287e-15 0 3.700743415e-16
|
||||
322 2 33.11015633 33.110078 3.916354612e-05 4.904232742e-13 0 1.492139745e-13
|
||||
323 2 -20.88315873 -20.885998 0.001419634185 1.859416424e-15 0 7.401486831e-16
|
||||
324 2 -23.59568898 -23.601336 0.002823509954 1.486164289e-15 0 4.916167932e-16
|
||||
325 2 -23.20858071 -23.207313 0.0006338528204 8.900302643e-16 0 3.147520853e-16
|
||||
326 2 -19.89310507 -19.898089 0.002491965758 8.784897284e-16 0 3.064678141e-16
|
||||
327 2 -23.40543384 -23.405474 2.007854096e-05 9.04864091e-16 0 2.55004351e-16
|
||||
328 2 -4.783890314 -4.781324 0.00128315718 1.026901322e-13 0 2.670433319e-14
|
||||
329 2 -18.86311291 -18.864936 0.0009115426716 2.305551267e-16 0 7.864079758e-17
|
||||
330 2 -17.81642588 -17.813086 0.001669937839 1.716587549e-16 0 6.245004514e-17
|
||||
331 2 -11.19369732 -11.197201 0.001751842379 6.247077482e-14 0 2.245483891e-14
|
||||
332 2 -23.6830862 -23.696705 0.006809399945 1.843658888e-15 0 7.087971703e-16
|
||||
# Volume_FCC.xyz
|
||||
config # atoms energy DFT energy energy error force DFT force force error
|
||||
333 4 -19.07363592 -19.075994 0.0005895202867 4.838977351e-14 0 1.162785146e-14
|
||||
334 4 -34.87911157 -34.873619 0.001373142448 2.834773835e-16 0 5.955883934e-17
|
||||
335 4 -43.95312208 -43.950003 0.0007797711561 2.246784353e-15 0 4.928060275e-16
|
||||
336 4 -40.99484531 -40.991909 0.0007340763059 8.408019466e-15 0 2.017013582e-15
|
||||
337 4 -43.44688587 -43.453929 0.001760782795 1.105978561e-14 0 2.960654589e-15
|
||||
338 4 -42.69057259 -42.686077 0.001123896575 2.15077979e-15 0 5.053466326e-16
|
||||
339 4 -33.22567657 -33.224653 0.0002558935333 6.71927174e-16 0 1.601728009e-16
|
||||
340 4 -26.86518979 -26.862709 0.0006201969912 3.31529179e-14 0 7.652202346e-15
|
||||
341 4 -25.52095377 -25.519883 0.0002676922193 3.655453829e-16 0 7.199102425e-17
|
||||
342 4 3.462101367 3.463071 0.0002424081278 1.816025861e-13 0 4.023864575e-14
|
||||
343 4 -31.5932268 -31.59595 0.0006807997919 3.628185658e-16 0 8.557969148e-17
|
||||
344 4 -45.10086835 -45.100466 0.0001005873411 2.465692424e-15 0 5.323999453e-16
|
||||
345 4 -46.05341345 -46.052258 0.0002888629271 8.511696107e-16 0 1.9963776e-16
|
||||
346 4 -29.99832749 -30.001189 0.0007153784531 3.847020655e-16 0 1.014813233e-16
|
||||
347 4 -22.85257327 -22.8504 0.0005433170403 7.603433695e-16 0 2.026735261e-16
|
||||
348 4 -9.165925377 -9.164691 0.0003085942037 6.355991568e-14 0 1.496321874e-14
|
||||
349 4 -24.14844545 -24.150343 0.0004743875843 4.762376771e-16 0 9.887923813e-17
|
||||
350 4 -46.43546878 -46.426795 0.002168445654 2.389854689e-15 0 6.508104241e-16
|
||||
351 4 -28.45126723 -28.451145 3.055783253e-05 7.811231556e-15 0 2.246466901e-15
|
||||
352 4 40.34134283 40.341566 5.579164045e-05 4.392900751e-13 0 1.047052708e-13
|
||||
353 4 19.618876 19.617912 0.0002409995917 2.653013854e-13 0 4.82657932e-14
|
||||
354 4 -26.95747287 -26.954384 0.0007722170381 5.063966549e-16 0 1.225871256e-16
|
||||
355 4 -46.33491981 -46.323696 0.002805953551 3.211950954e-15 0 8.731441496e-16
|
||||
356 4 -45.83316791 -45.828947 0.001055227438 1.228572267e-14 0 3.512236798e-15
|
||||
357 4 -38.16058675 -38.16029 7.418651586e-05 1.457184241e-15 0 3.625572065e-16
|
||||
358 4 -32.91257363 -32.919741 0.001791843199 5.73065335e-14 0 1.529158744e-14
|
||||
359 4 -41.2675262 -41.272675 0.001287199354 7.138843467e-15 0 2.027950471e-15
|
||||
360 4 -39.74460494 -39.753322 0.002179265661 7.861049173e-16 0 1.651275908e-16
|
||||
361 4 -37.55548161 -37.547435 0.002011652753 1.155947671e-14 0 2.497062164e-15
|
||||
362 4 -36.53186908 -36.52595 0.001479769423 3.660718685e-16 0 9.51206706e-17
|
||||
363 4 -45.01550153 -45.016087 0.0001463673621 1.766214736e-15 0 4.760370339e-16
|
||||
@ -1,20 +0,0 @@
|
||||
**************** Begin of Error Analysis for the Training Data Set ****************
|
||||
---------------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
---------------------------------------------------------------------------------------------------
|
||||
Displaced_A15.xyz 9 576 0.000554 0.000680 0.066393 0.083014
|
||||
Displaced_BCC.xyz 9 486 0.004724 0.005103 0.108253 0.139461
|
||||
Displaced_FCC.xyz 9 432 0.001704 0.001900 0.077531 0.097471
|
||||
Elastic_BCC.xyz 100 200 0.000444 0.000446 0.000001 0.000002
|
||||
Elastic_FCC.xyz 100 400 0.000273 0.000327 0.000110 0.000163
|
||||
GSF_110.xyz 22 528 0.001852 0.002260 0.027303 0.044765
|
||||
GSF_112.xyz 22 660 0.001839 0.002404 0.051415 0.080350
|
||||
Liquid.xyz 3 300 0.000674 0.000758 0.217921 0.276109
|
||||
Surface.xyz 7 236 0.009115 0.011661 0.047949 0.105123
|
||||
Volume_A15.xyz 30 240 0.001407 0.001693 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.001497 0.002077 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.000870 0.001139 0.000000 0.000000
|
||||
---------------------------------------------------------------------------------------------------
|
||||
All files 363 4224 0.001053 0.002171 0.059051 0.106960
|
||||
---------------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
@ -1,5 +0,0 @@
|
||||
# Demonstrate fitpod for POD potential
|
||||
|
||||
units metal
|
||||
fitpod Ta_param.pod Ta_data.pod
|
||||
|
||||
@ -1,114 +0,0 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate fitpod for POD potential
|
||||
|
||||
units metal
|
||||
fitpod Ta_param.pod Ta_data.pod
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 1
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 150
|
||||
total number of descriptors for all potentials: 182
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
**************** Begin of Data File ****************
|
||||
file format: extxyz
|
||||
file extension: xyz
|
||||
path to training data set: ../Ta/XYZ
|
||||
path to test data set: ../Ta/XYZ
|
||||
training fraction: 1
|
||||
test fraction: 1
|
||||
randomize training data set: 1
|
||||
randomize test data set: 1
|
||||
error analysis for training data set: 1
|
||||
error analysis for test data set: 0
|
||||
energy/force calculation for training data set: 0
|
||||
energy/force calculation for test data set: 0
|
||||
fitting weight for energy: 100
|
||||
fitting weight for force: 1
|
||||
fitting weight for stress: 0
|
||||
fitting regularization parameter: 1e-10
|
||||
**************** End of Data File ****************
|
||||
**************** Begin of Training Data Set ****************
|
||||
---------------------------------------------------------------
|
||||
data file | number of configurations | number of atoms
|
||||
---------------------------------------------------------------
|
||||
Displaced_A15.xyz | 9 | 576
|
||||
Displaced_BCC.xyz | 9 | 486
|
||||
Displaced_FCC.xyz | 9 | 432
|
||||
Elastic_BCC.xyz | 100 | 200
|
||||
Elastic_FCC.xyz | 100 | 400
|
||||
GSF_110.xyz | 22 | 528
|
||||
GSF_112.xyz | 22 | 660
|
||||
Liquid.xyz | 3 | 300
|
||||
Surface.xyz | 7 | 236
|
||||
Volume_A15.xyz | 30 | 240
|
||||
Volume_BCC.xyz | 21 | 42
|
||||
Volume_FCC.xyz | 31 | 124
|
||||
---------------------------------------------------------------
|
||||
number of files: 12
|
||||
number of configurations in all files: 363
|
||||
number of atoms in all files: 4224
|
||||
minimum number of atoms: 2
|
||||
maximum number of atoms: 100
|
||||
**************** End of Training Data Set ****************
|
||||
**************** Begin of Memory Allocation ****************
|
||||
maximum number of atoms in periodic domain: 100
|
||||
maximum number of atoms in extended domain: 2700
|
||||
maximum number of neighbors in extended domain: 270000
|
||||
size of double memory: 223201
|
||||
size of int memory: 14709
|
||||
size of descriptor matrix: 182 x 182
|
||||
**************** End of Memory Allocation ****************
|
||||
**************** Begin of Least-Squares Fitting ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
**************** End of Least-Squares Fitting ****************
|
||||
**************** Begin of Error Calculation ****************
|
||||
Configuration: # 1
|
||||
Configuration: # 101
|
||||
Configuration: # 201
|
||||
Configuration: # 301
|
||||
**************** End of Error Calculation ****************
|
||||
**************** Begin of Error Analysis for the Training Data Set ****************
|
||||
---------------------------------------------------------------------------------------------------
|
||||
File | # configs | # atoms | MAE energy | RMSE energy | MAE force | RMSE force
|
||||
---------------------------------------------------------------------------------------------------
|
||||
Displaced_A15.xyz 9 576 0.000554 0.000680 0.066393 0.083014
|
||||
Displaced_BCC.xyz 9 486 0.004724 0.005103 0.108253 0.139461
|
||||
Displaced_FCC.xyz 9 432 0.001704 0.001900 0.077531 0.097471
|
||||
Elastic_BCC.xyz 100 200 0.000444 0.000446 0.000001 0.000002
|
||||
Elastic_FCC.xyz 100 400 0.000273 0.000327 0.000110 0.000163
|
||||
GSF_110.xyz 22 528 0.001852 0.002260 0.027303 0.044765
|
||||
GSF_112.xyz 22 660 0.001839 0.002404 0.051415 0.080350
|
||||
Liquid.xyz 3 300 0.000674 0.000758 0.217921 0.276109
|
||||
Surface.xyz 7 236 0.009115 0.011661 0.047949 0.105123
|
||||
Volume_A15.xyz 30 240 0.001407 0.001693 0.000000 0.000000
|
||||
Volume_BCC.xyz 21 42 0.001497 0.002077 0.000000 0.000000
|
||||
Volume_FCC.xyz 31 124 0.000870 0.001139 0.000000 0.000000
|
||||
---------------------------------------------------------------------------------------------------
|
||||
All files 363 4224 0.001053 0.002171 0.059051 0.106960
|
||||
---------------------------------------------------------------------------------------------------
|
||||
**************** End of Error Analysis for the Training Data Set ****************
|
||||
|
||||
Total wall time: 0:00:01
|
||||
@ -1,142 +0,0 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD Ta potential
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 3.316
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice bcc $a
|
||||
lattice bcc 3.316
|
||||
Lattice spacing in x,y,z = 3.316 3.316 3.316
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 1 box
|
||||
Created orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
1 by 1 by 1 MPI processor grid
|
||||
create_atoms 1 box
|
||||
Created 128 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
create_atoms CPU = 0.000 seconds
|
||||
|
||||
mass 1 180.88
|
||||
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * Ta_param.pod Ta_coefficients.pod Ta
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 1
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 150
|
||||
total number of descriptors for all potentials: 182
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 5 5 5
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.082 | 3.082 | 3.082 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -11.847697 0 -11.809222 13502.169
|
||||
10 296.47494 -11.847245 0 -11.809222 13529.584
|
||||
20 286.0918 -11.845913 0 -11.809222 13613.884
|
||||
30 269.42275 -11.843776 0 -11.809222 13759.746
|
||||
40 247.39423 -11.84095 0 -11.809222 13972.073
|
||||
50 221.23976 -11.837596 0 -11.809222 14253.202
|
||||
60 192.43252 -11.833901 0 -11.809222 14600.367
|
||||
70 162.59874 -11.830075 0 -11.809221 15004.156
|
||||
80 133.41531 -11.826332 0 -11.809221 15448.418
|
||||
90 106.49785 -11.82288 0 -11.809221 15911.638
|
||||
100 83.288219 -11.819903 0 -11.809221 16369.373
|
||||
Loop time of 1.51781 on 1 procs for 100 steps with 128 atoms
|
||||
|
||||
Performance: 2.846 ns/day, 8.432 hours/ns, 65.884 timesteps/s, 8.433 katom-step/s
|
||||
99.8% CPU use with 1 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 1.5172 | 1.5172 | 1.5172 | 0.0 | 99.96
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.0002542 | 0.0002542 | 0.0002542 | 0.0 | 0.02
|
||||
Output | 0.00013308 | 0.00013308 | 0.00013308 | 0.0 | 0.01
|
||||
Modify | 0.00012159 | 0.00012159 | 0.00012159 | 0.0 | 0.01
|
||||
Other | | 0.0001446 | | | 0.01
|
||||
|
||||
Nlocal: 128 ave 128 max 128 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 727 ave 727 max 727 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 7424 ave 7424 max 7424 min
|
||||
Histogram: 1 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 7424
|
||||
Ave neighs/atom = 58
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
|
||||
Total wall time: 0:00:01
|
||||
@ -1,142 +0,0 @@
|
||||
LAMMPS (22 Dec 2022)
|
||||
using 1 OpenMP thread(s) per MPI task
|
||||
# Demonstrate POD Ta potential
|
||||
|
||||
# Initialize simulation
|
||||
|
||||
variable nsteps index 100
|
||||
variable nrep equal 4
|
||||
variable a equal 3.316
|
||||
units metal
|
||||
|
||||
# generate the box and atom positions using a BCC lattice
|
||||
|
||||
variable nx equal ${nrep}
|
||||
variable nx equal 4
|
||||
variable ny equal ${nrep}
|
||||
variable ny equal 4
|
||||
variable nz equal ${nrep}
|
||||
variable nz equal 4
|
||||
|
||||
boundary p p p
|
||||
|
||||
lattice bcc $a
|
||||
lattice bcc 3.316
|
||||
Lattice spacing in x,y,z = 3.316 3.316 3.316
|
||||
region box block 0 ${nx} 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 ${ny} 0 ${nz}
|
||||
region box block 0 4 0 4 0 ${nz}
|
||||
region box block 0 4 0 4 0 4
|
||||
create_box 1 box
|
||||
Created orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
1 by 2 by 2 MPI processor grid
|
||||
create_atoms 1 box
|
||||
Created 128 atoms
|
||||
using lattice units in orthogonal box = (0 0 0) to (13.264 13.264 13.264)
|
||||
create_atoms CPU = 0.000 seconds
|
||||
|
||||
mass 1 180.88
|
||||
|
||||
|
||||
# POD potential
|
||||
pair_style pod
|
||||
pair_coeff * * Ta_param.pod Ta_coefficients.pod Ta
|
||||
Reading potential file Ta_param.pod with DATE: 2022-11-30
|
||||
**************** Begin of POD Potentials ****************
|
||||
species: Ta
|
||||
periodic boundary conditions: 1 1 1
|
||||
inner cut-off radius: 1
|
||||
outer cut-off radius: 5
|
||||
bessel polynomial degree: 3
|
||||
inverse polynomial degree: 6
|
||||
one-body potential: 1
|
||||
two-body potential: 3 6 6
|
||||
three-body potential: 3 6 5 5
|
||||
four-body SNAP potential: 0 0
|
||||
quadratic POD potential: 1
|
||||
number of basis functions for one-body potential: 1
|
||||
number of basis functions for two-body potential: 6
|
||||
number of basis functions for three-body potential: 25
|
||||
number of basis functions for four-body potential: 0
|
||||
number of descriptors for one-body potential: 1
|
||||
number of descriptors for two-body potential: 6
|
||||
number of descriptors for three-body potential: 25
|
||||
number of descriptors for four-body potential: 0
|
||||
number of descriptors for quadratic POD potential: 150
|
||||
total number of descriptors for all potentials: 182
|
||||
**************** End of POD Potentials ****************
|
||||
|
||||
|
||||
# Setup output
|
||||
|
||||
thermo 10
|
||||
thermo_modify norm yes
|
||||
|
||||
# Set up NVE run
|
||||
|
||||
timestep 0.5e-3
|
||||
neighbor 1.0 bin
|
||||
neigh_modify once no every 1 delay 0 check yes
|
||||
|
||||
# Run MD
|
||||
|
||||
velocity all create 300.0 4928459 loop geom
|
||||
fix 1 all nve
|
||||
run ${nsteps}
|
||||
run 100
|
||||
Neighbor list info ...
|
||||
update: every = 1 steps, delay = 0 steps, check = yes
|
||||
max neighbors/atom: 2000, page size: 100000
|
||||
master list distance cutoff = 6
|
||||
ghost atom cutoff = 6
|
||||
binsize = 3, bins = 5 5 5
|
||||
1 neighbor lists, perpetual/occasional/extra = 1 0 0
|
||||
(1) pair pod, perpetual
|
||||
attributes: full, newton on
|
||||
pair build: full/bin/atomonly
|
||||
stencil: full/bin/3d
|
||||
bin: standard
|
||||
Per MPI rank memory allocation (min/avg/max) = 3.062 | 3.062 | 3.062 Mbytes
|
||||
Step Temp E_pair E_mol TotEng Press
|
||||
0 300 -11.847697 0 -11.809222 13502.169
|
||||
10 296.47494 -11.847245 0 -11.809222 13529.584
|
||||
20 286.0918 -11.845913 0 -11.809222 13613.884
|
||||
30 269.42275 -11.843776 0 -11.809222 13759.746
|
||||
40 247.39423 -11.84095 0 -11.809222 13972.073
|
||||
50 221.23976 -11.837596 0 -11.809222 14253.202
|
||||
60 192.43252 -11.833901 0 -11.809222 14600.367
|
||||
70 162.59874 -11.830075 0 -11.809221 15004.156
|
||||
80 133.41531 -11.826332 0 -11.809221 15448.418
|
||||
90 106.49785 -11.82288 0 -11.809221 15911.638
|
||||
100 83.288219 -11.819903 0 -11.809221 16369.373
|
||||
Loop time of 0.427448 on 4 procs for 100 steps with 128 atoms
|
||||
|
||||
Performance: 10.106 ns/day, 2.375 hours/ns, 233.947 timesteps/s, 29.945 katom-step/s
|
||||
97.9% CPU use with 4 MPI tasks x 1 OpenMP threads
|
||||
|
||||
MPI task timing breakdown:
|
||||
Section | min time | avg time | max time |%varavg| %total
|
||||
---------------------------------------------------------------
|
||||
Pair | 0.40622 | 0.40946 | 0.419 | 0.9 | 95.79
|
||||
Neigh | 0 | 0 | 0 | 0.0 | 0.00
|
||||
Comm | 0.0071192 | 0.016995 | 0.020439 | 4.4 | 3.98
|
||||
Output | 0.00012904 | 0.0002071 | 0.00043132 | 0.0 | 0.05
|
||||
Modify | 3.905e-05 | 4.8089e-05 | 5.5714e-05 | 0.0 | 0.01
|
||||
Other | | 0.0007341 | | | 0.17
|
||||
|
||||
Nlocal: 32 ave 32 max 32 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Nghost: 431 ave 431 max 431 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
Neighs: 0 ave 0 max 0 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
FullNghs: 1856 ave 1856 max 1856 min
|
||||
Histogram: 4 0 0 0 0 0 0 0 0 0
|
||||
|
||||
Total # of neighbors = 7424
|
||||
Ave neighs/atom = 58
|
||||
Neighbor list builds = 0
|
||||
Dangerous builds = 0
|
||||
|
||||
|
||||
Total wall time: 0:00:00
|
||||
Reference in New Issue
Block a user