From f11a698a026ead806c33b7676ee700b3c09c2176 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 21 Jun 2019 10:33:19 -0700 Subject: [PATCH 001/207] new directory test --- atomate/csld/__init__.py | 0 1 file changed, 0 insertions(+), 0 deletions(-) create mode 100644 atomate/csld/__init__.py diff --git a/atomate/csld/__init__.py b/atomate/csld/__init__.py new file mode 100644 index 000000000..e69de29bb From 0b1d39d4d315d6e05cea7ff1dd66e41955eb2b07 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 21 Jun 2019 10:40:18 -0700 Subject: [PATCH 002/207] new directory test --- atomate/csld/__init__.py | 1 + 1 file changed, 1 insertion(+) diff --git a/atomate/csld/__init__.py b/atomate/csld/__init__.py index e69de29bb..ed0f110e2 100644 --- a/atomate/csld/__init__.py +++ b/atomate/csld/__init__.py @@ -0,0 +1 @@ +print('hello') \ No newline at end of file From 5027e10c6dbf9561266c0d372ac9a62c18fa346f Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 21 Jun 2019 10:46:09 -0700 Subject: [PATCH 003/207] new directory test --- atomate/csld/__init__.py | 1 - atomate/vasp/workflows/base/csld.py | 0 2 files changed, 1 deletion(-) delete mode 100644 atomate/csld/__init__.py create mode 100644 atomate/vasp/workflows/base/csld.py diff --git a/atomate/csld/__init__.py b/atomate/csld/__init__.py deleted file mode 100644 index ed0f110e2..000000000 --- a/atomate/csld/__init__.py +++ /dev/null @@ -1 +0,0 @@ -print('hello') \ No newline at end of file diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py new file mode 100644 index 000000000..e69de29bb From f60db1eaf41b6edc626e2acdbb8431b6c5b58869 Mon Sep 17 00:00:00 2001 From: reeschang Date: Mon, 24 Jun 2019 17:30:36 -0700 Subject: [PATCH 004/207] new directory test --- .../vasp/workflows/base/CSLD_sc_enumerator.py | 105 ++++++++++++++++++ 1 file changed, 105 insertions(+) create mode 100644 atomate/vasp/workflows/base/CSLD_sc_enumerator.py diff --git a/atomate/vasp/workflows/base/CSLD_sc_enumerator.py b/atomate/vasp/workflows/base/CSLD_sc_enumerator.py new file mode 100644 index 000000000..5f9121050 --- /dev/null +++ b/atomate/vasp/workflows/base/CSLD_sc_enumerator.py @@ -0,0 +1,105 @@ +#!/usr/bin/env python3 + +import os +import sys + +import numpy as np + +""" +This module defines a script that generates perturbed supercells from a supercell structure +""" + +class CSLDPerturbedSupercellEnumerator: + """ + Uses a supercell Structure, a transformation matrix, a min/max displacement, + number of displacement values, and number of supercells per displacement + to generate a list of randomly perturbed supercells from a given supercell. + """ + + def __init__(self, original_supercell, + transformation_matrix, + min_displacement, + max_displacement, + num_displacements, + scs_per_displacement): + + self.supercell = original_supercell + self.trans_mat = transformation_matrix + self.min_disp = min_displacement + self.max_disp = max_displacement + self.num_disps = num_displacements + self.scs_per_disp = scs_per_displacement + self.perturbed_supercells = [] + + + def random_displacements(self, natom, rmax, rmin=None, dim=3): + #*** Adapted from csld.util.mathtool + + # Generate matrix of size (natom, 3) where each row is a Gaussian random vector + # If 'rmax'=None, then all vectors will have magnitude 'rmin'. + # Else, magnitudes are uniformly distributed between 'rmin' and 'rmax'. + + dx = np.random.normal(size=(natom, dim)) #Gaussian sampled displacements. Matrix size: (natom, 3) + dx_norms = np.linalg.norm(dx, axis=1) + veclen = np.full(natom, rmax) if rmax is None else np.random.uniform(rmin, rmax, natom) + + if not 0 in dx_norms: + return dx * (veclen / dx_norms)[:, None] + else: + self.random_displacements(natom, rmax, rmin, dim) + + + def perturb_supercell(self, structure, disp): + # *** Adapted from CSLD's 'polaron_main' file + + na = structure.num_sites + disp = float(disp) + if isinstance(disp, float): + # from csld.util.mathtool import random_displacements + dr = self.random_displacements(na, disp) #generate random displacements + + # Perturb structure with the random displacements + for i in range(len(structure._sites)): + structure.translate_sites([i], dr[i], frac_coords=False, to_unit_cell=True) + else: + print('displacement entered is not a float.') + + + def generate_transformations(self): + for disp_val in range(self.num_disps): + for cell in range(self.scs_per_disp): + sc = self.original_supercell.copy() + self.perturb_supercell(sc, self.max_disp) + self.perturbed_supercells += [sc] + + +#################################### +# BELOW IS FOR DEBUGGING PURPOSES # +#################################### +def main(): + print('test') + natom = 10 + dim = 3 + rmin = 0 + rmax = 0.1 + dx = np.random.normal(size=(natom, dim)) # Gaussian sampled displacements. Matrix size: (natom, 3) + print(dx.shape) + veclen = np.full(natom, rmin) if rmax is None else np.random.uniform(rmin, rmax, natom) # vector of length natom + dx *= (veclen / np.linalg.norm(dx, axis=1))[:, None] + test = (veclen / np.linalg.norm(dx, axis=1))[:, None] + print(test.shape) + + x = np.array([[1, 1, 1], + [1, 1, 1], + [1, 1, 1], + [1, 1, 1]]) + y = np.array([[1], + [2], + [3], + [4]]) + print(x*y) + + + +if __name__ == '__main__': + main() \ No newline at end of file From ab7e06ca255ed0305500e7f6d119d29c790517cf Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 25 Jun 2019 13:25:12 -0700 Subject: [PATCH 005/207] Confirmed supercell volume compares with Pymatgen's volume Added functionality for constraining supercell to a min number of atoms on top of the X times NN distances. --- atomate/vasp/workflows/base/csld.py | 194 ++++++++++++++++++++++++++++ 1 file changed, 194 insertions(+) diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index e69de29bb..b651e8f02 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -0,0 +1,194 @@ +#!/usr/bin/env python3 + +import math + +import numpy as np + +from pymatgen.ext.matproj import MPRester +from pymatgen.analysis.structure_analyzer import get_max_bond_lengths +from pymatgen.transformations.standard_transformations import SupercellTransformation + +""" +This module defines the Compressed Sensing Lattice Dynamics (CSLD) workflow. +""" + +def gen_scaling_matrix(structure=None, max_atoms=np.Inf, min_atoms=-np.Inf, length_cutoff=5): + """ + Returns the transformation matrix of a Pymatgen structure into a suitable supercell for CSLD + + Args: + structure (Structure): input structure. + max_atoms (int): maximum number of atoms allowed in the supercell + min_atoms (int): minimum number of atoms allowed in the supercell + length_cutoff (int): number of multiples of the unit cell nearest neighbor distance to + force all directions of the supercell to be at least as large + + Returns: + Transformation matrix (numpy array) + """ + + if not structure: + print('No structure was passed into gen_scaling_matrix()') + else: + + # -------- Store relevant structure data ---------- + latVecs = structure.lattice.matrix #lattice vectors + bondLengths = get_max_bond_lengths(structure) #dictionary of bond lengths + bondMatrix = structure.distance_matrix #NxN matrix of bond distances (diagonal is 0) + print(bondMatrix) + print(structure.sites) + np.fill_diagonal(bondMatrix, np.Inf) + nnDist = np.amin(bondMatrix) #nearest neighbor bond length + print("nn Dist: " + str(nnDist)) + + # --------- Transform lattice vectors ------------- + SCnotFound = True # boolean indicator for whether a sufficiently large supercell has been created + hard_threshold = nnDist * length_cutoff + print("hard_threshold: " + str(hard_threshold)) + target_threshold = hard_threshold # target_threshold is used as the desired CUBE side lengths of + # the supercell (SC) + # note: if it is not possible to get a cubic SC, the real SC dimensions will be less + # than the target + while SCnotFound: + print('---------------------------------------------------------') + print('target threshold: ' + str(target_threshold)) + target_supercell = np.eye(3, 3) * target_threshold + + T = np.linalg.inv(latVecs) @ target_supercell + # T = target_supercell @ np.linalg.inv(latVecs) + T = np.around(T) + print("proposed sc.txt:") + print(T) + + print("\nSupercell dimensions:") + scBases = latVecs @ T + print(scBases) + print("Supercell volume:") + vol = np.cross(scBases[0],scBases[1]).T @ scBases[2] + print(vol) + + # -------------------- Check how many nearest neighbors the supercell allows --------------------------- + def proj(b, a): + # Returns vector projection of b onto a + return (b.T @ (a / np.linalg.norm(a))) * (a / np.linalg.norm(a)) + + scBasesNorms = [np.linalg.norm(scBases[0]), np.linalg.norm(scBases[1]), np.linalg.norm(scBases[2])] + maxNorm = max(scBasesNorms) + maxIndex = scBasesNorms.index(maxNorm) + idx = list(range(3)) + idx.remove(maxIndex) + a = scBases[maxIndex] + b = scBases[idx[0]] + c = scBases[idx[1]] + projb_a = proj(b, a) + projc_a = proj(c, a) + + if np.linalg.norm(projb_a) > np.linalg.norm(projc_a): + length = np.linalg.norm(a - projb_a) + else: + length = np.linalg.norm(a - projc_a) + width = math.sqrt(np.linalg.norm(b) ** 2 - np.linalg.norm(projb_a) ** 2) + ab_normal = np.cross(a, b) # get normal direction from AB plane + height = np.linalg.norm(proj(c, ab_normal)) # project c onto AB plane normal + + cubeSide = min([length, width, height]) + print('smallest dimension of proposed SC: ' + str(cubeSide)) + + superstructure = SupercellTransformation(T).apply_transformation(structure) + num_at = superstructure.num_sites + if cubeSide >= hard_threshold and num_at >= min_atoms and num_at <= max_atoms: + print(T) + print("FINISHED") + return T + else: + # Increase threshold until + target_threshold += 1 + + +def parallelipipedVol(a=[1, 0, 0], b=[0, 1, 0], c=[0, 0, 1]): + vol = np.cross(a,b).T @ c + return vol + +def main(): + mpr = MPRester(api_key='auNIrJ23VLXCqbpl') + structure = mpr.get_structure_by_material_id('mp-7814') + print('structure loaded') + + T = gen_scaling_matrix(structure, length_cutoff=4, min_atoms=150) + #***my function, pymatgen's SupercellTransformation, and CSLD all yield different supercell lattice vectors + + print('~~~~~~~~~~~~~~~~~~~~~~~~~') + print("FINISHED2") + # print(T) + + # Pymatgen version + superstructure = SupercellTransformation(T).apply_transformation(structure) + print(superstructure.lattice) + print(superstructure.volume) + print(parallelipipedVol(superstructure.lattice.matrix[0], + superstructure.lattice.matrix[1], + superstructure.lattice.matrix[2])) + print(superstructure.num_sites) + superstructure.to(fmt='poscar', filename='POSCAR-scTest') + + # Find Primitive + # from pymatgen.symmetry.analyzer import SpacegroupAnalyzer + # sga = SpacegroupAnalyzer(superstructure) + # print(sga.find_primitive().lattice) + + # # CSLD version + # # *** Can't call CSLD Structure member functions because structure scraped is a Pymatgen Structure *** + # from csld.structure import Structure as CSLDStructure + # from csld.lattice import Lattice as CSLDLattice + # from csld.coord_utils import supercell_latticepoints + # + # def generate_supercell(CSLDStructure, scaling_matrix, scref=None): + # """ + # Create a supercell. + # + # Args: + # scaling_matrix: A scaling matrix for transforming the lattice + # vectors. Has to be all integers. Several options are possible: + # + # a. A full 3x3 scaling matrix defining the linear combination + # the old lattice vectors. E.g., [[2,1,0],[0,3,0],[0,0, + # 1]] generates a new structure with lattice vectors a' = + # 2a + b, b' = 3b, c' = c where a, b, and c are the lattice + # vectors of the original structure. + # b. An sequence of three scaling factors. E.g., [2, 1, 1] + # specifies that the supercell should have dimensions 2a x b x + # c. + # c. A number, which simply scales all lattice vectors by the + # same factor. + # """ + # scmat = np.array(scaling_matrix, np.int16) + # if scmat.shape != (3, 3): + # scmat= np.array(scmat* np.eye(3), np.int16) + # n_cell=int(round(np.linalg.det(scmat))) + # old_lattice = CSLDStructure._lattice + # new_lattice = CSLDLattice(np.dot(scmat, old_lattice.matrix)) + # tvects = supercell_latticepoints(scmat) + # inv=np.linalg.inv(scmat) + # if scref is None: + # sc_ref= supercell_latticepoints(scmat) + # else: + # sc_ref= scref + # return CSLDStructure(CSLDLattice(np.dot(scmat, CSLDStructure._lattice.matrix)), + # [s.species_and_occu for s in CSLDStructure for _ in range(n_cell)], + # (CSLDStructure.frac_coords[:,None,:]+sc_ref[None,:,:]).reshape((-1,3)).dot(inv), + # coords_are_cartesian=False, to_unit_cell=True, + # site_properties_T=[s.properties for s in CSLDStructure for _ in range(n_cell)], + # intensive_properties=CSLDStructure.intensive_properties,extensive_properties= + # {k:v*CSLDStructure.n_cell for k,v in CSLDStructure.extensive_properties.items()}) + # + # # csld_structure = csld.structure.Structure(structure.lattice, structure.species, structure.lattice.get_fractional_coords()) + # csld_supercell = SupercellStructure.from_scmat(csld_structure, T) + # print("here:") + # print(csld_supercell) + +if __name__ == '__main__': + main() + + + + From 278b535329a6aa7e80c61432fe043e995c8cc83f Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 25 Jun 2019 14:49:39 -0700 Subject: [PATCH 006/207] Added handling for transformation matrices with zero columns/rows (i.e. materials with extremely high/low angles) --- atomate/vasp/workflows/base/csld.py | 81 ++++++++++++++++++++++++----- 1 file changed, 69 insertions(+), 12 deletions(-) diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index b651e8f02..1c2d26a09 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -7,11 +7,19 @@ from pymatgen.ext.matproj import MPRester from pymatgen.analysis.structure_analyzer import get_max_bond_lengths from pymatgen.transformations.standard_transformations import SupercellTransformation +from csld.structure import SupercellStructure """ This module defines the Compressed Sensing Lattice Dynamics (CSLD) workflow. + +V3 added rounding of entries away from 0 if there are zero rows or columns in the transformation matrix. """ + +def round_away_from_zero(x): + aX = abs(x) + return math.ceil(aX)*(aX/x) if x is not 0 else 0 + def gen_scaling_matrix(structure=None, max_atoms=np.Inf, min_atoms=-np.Inf, length_cutoff=5): """ Returns the transformation matrix of a Pymatgen structure into a suitable supercell for CSLD @@ -35,8 +43,8 @@ def gen_scaling_matrix(structure=None, max_atoms=np.Inf, min_atoms=-np.Inf, leng latVecs = structure.lattice.matrix #lattice vectors bondLengths = get_max_bond_lengths(structure) #dictionary of bond lengths bondMatrix = structure.distance_matrix #NxN matrix of bond distances (diagonal is 0) - print(bondMatrix) - print(structure.sites) + # print(bondMatrix) + # print(structure.sites) np.fill_diagonal(bondMatrix, np.Inf) nnDist = np.amin(bondMatrix) #nearest neighbor bond length print("nn Dist: " + str(nnDist)) @@ -56,7 +64,37 @@ def gen_scaling_matrix(structure=None, max_atoms=np.Inf, min_atoms=-np.Inf, leng T = np.linalg.inv(latVecs) @ target_supercell # T = target_supercell @ np.linalg.inv(latVecs) - T = np.around(T) + print('T before rounding:') + print(T) + print('T after rounding:') + T_rounded = np.around(T) + print(T_rounded) + + + # Zero columns or rows make T singular, so make them non-singular + if (~T_rounded.any(axis=1)).any(): #Check for zero rows + zero_row_idxs = np.where(~T_rounded.any(axis=1))[0] + for zero_row_idx in zero_row_idxs: + # print(zero_row_idx) + zero_row = T[zero_row_idx, :] + # print('zero row:' + str(zero_row)) + col_idx_to_fix = np.where(np.absolute(zero_row) == np.amax(np.absolute(zero_row)))[0] + # print('amax:') + # print(np.amax(np.absolute(zero_row))) + # print('col idx to fix:') + # print(col_idx_to_fix) + for j in col_idx_to_fix: + T_rounded[zero_row_idx, j] = round_away_from_zero(T[zero_row_idx, j]) + if (~T_rounded.any(axis=1)).any(): #Check for zero columns + zero_col_idxs = np.where(~T_rounded.any(axis=1))[0] + for zero_col_idx in zero_col_idxs: + zero_col = T[:, zero_col_idx] + row_idx_to_fix = np.where(np.absolute(zero_col) == np.amax(np.absolute(zero_col)))[0] + for i in row_idx_to_fix: + T_rounded[i, zero_col_idx] = round_away_from_zero(T[i, zero_col_idx]) + + + T = T_rounded print("proposed sc.txt:") print(T) @@ -109,12 +147,27 @@ def parallelipipedVol(a=[1, 0, 0], b=[0, 1, 0], c=[0, 0, 1]): vol = np.cross(a,b).T @ c return vol + def main(): mpr = MPRester(api_key='auNIrJ23VLXCqbpl') - structure = mpr.get_structure_by_material_id('mp-7814') + # structure = mpr.get_structure_by_material_id('mp-7814') #passed + structure = mpr.get_structure_by_material_id('mp-1101039') #passed + # structure = mpr.get_structure_by_material_id('mp-20012') + print('structure loaded') + print(structure.num_sites) + # print('structure') + # print(structure) + # structure.to(fmt='poscar', filename='POSCAR-tlbise2-scraped') + + # # Find Primitive + # from pymatgen.symmetry.analyzer import SpacegroupAnalyzer + # sga = SpacegroupAnalyzer(structure) + # # print(sga.find_primitive().lattice) + # sga.find_primitive().to(fmt='poscar', filename='POSCAR-tlbise2-scraped-prim') + - T = gen_scaling_matrix(structure, length_cutoff=4, min_atoms=150) + T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150) #***my function, pymatgen's SupercellTransformation, and CSLD all yield different supercell lattice vectors print('~~~~~~~~~~~~~~~~~~~~~~~~~') @@ -124,17 +177,21 @@ def main(): # Pymatgen version superstructure = SupercellTransformation(T).apply_transformation(structure) print(superstructure.lattice) - print(superstructure.volume) - print(parallelipipedVol(superstructure.lattice.matrix[0], - superstructure.lattice.matrix[1], - superstructure.lattice.matrix[2])) + # print(superstructure.volume) + # print(parallelipipedVol(superstructure.lattice.matrix[0], + # superstructure.lattice.matrix[1], + # superstructure.lattice.matrix[2])) print(superstructure.num_sites) - superstructure.to(fmt='poscar', filename='POSCAR-scTest') - # Find Primitive + # # Find Primitive # from pymatgen.symmetry.analyzer import SpacegroupAnalyzer # sga = SpacegroupAnalyzer(superstructure) - # print(sga.find_primitive().lattice) + # # print(sga.find_primitive().lattice) + # sga.find_primitive().to(fmt='poscar', filename='POSCAR-scTest-prim') + + superstructure.to(fmt='poscar', filename='POSCAR-scTest') + + # # CSLD version # # *** Can't call CSLD Structure member functions because structure scraped is a Pymatgen Structure *** From 678b2b690c9947bc55b38bf6f4fbff7c7304ff4c Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 25 Jun 2019 15:04:06 -0700 Subject: [PATCH 007/207] Handling for max_atoms --- atomate/vasp/workflows/base/csld.py | 10 ++++++++-- 1 file changed, 8 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 1c2d26a09..f440a9212 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -7,7 +7,6 @@ from pymatgen.ext.matproj import MPRester from pymatgen.analysis.structure_analyzer import get_max_bond_lengths from pymatgen.transformations.standard_transformations import SupercellTransformation -from csld.structure import SupercellStructure """ This module defines the Compressed Sensing Lattice Dynamics (CSLD) workflow. @@ -132,8 +131,10 @@ def proj(b, a): cubeSide = min([length, width, height]) print('smallest dimension of proposed SC: ' + str(cubeSide)) + # Get number of atoms superstructure = SupercellTransformation(T).apply_transformation(structure) num_at = superstructure.num_sites + if cubeSide >= hard_threshold and num_at >= min_atoms and num_at <= max_atoms: print(T) print("FINISHED") @@ -141,6 +142,11 @@ def proj(b, a): else: # Increase threshold until target_threshold += 1 + if num_at > max_atoms: + raise AttributeError('While trying to solve for the supercell, the max' + 'number of atoms was exceeded. Try lowering the number' + 'of nearest neighbor distances.') + return def parallelipipedVol(a=[1, 0, 0], b=[0, 1, 0], c=[0, 0, 1]): @@ -167,7 +173,7 @@ def main(): # sga.find_primitive().to(fmt='poscar', filename='POSCAR-tlbise2-scraped-prim') - T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150) + T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150, max_atoms=1) #***my function, pymatgen's SupercellTransformation, and CSLD all yield different supercell lattice vectors print('~~~~~~~~~~~~~~~~~~~~~~~~~') From 01b1dbfd63c6789834515be469dc3ff9fe4cf7e8 Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 25 Jun 2019 16:32:00 -0700 Subject: [PATCH 008/207] IO for ShengBTE CONTROL file V1 (needs testing) --- atomate/vasp/workflows/base/sbte_IO.py | 100 +++++++++++++++++++++++++ 1 file changed, 100 insertions(+) create mode 100644 atomate/vasp/workflows/base/sbte_IO.py diff --git a/atomate/vasp/workflows/base/sbte_IO.py b/atomate/vasp/workflows/base/sbte_IO.py new file mode 100644 index 000000000..9a4d505bd --- /dev/null +++ b/atomate/vasp/workflows/base/sbte_IO.py @@ -0,0 +1,100 @@ +#!/usr/bin/env python3 + +import f90nml +""" +This module defines IO ShengBTE for making CONTROL file (i.e. a class that can read/write the ‘control’ file, f90ml) + +TO-DO: Test this thing +""" + +class ShengBTE_CONTROL_IO: + + """ + + Args: + nelements (int): number of elements in the material + natoms (int): number of atoms in the cell + ngrid (3 length list of ints): q-point mesh + ***norientations (int): + ***lfactor (float): + lattvec1 (3 length list of floats): first lattice vector + lattvec2 (3 length list of floats): second lattice vector + lattvec3 (3 length list of floats): third lattice vector + elements (comma-separated list of strings): list of elements present + types (natoms length list of ints): atom types listed in the same order as in 'elements' (first atom should be '1') + positions (natoms x 3 matrix): atomic positions of each atom + scell (3 length list of ints): dimensions of supercell input + ***temperature (int): temperature in Kelvin? + scalebroad (float): Gaussian broadening of allowable energies that can scatter a phonon to a certain state + (higher broadening = more scattering allowed. Too high is unphysical. For complex + materials, make 'scalebroad' smaller since there will be more scattering candidates + for any given phonon. + ***onlyharmonic (bool): Whether to only consider harmonic scattering (2-phonon?) + ***isotopes (bool): Whether to consider scattering from isotopic disorder. + ***nonanalytic (bool): Used for Born effective charge and dielectric constant. + nanowires (bool): Whether the structure input is a nanowire. + + Returns: + IO reader/writer for ShengBTE's CONTROL file, composed of FORTRAN namelists + """ + + def __init__(self, nelements=None, natoms=None, elements=None, types=None, positions=None, ngrid=[25, 25, 25], + lfactor=0.1, lattvec1=[1, 0, 0], lattvec2=[0, 1, 0], lattvec3=[0, 0, 1], scell=[5, 5, 5], + temperature=500, scalebroad=0.5, onlyharmonic=False, isotopes=False, nonanalytic=True, + nanowires=False, norientations=0): + + self.nelements = nelements + self.natoms = natoms + self.ngrid = ngrid + self.norientations = norientations + self.lfactor = lfactor + self.lattvec1 = lattvec1 + self.lattvec2 = lattvec2 + self.lattvec3 = lattvec3 + self.elements = elements + self.types = types + self.positions = positions + self.scell = scell + self.temperature = temperature + self.scalebroad = scalebroad + self.onlyharmonic = onlyharmonic + self.isotopes = isotopes + self.nonanalytic = nonanalytic + self.nanowires = nanowires + + + def read_CONTROL(self, filename): + nml = f90nml.read(filename) + return nml + + def write_CONTROL(self): + with open('CONTROL.nml', 'w') as control_file: + nml = {'allocations': + {'nelements': self.nelements, + 'natoms': self.natoms, + 'ngrid': self.ngrid, + 'norientations': self.norientations}, + 'crystal': + {'lfactor': self.lfactor, + 'lattvec(:,1)': self.lattvec1, + 'lattvec(:,2)': self.lattvec2, + 'lattvec(:,3)': self.lattvec3, + 'elements': self.elements, + 'types': self.types, + 'scell': self.scell}, + 'parameters': + {'T': self.temperature, + 'scalebroad': self.scalebroad}, + 'flags': + {'onlyharmonic': self.onlyharmonic, + 'isotopes': self.isotopes, + 'nonanalytic': self.nonanalytic, + 'nanowires': self.nanowires}} + + #add positions to the dict + num_atoms, _ = self.positions.shape + for at in range(num_atoms): + at_position = 'positions(:,' + str(at+1) + ')' + nml['crystal'][at_position] = self.positions[at, :] + + f90nml.write(nml, control_file, force=True) #force=True overwrites an existing file From 38ce381c769b5023fc4a654ed885865884784667 Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 25 Jun 2019 17:12:02 -0700 Subject: [PATCH 009/207] V1, needs testing with csld_main --- .../workflows/base/scrape_forces_from_DB.py | 85 +++++++++++++++++++ 1 file changed, 85 insertions(+) create mode 100644 atomate/vasp/workflows/base/scrape_forces_from_DB.py diff --git a/atomate/vasp/workflows/base/scrape_forces_from_DB.py b/atomate/vasp/workflows/base/scrape_forces_from_DB.py new file mode 100644 index 000000000..90178a709 --- /dev/null +++ b/atomate/vasp/workflows/base/scrape_forces_from_DB.py @@ -0,0 +1,85 @@ +#!/usr/bin/env python3 + + +import numpy as np +from pymongo import MongoClient + + +# MongoDB database settings/details +host = "brmyvxghlvvkgkx-mongodb.services.clever-cloud.com" +port = 27017 +database_name = "brmyvxghlvvkgkx" +username = "usxrmfzwh9ed1plwi027" +password = "JJGXekEfnNYtXQSBYHv8" + +# Connect to the database +db = MongoClient(host, port)[database_name] +db.authenticate(username, password) +tasks = db.tasks #connects to the 'tasks' collection + +""" +This module defines IO ShengBTE for making CONTROL file (i.e. a class that can read/write the ‘control’ file, f90ml) + +TO-DO: Test this thing with csld_main +""" + +def scrape_forces_to_txt(task_id): + # Input a Firetask task_id (int) + # Output a .txt with all the atomic forces + + forces_list = tasks.find_one({'task_id': task_id})['calcs_reversed'][0]['output']['ionic_steps'][0]['forces'] + # print(forces_list) + # print(len(forces_list)) + + num_atoms = len(forces_list) + forces = np.empty((num_atoms,3)) + for atom in range(num_atoms): + forces[atom,:] = forces_list[atom][:] + # print(forces) + np.savetxt('forces.txt', forces, fmt='%.6f') + + +def main(): + scrape_forces_to_txt(2) + + +if __name__ == '__main__': + main() + +# def get_structure_from_task_id(task_id): +# # Input a Firetask task_id (int) +# # Return the corresponding Pymatgen structure (Structure) +# try: +# return Structure.from_dict(tasks.find_one({"task_id": task_id})["input"]["structure"]) +# except: +# print("No structure with task id '{}' was found.".format(task_id)) +# +# +# +# def get_structures_from_formulaV2(formula, task_label=None): +# # Required: +# # Input a Pymatgen 'pretty formula' (String) +# # Optional: +# # Input a 'task_label' or substring of a 'task_label' (String) +# # Return the corresponding Pymatgen Structures (list) +# +# structs = [] +# try: +# query = {"formula_pretty": formula} +# if task_label is not None and isinstance(task_label, str): +# # query["$and"] += [{"task_label": task_label}] +# query["task_label"] = {"$regex": task_label} +# dicts = list(tasks.find(query, ["input.structure"])) +# +# # dicts = list(tasks.find({"$and": [{"formula_pretty": formula}, +# # {"task_label": task_label}]}, +# # ["input.structure"])) +# for dict in dicts: +# struct = Structure.from_dict(dict["input"]["structure"]) +# structs += [struct] +# return structs +# except: +# if isinstance(formula, str): +# print("No structures with the formula '{}' found.".format(formula)) +# else: +# print("Entered formula is not a string.") From 74fb2b09fe5c32e7783e4d2e59a2f23f48cfcfbb Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 26 Jun 2019 11:54:05 -0700 Subject: [PATCH 010/207] Revised script and tested for reading, updating, and writing namelist files from a Python dict. --- atomate/vasp/workflows/base/sbte_IO.py | 91 ++++++++++++-------------- 1 file changed, 41 insertions(+), 50 deletions(-) diff --git a/atomate/vasp/workflows/base/sbte_IO.py b/atomate/vasp/workflows/base/sbte_IO.py index 9a4d505bd..a86b09246 100644 --- a/atomate/vasp/workflows/base/sbte_IO.py +++ b/atomate/vasp/workflows/base/sbte_IO.py @@ -38,63 +38,54 @@ class ShengBTE_CONTROL_IO: IO reader/writer for ShengBTE's CONTROL file, composed of FORTRAN namelists """ - def __init__(self, nelements=None, natoms=None, elements=None, types=None, positions=None, ngrid=[25, 25, 25], - lfactor=0.1, lattvec1=[1, 0, 0], lattvec2=[0, 1, 0], lattvec3=[0, 0, 1], scell=[5, 5, 5], - temperature=500, scalebroad=0.5, onlyharmonic=False, isotopes=False, nonanalytic=True, - nanowires=False, norientations=0): - - self.nelements = nelements - self.natoms = natoms - self.ngrid = ngrid - self.norientations = norientations - self.lfactor = lfactor - self.lattvec1 = lattvec1 - self.lattvec2 = lattvec2 - self.lattvec3 = lattvec3 - self.elements = elements - self.types = types - self.positions = positions - self.scell = scell - self.temperature = temperature - self.scalebroad = scalebroad - self.onlyharmonic = onlyharmonic - self.isotopes = isotopes - self.nonanalytic = nonanalytic - self.nanowires = nanowires - - def read_CONTROL(self, filename): nml = f90nml.read(filename) return nml - def write_CONTROL(self): - with open('CONTROL.nml', 'w') as control_file: + def write_CONTROL_from_dict(self, dict, filename='CONTROL'): + with open(filename, 'w') as control_file: nml = {'allocations': - {'nelements': self.nelements, - 'natoms': self.natoms, - 'ngrid': self.ngrid, - 'norientations': self.norientations}, + {'nelements': dict.get('allocations', None).get('nelements', None), + 'natoms': dict.get('allocations', None).get('natoms', None), + 'ngrid': dict.get('allocations', [25, 25, 25]).get('ngrid', [25, 25, 25]), + 'norientations': dict.get('allocations', 0).get('norientations', 0)}, 'crystal': - {'lfactor': self.lfactor, - 'lattvec(:,1)': self.lattvec1, - 'lattvec(:,2)': self.lattvec2, - 'lattvec(:,3)': self.lattvec3, - 'elements': self.elements, - 'types': self.types, - 'scell': self.scell}, + {'lfactor': dict.get('crystal', 0.1).get('lfactor', 0.1), + # 'lattvec(:,1)': dict.get('crystal', None).get('lattvec(:,1)', None), + # 'lattvec(:,2)': dict.get('crystal', None).get('lattvec(:,2)', None), + # 'lattvec(:,3)': dict.get('crystal', None).get('lattvec(:,3)', None), + 'lattvec': dict.get('crystal', None).get('lattvec', None), + 'positions': dict.get('crystal', None).get('positions', None), + 'elements': dict.get('crystal', None).get('elements', None), + 'types': dict.get('crystal', None).get('types', None), + 'scell': dict.get('crystal', [5, 5, 5]).get('scell', [5, 5, 5])}, 'parameters': - {'T': self.temperature, - 'scalebroad': self.scalebroad}, + {'T': dict.get('parameters', 500).get('T', 500), + 'scalebroad': dict.get('parameters', 0.5).get('scalebroad', 0.5)}, 'flags': - {'onlyharmonic': self.onlyharmonic, - 'isotopes': self.isotopes, - 'nonanalytic': self.nonanalytic, - 'nanowires': self.nanowires}} - - #add positions to the dict - num_atoms, _ = self.positions.shape - for at in range(num_atoms): - at_position = 'positions(:,' + str(at+1) + ')' - nml['crystal'][at_position] = self.positions[at, :] + {'onlyharmonic': dict.get('flags', False).get('onlyharmonic', False), + 'isotopes': dict.get('flags', False).get('isotopes', False), + 'nonanalytic': dict.get('flags', True).get('nonanalytic', True), + 'nanowires': dict.get('flags', False).get('nanowires', False)}} f90nml.write(nml, control_file, force=True) #force=True overwrites an existing file + + +def main(): + # Read the CONTROL file into a Fortran namelist object + sbte_io = ShengBTE_CONTROL_IO() + namelist = sbte_io.read_CONTROL('CONTROL') + print(namelist) + print('---------------------') + + # Convert the namelist object to a dict for easy access of contents + dict = namelist.todict() + print(dict) + print(dict['allocations']['nelements']) + + # Write the dict back into a namelist file + sbte_io.write_CONTROL_from_dict(dict, filename='CONTROL_test') + + +if __name__ == '__main__': + main() \ No newline at end of file From 9aaa03defae21b955a8297ba7a97ad53a0010230 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 26 Jun 2019 14:26:09 -0700 Subject: [PATCH 011/207] fixed some bugs and added a working test case in main(). Imports csld_sc_gen --- .../vasp/workflows/base/CSLD_sc_enumerator.py | 152 ++++++++++++------ .../base/{csld.py => csld_sc_gen.py} | 2 +- 2 files changed, 108 insertions(+), 46 deletions(-) rename atomate/vasp/workflows/base/{csld.py => csld_sc_gen.py} (99%) diff --git a/atomate/vasp/workflows/base/CSLD_sc_enumerator.py b/atomate/vasp/workflows/base/CSLD_sc_enumerator.py index 5f9121050..b37f9ad54 100644 --- a/atomate/vasp/workflows/base/CSLD_sc_enumerator.py +++ b/atomate/vasp/workflows/base/CSLD_sc_enumerator.py @@ -1,8 +1,5 @@ #!/usr/bin/env python3 -import os -import sys - import numpy as np """ @@ -14,25 +11,47 @@ class CSLDPerturbedSupercellEnumerator: Uses a supercell Structure, a transformation matrix, a min/max displacement, number of displacement values, and number of supercells per displacement to generate a list of randomly perturbed supercells from a given supercell. + + Args: + original_supercell (Structure): supercell to displace, typically already relaxed + max_displacement_val (float): maximum displacement value for perturbing the supercell (in Angstroms) + min_displacement_val (float): minimum displacement value for perturbing the supercell (in Angstroms) + num_displacements (int): number of unique displacement values to try, bounded by + min_displacement and max_displacement. This argument is ignored if min_displacement + is not passed as an argument. + scs_per_displacement_val (int): number of perturbed supercells to generate for each unique + displacement value. + + floor_displacement (Optional float): If None (default), then for a given perturbed supercell, all atoms will + move the same distance from their original locations. If float, then for a given perturbed supercell, + the distances that atoms move will be uniformly distributed from a minimum value of 'floor_displacement' + to the displacement value 'displacement_val'. + """ def __init__(self, original_supercell, - transformation_matrix, - min_displacement, - max_displacement, + max_displacement_val, + min_displacement_val, num_displacements, - scs_per_displacement): + scs_per_displacement_val, + floor_displacement=None): - self.supercell = original_supercell - self.trans_mat = transformation_matrix - self.min_disp = min_displacement - self.max_disp = max_displacement + self.original_supercell = original_supercell + self.max_disp_val = max_displacement_val + self.min_disp_val = min_displacement_val self.num_disps = num_displacements - self.scs_per_disp = scs_per_displacement - self.perturbed_supercells = [] + self.scs_per_disp_val = scs_per_displacement_val + if floor_displacement is not None: + self.floor_disp = float(floor_displacement) + else: + self.floor_disp = None - def random_displacements(self, natom, rmax, rmin=None, dim=3): + self.disp_vals = np.linspace(min_displacement_val, max_displacement_val, num=num_displacements) + self.perturbed_supercells = self.generate_transformations() + + + def random_displacements(self, natom, rmax, rmin, dim=3): #*** Adapted from csld.util.mathtool # Generate matrix of size (natom, 3) where each row is a Gaussian random vector @@ -41,7 +60,7 @@ def random_displacements(self, natom, rmax, rmin=None, dim=3): dx = np.random.normal(size=(natom, dim)) #Gaussian sampled displacements. Matrix size: (natom, 3) dx_norms = np.linalg.norm(dx, axis=1) - veclen = np.full(natom, rmax) if rmax is None else np.random.uniform(rmin, rmax, natom) + veclen = np.full(natom, rmax) if rmin is None else np.random.uniform(rmin, rmax, natom) if not 0 in dx_norms: return dx * (veclen / dx_norms)[:, None] @@ -49,56 +68,99 @@ def random_displacements(self, natom, rmax, rmin=None, dim=3): self.random_displacements(natom, rmax, rmin, dim) - def perturb_supercell(self, structure, disp): + def perturb_supercell(self, structure, max_disp, floor_disp): # *** Adapted from CSLD's 'polaron_main' file na = structure.num_sites - disp = float(disp) - if isinstance(disp, float): + max_disp = float(max_disp) + if isinstance(max_disp, float): # from csld.util.mathtool import random_displacements - dr = self.random_displacements(na, disp) #generate random displacements + dr = self.random_displacements(na, max_disp, floor_disp) #generate random displacements # Perturb structure with the random displacements for i in range(len(structure._sites)): structure.translate_sites([i], dr[i], frac_coords=False, to_unit_cell=True) + return structure else: print('displacement entered is not a float.') def generate_transformations(self): - for disp_val in range(self.num_disps): - for cell in range(self.scs_per_disp): + perturbed_supercells = [] + for disp_val in self.disp_vals: + for cell in range(self.scs_per_disp_val): sc = self.original_supercell.copy() - self.perturb_supercell(sc, self.max_disp) - self.perturbed_supercells += [sc] + sc = self.perturb_supercell(sc, disp_val, self.floor_disp) + perturbed_supercells += [sc] + return perturbed_supercells #################################### # BELOW IS FOR DEBUGGING PURPOSES # #################################### def main(): - print('test') - natom = 10 - dim = 3 - rmin = 0 - rmax = 0.1 - dx = np.random.normal(size=(natom, dim)) # Gaussian sampled displacements. Matrix size: (natom, 3) - print(dx.shape) - veclen = np.full(natom, rmin) if rmax is None else np.random.uniform(rmin, rmax, natom) # vector of length natom - dx *= (veclen / np.linalg.norm(dx, axis=1))[:, None] - test = (veclen / np.linalg.norm(dx, axis=1))[:, None] - print(test.shape) - - x = np.array([[1, 1, 1], - [1, 1, 1], - [1, 1, 1], - [1, 1, 1]]) - y = np.array([[1], - [2], - [3], - [4]]) - print(x*y) - + # print('test') + # natom = 10 + # dim = 3 + # rmin = 0 + # rmax = 0.1 + # dx = np.random.normal(size=(natom, dim)) # Gaussian sampled displacements. Matrix size: (natom, 3) + # print(dx.shape) + # veclen = np.full(natom, rmin) if rmax is None else np.random.uniform(rmin, rmax, natom) # vector of length natom + # dx *= (veclen / np.linalg.norm(dx, axis=1))[:, None] + # test = (veclen / np.linalg.norm(dx, axis=1))[:, None] + # print(test.shape) + # + # x = np.array([[1, 1, 1], + # [1, 1, 1], + # [1, 1, 1], + # [1, 1, 1]]) + # y = np.array([[1], + # [2], + # [3], + # [4]]) + # print(x*y) + + from atomate.vasp.workflows.base.csld_sc_gen import gen_scaling_matrix + + from pymatgen.ext.matproj import MPRester + from pymatgen.analysis.structure_analyzer import get_max_bond_lengths + from pymatgen.transformations.standard_transformations import SupercellTransformation + + mpr = MPRester(api_key='auNIrJ23VLXCqbpl') + # structure = mpr.get_structure_by_material_id('mp-7814') #passed + structure = mpr.get_structure_by_material_id('mp-1101039') # passed + # structure = mpr.get_structure_by_material_id('mp-20012') + + print('structure loaded') + print(structure.num_sites) + # print('structure') + # print(structure) + # structure.to(fmt='poscar', filename='POSCAR-tlbise2-scraped') + + # # Find Primitive + # from pymatgen.symmetry.analyzer import SpacegroupAnalyzer + # sga = SpacegroupAnalyzer(structure) + # # print(sga.find_primitive().lattice) + # sga.find_primitive().to(fmt='poscar', filename='POSCAR-tlbise2-scraped-prim') + + T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150, max_atoms=1000) + # ***my function, pymatgen's SupercellTransformation, and CSLD all yield different supercell lattice vectors + + print('~~~~~~~~~~~~~~~~~~~~~~~~~') + print("FINISHED2") + # print(T) + + # Pymatgen version + superstructure = SupercellTransformation(T).apply_transformation(structure) + + enum = CSLDPerturbedSupercellEnumerator(superstructure, + max_displacement_val=0.05, + min_displacement_val=0.01, + num_displacements=2, + scs_per_displacement_val=1) + print('perturbed supercells list:') + print(enum.perturbed_supercells) if __name__ == '__main__': diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld_sc_gen.py similarity index 99% rename from atomate/vasp/workflows/base/csld.py rename to atomate/vasp/workflows/base/csld_sc_gen.py index f440a9212..6fa54d80e 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld_sc_gen.py @@ -173,7 +173,7 @@ def main(): # sga.find_primitive().to(fmt='poscar', filename='POSCAR-tlbise2-scraped-prim') - T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150, max_atoms=1) + T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150, max_atoms=1000) #***my function, pymatgen's SupercellTransformation, and CSLD all yield different supercell lattice vectors print('~~~~~~~~~~~~~~~~~~~~~~~~~') From de011a9a8a2fe17016b4f4190593057c785600c7 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 26 Jun 2019 16:35:09 -0700 Subject: [PATCH 012/207] Made a custom IO writer from a dict to a string to a file since f90nml was not writing files in format that was readable by ShengBTE. --- atomate/vasp/workflows/base/sbte_IO.py | 145 ++++++++++++++++++++----- 1 file changed, 117 insertions(+), 28 deletions(-) diff --git a/atomate/vasp/workflows/base/sbte_IO.py b/atomate/vasp/workflows/base/sbte_IO.py index a86b09246..ffd465645 100644 --- a/atomate/vasp/workflows/base/sbte_IO.py +++ b/atomate/vasp/workflows/base/sbte_IO.py @@ -1,6 +1,7 @@ #!/usr/bin/env python3 import f90nml +import numpy as np """ This module defines IO ShengBTE for making CONTROL file (i.e. a class that can read/write the ‘control’ file, f90ml) @@ -10,7 +11,6 @@ class ShengBTE_CONTROL_IO: """ - Args: nelements (int): number of elements in the material natoms (int): number of atoms in the cell @@ -42,33 +42,120 @@ def read_CONTROL(self, filename): nml = f90nml.read(filename) return nml - def write_CONTROL_from_dict(self, dict, filename='CONTROL'): + + + def file_writer_helper_func(self, dict, filename): + nelements = str(dict['allocations']['nelements']) + natoms = str(dict['allocations']['natoms']) + ngrid = dict['allocations']['ngrid'] + norientations = str(dict['allocations']['norientations']) + + lfactor = str(dict['crystal']['lfactor']) + lattvec1 = dict['crystal']['lattvec'][0] + lattvec2 = dict['crystal']['lattvec'][1] + lattvec3 = dict['crystal']['lattvec'][2] + elements = dict['crystal']['elements'] #string or list of strings, needs to be parsed + types = dict['crystal']['types'] #list of ints, needs to be parsed + positions = np.asarray(dict['crystal']['positions']) #numpy array, needs to be parsed + num_sites, _ = positions.shape + scell = dict['crystal']['scell'] #list of ints, needs to be parsed + + temperature = str(int(dict['parameters']['T'])) + scalebroad = str(dict['parameters']['scalebroad']) + + onlyharmonic = dict['flags']['onlyharmonic'] + isotopes = dict['flags']['isotopes'] + nonanalytic = dict['flags']['nonanalytic'] + nanowires = dict['flags']['nanowires'] + + def boolean_to_string(boolean): + if boolean is True: + return '.TRUE.' + else: + return '.FALSE.' + + indent = ' ' + types_string ='types=' + positions_string = '' + for line in range(num_sites): + if line != num_sites-1: + types_string += str(types[line])+' ' + else: + types_string += str(types[line])+',\n' + positions_string += 'positions(:,' + str(line+1) + ')=' + str(positions[line,0]) + ' ' \ + + str(positions[line,1]) + ' ' + str(positions[line,2]) + ',\n' + indent + + full_string = '&allocations\n'+indent+'nelements='+nelements+',\n' + full_string += indent+'natoms='+natoms+',\n' + full_string += indent+'ngrid(:)='+str(ngrid[0])+' '+str(ngrid[1])+' '+str(ngrid[2])+'\n' + full_string += indent+'norientations='+norientations+'\n' + full_string += '&end\n&crystal\n' + full_string += indent+'lfactor='+lfactor+',\n' + full_string += indent+'lattvec(:,1)='+str(lattvec1[0])+' '+str(lattvec1[1])+' '+str(lattvec1[2])+',\n' + full_string += indent+'lattvec(:,2)='+str(lattvec2[0])+' '+str(lattvec2[1])+' '+str(lattvec2[2])+',\n' + full_string += indent+'lattvec(:,3)='+str(lattvec3[0])+' '+str(lattvec3[1])+' '+str(lattvec3[2])+',\n' + full_string += indent+'elements=' + if isinstance(elements, list): + for i in range(len(elements)): + full_string += '\"'+elements[i]+str('\"') + if i != (len(elements)-1): + full_string += ' ' + else: + full_string += '\n' + else: + full_string += '\"'+elements+str('\"\n') + full_string += indent+types_string + full_string += indent+positions_string + full_string += 'scell(:)='+str(scell[0])+' '+str(scell[1])+' '+str(scell[2])+'\n' + full_string += '&end\n¶meters\n' + full_string += indent+'T='+temperature+'\n' + full_string += indent+'scalebroad='+scalebroad+'\n' + full_string += '&end\n&flags\n' + full_string += indent+'isotopes='+boolean_to_string(isotopes)+'\n' + full_string += indent+'onlyharmonic='+boolean_to_string(onlyharmonic)+'\n' + full_string += indent+'nonanalytic='+boolean_to_string(nonanalytic)+'\n' + full_string += indent+'nanowires='+boolean_to_string(nanowires)+'\n' + full_string += '&end' + + file = open(filename, 'w+') + file.write(full_string) + file.close() + + + def write_CONTROL_from_dict(self, dict, filename='CONTROL', overwrite=True): with open(filename, 'w') as control_file: - nml = {'allocations': - {'nelements': dict.get('allocations', None).get('nelements', None), - 'natoms': dict.get('allocations', None).get('natoms', None), - 'ngrid': dict.get('allocations', [25, 25, 25]).get('ngrid', [25, 25, 25]), - 'norientations': dict.get('allocations', 0).get('norientations', 0)}, - 'crystal': - {'lfactor': dict.get('crystal', 0.1).get('lfactor', 0.1), - # 'lattvec(:,1)': dict.get('crystal', None).get('lattvec(:,1)', None), - # 'lattvec(:,2)': dict.get('crystal', None).get('lattvec(:,2)', None), - # 'lattvec(:,3)': dict.get('crystal', None).get('lattvec(:,3)', None), - 'lattvec': dict.get('crystal', None).get('lattvec', None), - 'positions': dict.get('crystal', None).get('positions', None), - 'elements': dict.get('crystal', None).get('elements', None), - 'types': dict.get('crystal', None).get('types', None), - 'scell': dict.get('crystal', [5, 5, 5]).get('scell', [5, 5, 5])}, - 'parameters': - {'T': dict.get('parameters', 500).get('T', 500), - 'scalebroad': dict.get('parameters', 0.5).get('scalebroad', 0.5)}, - 'flags': - {'onlyharmonic': dict.get('flags', False).get('onlyharmonic', False), - 'isotopes': dict.get('flags', False).get('isotopes', False), - 'nonanalytic': dict.get('flags', True).get('nonanalytic', True), - 'nanowires': dict.get('flags', False).get('nanowires', False)}} - - f90nml.write(nml, control_file, force=True) #force=True overwrites an existing file + new_dict = {'allocations': + {'nelements': dict.get('allocations', None).get('nelements', None), + 'natoms': dict.get('allocations', None).get('natoms', None), + 'ngrid': dict.get('allocations', [25, 25, 25]).get('ngrid', [25, 25, 25]), + 'norientations': dict.get('allocations', 0).get('norientations', 0)}, + 'crystal': + {'lfactor': dict.get('crystal', 0.1).get('lfactor', 0.1), + # 'lattvec(:,1)': dict.get('crystal', None).get('lattvec(:,1)', None), + # 'lattvec(:,2)': dict.get('crystal', None).get('lattvec(:,2)', None), + # 'lattvec(:,3)': dict.get('crystal', None).get('lattvec(:,3)', None), + 'lattvec': dict.get('crystal', None).get('lattvec', None), + 'elements': dict.get('crystal', None).get('elements', None), + 'types': dict.get('crystal', None).get('types', None), + 'positions': dict.get('crystal', None).get('positions', None), + 'scell': dict.get('crystal', [5, 5, 5]).get('scell', [5, 5, 5])}, + 'parameters': + {'T': dict.get('parameters', 300).get('t', 300), + 'scalebroad': dict.get('parameters', 0.5).get('scalebroad', 0.5)}, + 'flags': + {'onlyharmonic': dict.get('flags', False).get('onlyharmonic', False), + 'isotopes': dict.get('flags', False).get('isotopes', False), + 'nonanalytic': dict.get('flags', True).get('nonanalytic', True), + 'nanowires': dict.get('flags', False).get('nanowires', False)}} + + # nml = f90nml.namelist.Namelist(new_dict) #convert dict to namelist object + # nml.false_repr = '.FALSE.' + # nml.true_repr = '.TRUE.' + # nml.index_spacing = False + # nml.uppercase = False + # nml.indent = ' ' + # f90nml.write(nml, control_file, force=overwrite, sort=False) #force=True overwrites an existing file + self.file_writer_helper_func(new_dict, filename=filename) def main(): @@ -82,9 +169,11 @@ def main(): dict = namelist.todict() print(dict) print(dict['allocations']['nelements']) + print(dict['crystal']['lattvec']) + print(dict['crystal']['lattvec'][0]) # Write the dict back into a namelist file - sbte_io.write_CONTROL_from_dict(dict, filename='CONTROL_test') + sbte_io.write_CONTROL_from_dict(dict, filename='CONTROL_test2') if __name__ == '__main__': From 2692be06e7d5d09e18d1405b417ea41b5388f205 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 10 Jul 2019 16:50:10 -0700 Subject: [PATCH 013/207] CSLD workflow first try --- atomate/vasp/firetasks/parse_outputs.py | 271 ++++++++++++++++++++++++ atomate/vasp/workflows/base/csld.py | 158 ++++++++++++++ 2 files changed, 429 insertions(+) create mode 100644 atomate/vasp/workflows/base/csld.py diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 0b4935abc..9a9281fd1 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1754,6 +1754,277 @@ def split_abc(var, var_name): coll = vaspdb.db["polarization_tasks"] coll.insert_one(polarization_dict) +@explicit_serialize +class PerformCSLDMinimization(FiretaskBase): + """ + Used to aggregate atomic forces of perturbed supercells in compressed + sensing lattice dynamics (CSLD) workflow and generate interatomic force + constants. + + Required parameters: + db_file (str): path to the db file that holds your tasks + collection and that you want to hold the magnetic_orderings + collection + wf_uuid (str): auto-generated from get_wf_magnetic_orderings, + used to make it easier to retrieve task docs + parent_structure (Structure): material that CSLD is being run on + forces_paths (list of str): paths to directories containing 'force.txt' + files + csld_settings (ConfigParser): settings for running CSLD + csld_options (dict): options for running CSLD + # Optional parameters: + # to_db (bool): if True, the data will be inserted into + # dedicated collection in database, otherwise, will be dumped + # to a .json file. + """ + + required_params = ["db_file", "wf_uuid", "parent_structure", "forces_paths", + # "csld_settings", "csld_options", + + "trans_mat", "supercell_structure", + "disps"] + + def set_params(self, iteration_number, cluster_diam, max_order, submodel1, export_sbte): + from configparser import ConfigParser + supercell_folder = self["parent_structure"].composition.reduced_formula + \ + "_supercell_iter" + str(iteration_number) + os.mkdir(supercell_folder) + np.savetxt(supercell_folder + "/sc.txt", self["trans_mat"], fmt="%.0f", + delimiter=" ") + self["supercell_structure"].to("poscar", filename=supercell_folder + "/SPOSCAR") + + disp_folders = [] + csld_traindat_disp_folders = '' + for disp in self["disps"]: + disp_folder = supercell_folder+'/disp'+str(disp) + disp_folders += [disp_folder] + csld_traindat_disp_folders += ' ' + str(disp_folder) + os.mkdir(disp_folder) + + # Parameters for conducting CSLD + csld_traindat_string = supercell_folder + '/SPOSCAR' + csld_traindat_string += csld_traindat_disp_folders + + csld_settings = ConfigParser() + csld_settings['convergence_info'] = { + 'iteration': 0, + 'settings_tried': {} + } + csld_settings['structure'] = { + 'prim': 'POSCAR', + 'sym_tol': '1e-3', + 'epsilon_inf': None, # check how it reads 3x3 matrix + 'born_charge': None # check reading n_atom*9 numbers + } + csld_settings['model'] = { + 'model_type': 'LD', + 'cluster_in': 'clusters.out', + 'cluster_out': 'clusters.out', + 'symC_in': 'Cmat.mtx', + 'symC_out': 'Cmat.mtx', + 'max_order': max_order, #3, # this should be variable + 'fractional_distance': False, + 'cluster_diameter': cluster_diam, #'11 6.5 5.0', #this should be variable + 'cluster_filter': lambda cls: ((cls.order_uniq <= 2) + or (cls.bond_counts(2.9) >= 2)) + and cls.is_small_in( + supercell_folder + "/sc.txt") + # rewrote how it reads the trans_mat + } + csld_settings['training'] = { + 'interface': 'VASP', + 'corr_type': 'f', + 'corr_in': 'Amat.mtx', + 'corr_out': 'Amat.mtx', + 'fval_in': 'fval.txt', + 'fval_out': 'fval.txt', + 'traindat1': csld_traindat_string + # 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' + # Rewrote how it reads forces + } + csld_settings['fitting'] = { + 'solution_in': 'solution_all', + 'solution_out': 'solution_all', + 'nsubset': 5, + 'holdsize': 0.1, + ## 1 FPC 2 FPC sparse 3 split 4 sparse split + ## 5 split+ right preconditioning 6 sparse split + r preconditioning + ## 101 Bayesian CS + 'method': 5, + + # For weight of L1 or L2 regularization + 'mulist': '1E-5 1E-7 1E-9 1E-11', + 'maxIter': 300, + 'tolerance': 1E-6, + 'subsetsize': 0.85, + 'lambda': 0.5, + 'uscale_list': '0.03', + 'submodel1': submodel1, #'anh 0 1 2 3', # this should be variable + } + csld_settings['phonon'] = { + 'qpoint_fractional': False, + # 'Auto' or something like "[[10, [0,0,0],'\\Gamma', [0.5,0.5,0.5], 'X', [0.5,0.5,0], 'K']]" + 'wavevector': "[[25, [0,0,0],'\Gamma', [0,0.5,0.5], 'X']," + " [25, [1,0.5,0.5], 'X', [0.75,0.375,0.375], " + "'K', [0,0,0], '\Gamma', [0.5, 0.5, 0.5], 'L']]", + 'unit': 'meV', # THz, meV, eV, cm + + # number of grid points + 'dos_grid': '15 15 15', + + # number of points in DOS + 'nE_dos': 500, + + ## 0 (Gaussian), 1 (Lorentzian), -1 (tetrahedron method) + 'ismear': -1, + + ## width in THz of Gaussian/Lorentzian smearing + 'epsilon': 0.05, + 'pdos': True, + + 'thermal_T_range': '50 800 50', + 'thermal_out': 'thermal_out.txt' + } + csld_settings['export_potential'] = { + 'export_shengbte': export_sbte, #'5 5 5 2 3' # 5x5x5 supercell + # 2 and 3 orders to be considered + # should be variable? + } + csld_settings['prediction'] = { + 'interface': 'VASP', + 'corr_type': 'f', + 'corr_in': 'Amat_pred.mtx', + 'corr_out': 'Amat_pred.mtx', + 'fval_in': 'fval_pred.txt', + 'fval_out': 'fval_pred.txt', + 'traindat0': 'fcc222/POSCAR fcc222/traj*' + } + # set default values + csld_settings['DEFAULT'] = { + "qpoint_fractional": False, + "true_v_fit": 'true_fit.txt', + 'epsilon': '0.05', + "bcs_reweight": 'True', + "bcs_penalty": 'arctan', + "bcs_jcutoff": '1E-8'} + + csld_options = {} + csld_options['pdfout'] = 'plots.pdf' + csld_options['ldff_step'] = 0 + csld_options['phonon_step'] = 1 + csld_options['phonon'] = False + csld_options['save_pot_step'] = 0 # WHAT DOES THIS NEED TO BE? + csld_options['pot'] = False + + self["csld_settings"] = csld_settings + self["csld_options"] = csld_options + + def run_task(self, fw_spec): + + iter = 0 + not_converged = True + maxIter = 10 + convergence_info_dict = self["csld_settings"]["convergence_info"] + summaries = [] + + #FILL THESE IN FURTHER + cluster_diam_settings = ['11 6.5 5.0'] + max_order_settings = [3] + submodel1_settings = ['anh 0 1 2 3'] + export_sbte_settings = ['5 5 5 2 3'] + + while not_converged or iter < maxIter: + self.set_params(iter, + cluster_diam_settings[iter], + max_order_settings[iter], + submodel1_settings[iter], + export_sbte_settings[iter]) + + uuid = self["wf_uuid"] + db_file = env_chk(self.get("db_file"), fw_spec) + + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + tasks = mmdb["tasks"] + formula = self["parent_structure"].formula + formula_pretty = self["parent_structure"].composition.reduced_formula + task_label = 'static' + supercells_dicts = list(tasks.find({"wf_meta.wf_uuid": uuid, + "task_label": {"$regex": task_label}, + "formula_pretty": formula_pretty}, + ['task_id', 'output.forces'])) + #list of dicts where each dict contatins a task_id and a list of forces + # for each supercell + + supercells_forces = [] + supercells_task_ids = [] + for supercell_dict in supercells_dicts: + #List of np.ndarrays where each np.ndarray is a matrix of forces + # for a perturbed supercell + supercells_forces += [np.asarray(supercell_dict['output']['forces'])] + + #List of task ids for each perturbed supercell + supercells_task_ids += [supercell_dict['task_id']] + + supercell_idx = 0 + for supercell_forces in supercells_forces: + path = self["forces_paths"][supercell_idx] + np.savetxt(path + "/force.txt", supercell_forces, fmt='%.6f') + + #Perform csld minimization now + import scripts.csld_main_rees as csld_main + rel_err, freq_matrix = csld_main.main(self["csld_options"], + self["csld_settings"]) + freq_matrix = np.asarray(freq_matrix) + imaginary_idx = freq_matrix < 0 + imaginary_freqs = freq_matrix[imaginary_idx] + num_imaginary_bands = np.any(imaginary_idx, axis=1) + most_imaginary_freq = np.amin(imaginary_freqs) + # For imaginary frequencies, w^2 is negative + # code handles it as w = sign(sqrt(abs(w^2)), w^2) + + if num_imaginary_bands == 0: + not_converged = False + + #Save to DB + summary = { + "formula": formula, + "formula_pretty": formula_pretty, + "parent_structure": self["parent_structure"].as_dict(), + "wf_meta": {"wf_uuid": uuid}, + + # + "iteration": iter, + "cluster_diam": self["csld_settings"]["model"]["cluster_diameter"], + "max_order": self["csld_settings"]["model"]["max_order"], + "submodel1": self["csld_settings"]["fitting"]["submodel1"], + "export_potential": self["csld_settings"]["export_potential"]["export_shengbte"], + + "cross_val_error": rel_err, + "num_imaginary_modes": num_imaginary_bands, #number or percent? + "most_imaginary_freq": most_imaginary_freq + } + latest_settings = {str(convergence_info_dict["iteration"]): + {self["csld_settings"]["model"]["max_order"], + self["csld_settings"]["fitting"]["submodel1"], + self["csld_settings"]["export_potential"][ + "export_shengbte"]}} + convergence_info_dict["iteration"] += 1 + convergence_info_dict["settings_tried"].update(latest_settings) + + if fw_spec.get("tags", None): + summary["tags"] = fw_spec["tags"] + + summaries.append(summary) + + mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] + mmdb.collection.insert(summaries) + + if iter < maxIter: + logger.info("Compressed Sensing Lattice Dynamics calculation complete.") + else: + logger.info("Compressed Sensing Lattice Dynamics calculation failed." + "Max iterations was reached.") + # the following definitions for backward compatibility class VaspToDbTask(VaspToDb): diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py new file mode 100644 index 000000000..23df7e6b5 --- /dev/null +++ b/atomate/vasp/workflows/base/csld.py @@ -0,0 +1,158 @@ +# coding: utf-8 + +import os + +import numpy as np +from uuid import uuid4 +from pymatgen.alchemy.materials import TransformedStructure +from pymatgen.transformations.advanced_transformations import ( + CubicSupercellTransformation, + PerturbSitesTransformation +) +from fireworks import Workflow, Firework +from atomate.utils.utils import get_logger +from atomate.vasp.config import VASP_CMD, DB_FILE, ADD_WF_METADATA # what is this? +from atomate.vasp.fireworks.core import StaticFW +from atomate.vasp.firetasks.parse_outputs import PerformCSLDMinimization + +from pymatgen.io.vasp.sets import MPStaticSet + +# NEW THINGS TO INSTALL? +from configparser import ConfigParser +from scripts import csld_main_rees #csld>scripts + +logger = get_logger(__name__) + +__author__ = "Rees Chang" +__email__ = "rc564@cornell.edu" +__date__ = "July 2019" + +__csld_wf_version__ = 1.0 + +class CompressedSensingLatticeDynamicsWF: + def __init__( + self, + parent_structure, + min_atoms=-np.Inf, + max_atoms=np.Inf, + num_nn_dists=5, + max_displacement=0.1, + min_displacement=0.01, + num_displacements=10, + supercells_per_displacement_distance=1, + min_random_distance=None, + #csld input params here + ): + """ + This workflow will use compressed sensing lattice dynamics (CSLD) + (doi: 10.1103/PhysRevLett.113.185501) to generate interatomic force + constants from an input structure and output a summary to a database. + + A summary of the workflow is as follows: + 1. Transform the input structure into a supercell + 2. Transform the supercell into a list of supercells with all atoms + randomly perturbed from their original sites + 3. Run static VASP calculations on each perturbed supercell to + calculate atomic forces. + 4. Aggregate the forces and conduct the CSLD minimization algorithm + to compute interatomic force constants. + 5. Output the interatomic force constants to the database. + + Args: + parent_structure (Structure): + min_atoms (int): + max_atoms (int): + num_nn_dists (int or float): + max_displacement (float) + """ + self.uuid = str(uuid4()) + self.wf_meta = { + "wf_uuid": self.uuid, + "wf_name": self.__class__.__name__, + } + + # Create supercell + self.parent_structure = parent_structure + self.min_atoms = min_atoms + self.max_atoms = max_atoms + self.num_nn_dists = num_nn_dists + supercell_transform = CubicSupercellTransformation( + self.min_atoms, + self.max_atoms, + self.num_nn_dists, + ) + # supercell (Structure) + self.supercell = supercell_transform.apply_transformation(self.parent_structure) + self.trans_mat = supercell_transform.trans_mat + + # Generate randomly perturbed supercells + perturbed_supercells_transform = PerturbSitesTransformation( + max_displacement, + min_displacement, + num_displacements, + supercells_per_displacement_distance, + min_random_distance + ) + # list of perturbed supercell structures (list) + self.perturbed_supercells = perturbed_supercells_transform.apply_transformation(self.supercell) + # list of (non-unique) displacement values used in the perturbation (np.ndarray) + self.disps = np.repeat(perturbed_supercells_transform.disps, + supercells_per_displacement_distance) + + + def get_wf( + self, + c=None + ): + fws = [] + c = c or {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} + + def _add_metadata(structure): + """ + Add metadata for easy querying from the database later. + """ + return TransformedStructure( + structure, other_parameters={"wf_meta": self.wf_meta} + ) + + user_incar_settings = {"NSW": 0, "LCHARG": False, "IBRION": -1} + user_incar_settings.update(c.get("user_incar_settings", {})) + + for idx, perturbed_supercell in enumerate(self.perturbed_supercells): + # Run static calculations on the perturbed supercells to compute forces on each atom + name = "perturbed supercell, idx: {}, disp_val: {},".format(idx, self.disps[idx]) + + + vis = MPStaticSet(perturbed_supercell, + user_incar_settings, + reciprocal_density=1) #@ALEX is this right/ok + # how to run vasp_gam instead of vasp_std? + fws.append(StaticFW( + perturbed_supercell, + vasp_input_set=vis, + vasp_cmd=c["VASP_CMD"], + db_file=c["DB_FILE"], + name=name + " static" + )) + + # Collect force constants from the DB and output on cluster + fw_collect_force_constants = Firework( + PerformCSLDMinimization( + db_file=c["DB_FILE"], # wot + wf_uuid=self.uuid, + csld_settings=self.csld_settings, + csld_options=self.csld_options, + forces_paths=self.disp_folders, + trans_mat=self.trans_mat, + supercell_structure=self.supercell, + disps=self.disps + ) + ) + + # Add a firework here to check for imaginary modes + + + formula = self.parent_structure.composition.reduced_formula + wf_name = "{} - compressed sensing lattice dynamics".format(formula) + wf = Workflow(fws, name=wf_name) + return wf \ No newline at end of file From d50ef73052947a7401de28b65c90349339d54a42 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 10 Jul 2019 16:57:35 -0700 Subject: [PATCH 014/207] quick change --- atomate/vasp/firetasks/parse_outputs.py | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 9a9281fd1..1fa15b2c2 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1933,6 +1933,9 @@ def run_task(self, fw_spec): submodel1_settings = ['anh 0 1 2 3'] export_sbte_settings = ['5 5 5 2 3'] + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + tasks = mmdb["tasks"] while not_converged or iter < maxIter: self.set_params(iter, cluster_diam_settings[iter], @@ -1941,10 +1944,7 @@ def run_task(self, fw_spec): export_sbte_settings[iter]) uuid = self["wf_uuid"] - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - tasks = mmdb["tasks"] formula = self["parent_structure"].formula formula_pretty = self["parent_structure"].composition.reduced_formula task_label = 'static' From 51117924aea92d5fcf0d4a4441a61dc699e5cf45 Mon Sep 17 00:00:00 2001 From: reeschang Date: Thu, 11 Jul 2019 14:04:18 -0700 Subject: [PATCH 015/207] Debugging stuff. First version that was launched on cori --- atomate/vasp/firetasks/parse_outputs.py | 13 ++-- atomate/vasp/workflows/base/csld.py | 79 +++++++++++++++++++------ 2 files changed, 66 insertions(+), 26 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 1fa15b2c2..632e9417a 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1755,7 +1755,7 @@ def split_abc(var, var_name): coll.insert_one(polarization_dict) @explicit_serialize -class PerformCSLDMinimization(FiretaskBase): +class CSLDForceConstantsToDB(FiretaskBase): """ Used to aggregate atomic forces of perturbed supercells in compressed sensing lattice dynamics (CSLD) workflow and generate interatomic force @@ -1768,8 +1768,6 @@ class PerformCSLDMinimization(FiretaskBase): wf_uuid (str): auto-generated from get_wf_magnetic_orderings, used to make it easier to retrieve task docs parent_structure (Structure): material that CSLD is being run on - forces_paths (list of str): paths to directories containing 'force.txt' - files csld_settings (ConfigParser): settings for running CSLD csld_options (dict): options for running CSLD # Optional parameters: @@ -1778,7 +1776,7 @@ class PerformCSLDMinimization(FiretaskBase): # to a .json file. """ - required_params = ["db_file", "wf_uuid", "parent_structure", "forces_paths", + required_params = ["db_file", "wf_uuid", "parent_structure", # "csld_settings", "csld_options", "trans_mat", "supercell_structure", @@ -1913,21 +1911,22 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor csld_options['ldff_step'] = 0 csld_options['phonon_step'] = 1 csld_options['phonon'] = False - csld_options['save_pot_step'] = 0 # WHAT DOES THIS NEED TO BE? + csld_options['save_pot_step'] = 1 # usual default is 0 csld_options['pot'] = False self["csld_settings"] = csld_settings self["csld_options"] = csld_options + self["forces_paths"] = disp_folders def run_task(self, fw_spec): iter = 0 not_converged = True - maxIter = 10 + maxIter = 1 convergence_info_dict = self["csld_settings"]["convergence_info"] summaries = [] - #FILL THESE IN FURTHER + # cluster_diam_settings = ['11 6.5 5.0'] max_order_settings = [3] submodel1_settings = ['anh 0 1 2 3'] diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 23df7e6b5..e53003aaa 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -13,13 +13,16 @@ from atomate.utils.utils import get_logger from atomate.vasp.config import VASP_CMD, DB_FILE, ADD_WF_METADATA # what is this? from atomate.vasp.fireworks.core import StaticFW -from atomate.vasp.firetasks.parse_outputs import PerformCSLDMinimization +from atomate.vasp.firetasks.parse_outputs import CSLDForceConstantsToDB +from atomate.vasp.powerups import ( + add_additional_fields_to_taskdocs +) from pymatgen.io.vasp.sets import MPStaticSet # NEW THINGS TO INSTALL? -from configparser import ConfigParser -from scripts import csld_main_rees #csld>scripts +# from configparser import ConfigParser +# from scripts import csld_main_rees #csld>scripts logger = get_logger(__name__) @@ -68,7 +71,7 @@ def __init__( self.uuid = str(uuid4()) self.wf_meta = { "wf_uuid": self.uuid, - "wf_name": self.__class__.__name__, + "wf_name": self.__class__.__name__, #"CompressedSensingLatticeDynamicsWF" } # Create supercell @@ -115,18 +118,24 @@ def _add_metadata(structure): structure, other_parameters={"wf_meta": self.wf_meta} ) - user_incar_settings = {"NSW": 0, "LCHARG": False, "IBRION": -1} + user_incar_settings = {"ADDGRID": True, #Fast Fourier Transform grid + "LCHARG": False, + "ENCUT": 700, + "EDIFF": 1e-7, #may need to tune this + "PREC": 'Accurate', + "LAECHG": False, + "LREAL": False, + "LASPH": True} user_incar_settings.update(c.get("user_incar_settings", {})) for idx, perturbed_supercell in enumerate(self.perturbed_supercells): # Run static calculations on the perturbed supercells to compute forces on each atom - name = "perturbed supercell, idx: {}, disp_val: {},".format(idx, self.disps[idx]) + name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format(idx, self.disps[idx]) vis = MPStaticSet(perturbed_supercell, - user_incar_settings, - reciprocal_density=1) #@ALEX is this right/ok - # how to run vasp_gam instead of vasp_std? + user_incar_settings=user_incar_settings) + fws.append(StaticFW( perturbed_supercell, vasp_input_set=vis, @@ -135,24 +144,56 @@ def _add_metadata(structure): name=name + " static" )) + print('DISPS') + print(self.disps) # Collect force constants from the DB and output on cluster - fw_collect_force_constants = Firework( - PerformCSLDMinimization( + csld_fw = Firework( + CSLDForceConstantsToDB( db_file=c["DB_FILE"], # wot wf_uuid=self.uuid, - csld_settings=self.csld_settings, - csld_options=self.csld_options, - forces_paths=self.disp_folders, + name='CSLDForceConstantsToDB', + parent_structure=self.parent_structure, trans_mat=self.trans_mat, supercell_structure=self.supercell, disps=self.disps - ) + ), + name="Compressed Sensing Lattice Dynamics", + parents=fws[-len(self.perturbed_supercells):] ) - - # Add a firework here to check for imaginary modes - + fws.append(csld_fw) formula = self.parent_structure.composition.reduced_formula wf_name = "{} - compressed sensing lattice dynamics".format(formula) wf = Workflow(fws, name=wf_name) - return wf \ No newline at end of file + + wf = add_additional_fields_to_taskdocs(wf, + {"wf_meta": self.wf_meta}, + task_name_constraint="VaspToDb" + #may need to change this to "CSLDForceConstantsToDB"? + ) + #tag = #insert anything relevant to every firework in the workflow + # wf = add_tags(wf, [tag, ]) + return wf + + +if __name__ == "__main__": + + from fireworks import LaunchPad + from pymatgen.ext.matproj import MPRester + + #get a structure + mpr = MPRester(api_key='auNIrJ23VLXCqbpl') + structure = mpr.get_structure_by_material_id('mp-149') + + csld_class = CompressedSensingLatticeDynamicsWF(structure) + # print(csld_class.disps) + # print(len(csld_class.disps)) + + wf = csld_class.get_wf() + + print(wf) + + lpad = LaunchPad.auto_load() + lpad.add_wf(wf) + + #how did lpad know which database to put the wf? From 88bfa6803cf7b8e990672d6c0b3c3afa10f7bfeb Mon Sep 17 00:00:00 2001 From: reeschang Date: Mon, 15 Jul 2019 17:03:52 -0700 Subject: [PATCH 016/207] first pass local debugging --- atomate/vasp/firetasks/parse_outputs.py | 257 +++++++++++++----------- 1 file changed, 136 insertions(+), 121 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 632e9417a..f3afa8327 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1,5 +1,6 @@ import json import os +import shutil import re from collections import defaultdict from datetime import datetime @@ -1756,6 +1757,8 @@ def split_abc(var, var_name): @explicit_serialize class CSLDForceConstantsToDB(FiretaskBase): + #TODO: Update this class once a public version of CSLD is released + #TODO: Update this class once Junsoo has fixed the cluster generation """ Used to aggregate atomic forces of perturbed supercells in compressed sensing lattice dynamics (CSLD) workflow and generate interatomic force @@ -1786,7 +1789,12 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor from configparser import ConfigParser supercell_folder = self["parent_structure"].composition.reduced_formula + \ "_supercell_iter" + str(iteration_number) + + # Remove supercell_folder if it already exists, then make a new one + if os.path.exists(supercell_folder) and os.path.isdir(supercell_folder): + shutil.rmtree(supercell_folder) os.mkdir(supercell_folder) + np.savetxt(supercell_folder + "/sc.txt", self["trans_mat"], fmt="%.0f", delimiter=" ") self["supercell_structure"].to("poscar", filename=supercell_folder + "/SPOSCAR") @@ -1799,131 +1807,135 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor csld_traindat_disp_folders += ' ' + str(disp_folder) os.mkdir(disp_folder) - # Parameters for conducting CSLD - csld_traindat_string = supercell_folder + '/SPOSCAR' - csld_traindat_string += csld_traindat_disp_folders + self['convergence_info'] = { + 'iteration': 0, + 'settings_tried': {} + } - csld_settings = ConfigParser() - csld_settings['convergence_info'] = { - 'iteration': 0, - 'settings_tried': {} - } - csld_settings['structure'] = { - 'prim': 'POSCAR', - 'sym_tol': '1e-3', - 'epsilon_inf': None, # check how it reads 3x3 matrix - 'born_charge': None # check reading n_atom*9 numbers - } - csld_settings['model'] = { - 'model_type': 'LD', - 'cluster_in': 'clusters.out', - 'cluster_out': 'clusters.out', - 'symC_in': 'Cmat.mtx', - 'symC_out': 'Cmat.mtx', - 'max_order': max_order, #3, # this should be variable - 'fractional_distance': False, - 'cluster_diameter': cluster_diam, #'11 6.5 5.0', #this should be variable - 'cluster_filter': lambda cls: ((cls.order_uniq <= 2) - or (cls.bond_counts(2.9) >= 2)) - and cls.is_small_in( - supercell_folder + "/sc.txt") - # rewrote how it reads the trans_mat - } - csld_settings['training'] = { - 'interface': 'VASP', - 'corr_type': 'f', - 'corr_in': 'Amat.mtx', - 'corr_out': 'Amat.mtx', - 'fval_in': 'fval.txt', - 'fval_out': 'fval.txt', - 'traindat1': csld_traindat_string - # 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' - # Rewrote how it reads forces - } - csld_settings['fitting'] = { - 'solution_in': 'solution_all', - 'solution_out': 'solution_all', - 'nsubset': 5, - 'holdsize': 0.1, - ## 1 FPC 2 FPC sparse 3 split 4 sparse split - ## 5 split+ right preconditioning 6 sparse split + r preconditioning - ## 101 Bayesian CS - 'method': 5, - - # For weight of L1 or L2 regularization - 'mulist': '1E-5 1E-7 1E-9 1E-11', - 'maxIter': 300, - 'tolerance': 1E-6, - 'subsetsize': 0.85, - 'lambda': 0.5, - 'uscale_list': '0.03', - 'submodel1': submodel1, #'anh 0 1 2 3', # this should be variable - } - csld_settings['phonon'] = { - 'qpoint_fractional': False, - # 'Auto' or something like "[[10, [0,0,0],'\\Gamma', [0.5,0.5,0.5], 'X', [0.5,0.5,0], 'K']]" - 'wavevector': "[[25, [0,0,0],'\Gamma', [0,0.5,0.5], 'X']," - " [25, [1,0.5,0.5], 'X', [0.75,0.375,0.375], " - "'K', [0,0,0], '\Gamma', [0.5, 0.5, 0.5], 'L']]", - 'unit': 'meV', # THz, meV, eV, cm + # Parameters for conducting CSLD + csld_traindat_string = supercell_folder + '/SPOSCAR' + csld_traindat_string += csld_traindat_disp_folders + + csld_settings = ConfigParser() + csld_settings['convergence_info'] = { + 'iteration': 0, + 'settings_tried': {} + } + csld_settings['structure'] = { + 'prim': 'POSCAR', + 'sym_tol': '1e-3', + # 'epsilon_inf': None, # check how it reads 3x3 matrix + # 'born_charge': None # check reading n_atom*9 numbers + } + csld_settings['model'] = { + 'model_type': 'LD', + 'cluster_in': 'clusters.out', + 'cluster_out': 'clusters.out', + 'symC_in': 'Cmat.mtx', + 'symC_out': 'Cmat.mtx', + 'max_order': max_order, #3, # this should be variable + 'fractional_distance': False, + 'cluster_diameter': cluster_diam, #'11 6.5 5.0', #this should be variable + 'cluster_filter': lambda cls: ((cls.order_uniq <= 2) + or (cls.bond_counts(2.9) >= 2)) + and cls.is_small_in( + supercell_folder + "/sc.txt") + # rewrote how it reads the trans_mat + } + csld_settings['training'] = { + 'interface': 'VASP', + 'corr_type': 'f', + 'corr_in': 'Amat.mtx', + 'corr_out': 'Amat.mtx', + 'fval_in': 'fval.txt', + 'fval_out': 'fval.txt', + 'traindat1': csld_traindat_string + # 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' + # Rewrote how it reads forces + } + csld_settings['fitting'] = { + 'solution_in': 'solution_all', + 'solution_out': 'solution_all', + 'nsubset': 5, + 'holdsize': 0.1, + ## 1 FPC 2 FPC sparse 3 split 4 sparse split + ## 5 split+ right preconditioning 6 sparse split + r preconditioning + ## 101 Bayesian CS + 'method': 5, + + # For weight of L1 or L2 regularization + 'mulist': '1E-5 1E-7 1E-9 1E-11', + 'maxIter': 300, + 'tolerance': 1E-6, + 'subsetsize': 0.85, + 'lambda': 0.5, + 'uscale_list': '0.03', + 'submodel1': submodel1, #'anh 0 1 2 3', # this should be variable + } + csld_settings['phonon'] = { + 'qpoint_fractional': False, + # 'Auto' or something like "[[10, [0,0,0],'\\Gamma', [0.5,0.5,0.5], 'X', [0.5,0.5,0], 'K']]" + 'wavevector': "[[25, [0,0,0],'\Gamma', [0,0.5,0.5], 'X']," + " [25, [1,0.5,0.5], 'X', [0.75,0.375,0.375], " + "'K', [0,0,0], '\Gamma', [0.5, 0.5, 0.5], 'L']]", + 'unit': 'meV', # THz, meV, eV, cm - # number of grid points - 'dos_grid': '15 15 15', + # number of grid points + 'dos_grid': '15 15 15', - # number of points in DOS - 'nE_dos': 500, + # number of points in DOS + 'nE_dos': 500, - ## 0 (Gaussian), 1 (Lorentzian), -1 (tetrahedron method) - 'ismear': -1, + ## 0 (Gaussian), 1 (Lorentzian), -1 (tetrahedron method) + 'ismear': -1, - ## width in THz of Gaussian/Lorentzian smearing - 'epsilon': 0.05, - 'pdos': True, + ## width in THz of Gaussian/Lorentzian smearing + 'epsilon': 0.05, + 'pdos': True, - 'thermal_T_range': '50 800 50', - 'thermal_out': 'thermal_out.txt' - } - csld_settings['export_potential'] = { - 'export_shengbte': export_sbte, #'5 5 5 2 3' # 5x5x5 supercell - # 2 and 3 orders to be considered - # should be variable? - } - csld_settings['prediction'] = { - 'interface': 'VASP', - 'corr_type': 'f', - 'corr_in': 'Amat_pred.mtx', - 'corr_out': 'Amat_pred.mtx', - 'fval_in': 'fval_pred.txt', - 'fval_out': 'fval_pred.txt', - 'traindat0': 'fcc222/POSCAR fcc222/traj*' - } - # set default values - csld_settings['DEFAULT'] = { - "qpoint_fractional": False, - "true_v_fit": 'true_fit.txt', - 'epsilon': '0.05', - "bcs_reweight": 'True', - "bcs_penalty": 'arctan', - "bcs_jcutoff": '1E-8'} - - csld_options = {} - csld_options['pdfout'] = 'plots.pdf' - csld_options['ldff_step'] = 0 - csld_options['phonon_step'] = 1 - csld_options['phonon'] = False - csld_options['save_pot_step'] = 1 # usual default is 0 - csld_options['pot'] = False - - self["csld_settings"] = csld_settings - self["csld_options"] = csld_options - self["forces_paths"] = disp_folders + 'thermal_T_range': '50 800 50', + 'thermal_out': 'thermal_out.txt' + } + csld_settings['export_potential'] = { + 'export_shengbte': export_sbte, #'5 5 5 2 3' # 5x5x5 supercell + # 2 and 3 orders to be considered + # should be variable? + } + csld_settings['prediction'] = { + 'interface': 'VASP', + 'corr_type': 'f', + 'corr_in': 'Amat_pred.mtx', + 'corr_out': 'Amat_pred.mtx', + 'fval_in': 'fval_pred.txt', + 'fval_out': 'fval_pred.txt', + 'traindat0': 'fcc222/POSCAR fcc222/traj*' + } + # set default values + csld_settings['DEFAULT'] = { + "qpoint_fractional": False, + "true_v_fit": 'true_fit.txt', + 'epsilon': '0.05', + "bcs_reweight": 'True', + "bcs_penalty": 'arctan', + "bcs_jcutoff": '1E-8'} + + csld_options = {} + csld_options['pdfout'] = 'plots.pdf' + csld_options['ldff_step'] = 0 + csld_options['phonon_step'] = 1 + csld_options['phonon'] = False + csld_options['save_pot_step'] = 1 # usual default is 0 + csld_options['pot'] = False + + self["csld_settings"] = csld_settings + self["csld_options"] = csld_options + self["forces_paths"] = disp_folders def run_task(self, fw_spec): iter = 0 not_converged = True maxIter = 1 - convergence_info_dict = self["csld_settings"]["convergence_info"] summaries = [] # @@ -1947,7 +1959,7 @@ def run_task(self, fw_spec): formula = self["parent_structure"].formula formula_pretty = self["parent_structure"].composition.reduced_formula task_label = 'static' - supercells_dicts = list(tasks.find({"wf_meta.wf_uuid": uuid, + supercells_dicts = list(tasks.find({"wf_meta.wf_uuid": uuid, # Date: Tue, 16 Jul 2019 10:23:39 -0700 Subject: [PATCH 017/207] Fixed workflow generation script and added perturbed supercells as a required param (for putting poscars inside displacement folders) --- atomate/vasp/firetasks/parse_outputs.py | 17 +++--- atomate/vasp/workflows/base/csld.py | 80 +++++++++++++++++-------- 2 files changed, 64 insertions(+), 33 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index f3afa8327..e852bc492 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1780,8 +1780,7 @@ class CSLDForceConstantsToDB(FiretaskBase): """ required_params = ["db_file", "wf_uuid", "parent_structure", - # "csld_settings", "csld_options", - + "perturbed_supercells", "trans_mat", "supercell_structure", "disps"] @@ -1798,14 +1797,17 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor np.savetxt(supercell_folder + "/sc.txt", self["trans_mat"], fmt="%.0f", delimiter=" ") self["supercell_structure"].to("poscar", filename=supercell_folder + "/SPOSCAR") + self["parent_structure"].to("poscar", filename=supercell_folder + "POSCAR") disp_folders = [] csld_traindat_disp_folders = '' - for disp in self["disps"]: + for idx, disp in enumerate(self["disps"]): disp_folder = supercell_folder+'/disp'+str(disp) disp_folders += [disp_folder] csld_traindat_disp_folders += ' ' + str(disp_folder) os.mkdir(disp_folder) + self["perturbed_supercells"][idx].to("poscar", + filename=disp_folder + "/POSCAR") self['convergence_info'] = { 'iteration': 0, @@ -1822,7 +1824,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor 'settings_tried': {} } csld_settings['structure'] = { - 'prim': 'POSCAR', + 'prim': supercell_folder + 'POSCAR', 'sym_tol': '1e-3', # 'epsilon_inf': None, # check how it reads 3x3 matrix # 'born_charge': None # check reading n_atom*9 numbers @@ -1836,10 +1838,9 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor 'max_order': max_order, #3, # this should be variable 'fractional_distance': False, 'cluster_diameter': cluster_diam, #'11 6.5 5.0', #this should be variable - 'cluster_filter': lambda cls: ((cls.order_uniq <= 2) - or (cls.bond_counts(2.9) >= 2)) - and cls.is_small_in( - supercell_folder + "/sc.txt") + 'cluster_filter': r"lambda cls: ((cls.order_uniq <= 2) or " + r"(cls.bond_counts(2.9) >= 2)) and " + r"cls.is_small_in('" +supercell_folder+ "/sc.txt')" # rewrote how it reads the trans_mat } csld_settings['training'] = { diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index e53003aaa..6acbd1b3d 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -12,13 +12,13 @@ from fireworks import Workflow, Firework from atomate.utils.utils import get_logger from atomate.vasp.config import VASP_CMD, DB_FILE, ADD_WF_METADATA # what is this? -from atomate.vasp.fireworks.core import StaticFW +from atomate.vasp.fireworks.core import StaticFW, OptimizeFW from atomate.vasp.firetasks.parse_outputs import CSLDForceConstantsToDB from atomate.vasp.powerups import ( add_additional_fields_to_taskdocs ) -from pymatgen.io.vasp.sets import MPStaticSet +from pymatgen.io.vasp.sets import MPStaticSet, MPRelaxSet # NEW THINGS TO INSTALL? # from configparser import ConfigParser @@ -118,27 +118,46 @@ def _add_metadata(structure): structure, other_parameters={"wf_meta": self.wf_meta} ) - user_incar_settings = {"ADDGRID": True, #Fast Fourier Transform grid - "LCHARG": False, - "ENCUT": 700, - "EDIFF": 1e-7, #may need to tune this - "PREC": 'Accurate', - "LAECHG": False, - "LREAL": False, - "LASPH": True} - user_incar_settings.update(c.get("user_incar_settings", {})) + #TODO: Move this relaxation section elsewhere + # relax_user_incar_settings = {"EDIFF": 1e-8, + # "EDIFFG": -1e-5, + # } + # relax_vis = MPRelaxSet(self.parent_structure, + # user_incar_settings=relax_user_incar_settings) + # # relax + # fws.append( + # OptimizeFW( + # self.parent_structure, + # vasp_input_set=relax_vis, + # vasp_cmd=c["VASP_CMD"], + # db_file=c["DB_FILE"], + # max_force_threshold=0.05, #idk, should i change this? + # half_kpts_first_relax=False, #idk what this is + # name="{} - CSLD relax parent".format(self.parent_structure.composition.reduced_formula), + # ) + # ) + ##################### + + static_user_incar_settings = {"ADDGRID": True, + # Fast Fourier Transform grid + "LCHARG": False, + "ENCUT": 700, + "EDIFF": 1e-7, # may need to tune this + "PREC": 'Accurate', + "LAECHG": False, + "LREAL": False, + "LASPH": True} + static_user_incar_settings.update(c.get("user_incar_settings", {})) for idx, perturbed_supercell in enumerate(self.perturbed_supercells): # Run static calculations on the perturbed supercells to compute forces on each atom name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format(idx, self.disps[idx]) - - vis = MPStaticSet(perturbed_supercell, - user_incar_settings=user_incar_settings) - + static_vis = MPStaticSet(perturbed_supercell, + user_incar_settings=static_user_incar_settings) fws.append(StaticFW( perturbed_supercell, - vasp_input_set=vis, + vasp_input_set=static_vis, vasp_cmd=c["VASP_CMD"], db_file=c["DB_FILE"], name=name + " static" @@ -155,6 +174,7 @@ def _add_metadata(structure): parent_structure=self.parent_structure, trans_mat=self.trans_mat, supercell_structure=self.supercell, + perturbed_supercells=self.perturbed_supercells, disps=self.disps ), name="Compressed Sensing Lattice Dynamics", @@ -176,24 +196,34 @@ def _add_metadata(structure): return wf +# SCRIPT FOR CREATING THE WORKFLOW AND ADDING IT TO THE DATABASE if __name__ == "__main__": from fireworks import LaunchPad from pymatgen.ext.matproj import MPRester + from atomate.vasp.powerups import add_tags, set_execution_options #get a structure mpr = MPRester(api_key='auNIrJ23VLXCqbpl') structure = mpr.get_structure_by_material_id('mp-149') csld_class = CompressedSensingLatticeDynamicsWF(structure) - # print(csld_class.disps) - # print(len(csld_class.disps)) + print("uuid") + print(csld_class.uuid) wf = csld_class.get_wf() - - print(wf) - - lpad = LaunchPad.auto_load() - lpad.add_wf(wf) - - #how did lpad know which database to put the wf? + print("trans mat") + print(csld_class.trans_mat) + + # wf = add_tags(wf, ['csld', 'v1', 'rees']) + # wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks + # print(wf) + # + # lpad = LaunchPad.auto_load() + # lpad.add_wf(wf) + + # [[4. 0. - 2.] + # [-1. 4. - 1.] + # [0. + # 0. + # 4.]] From e19c32a5a756165e7f2d7f194c2b9c7ce160a486 Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 16 Jul 2019 11:49:19 -0700 Subject: [PATCH 018/207] Workflow now runs without errors but with garbage results --- atomate/vasp/firetasks/parse_outputs.py | 18 ++++++++++++------ 1 file changed, 12 insertions(+), 6 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index e852bc492..1da28890c 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1968,19 +1968,25 @@ def run_task(self, fw_spec): # for each supercell supercells_forces = [] - supercells_task_ids = [] + # supercells_task_ids = [] + supercells_task_labels = [] for supercell_dict in supercells_dicts: #List of np.ndarrays where each np.ndarray is a matrix of forces # for a perturbed supercell supercells_forces += [np.asarray(supercell_dict['output']['forces'])] - #List of task ids for each perturbed supercell - supercells_task_ids += [supercell_dict['task_id']] + # #List of task ids for each perturbed supercell + # supercells_task_ids += [supercell_dict['task_id']] - supercell_idx = 0 - for supercell_forces in supercells_forces: + supercells_task_labels += [supercell_dict['task_label']] + + supercells_zip = sorted(zip(supercells_task_labels, supercells_forces), key=lambda pair: pair[0]) + #sort by task labels + supercells_forces = [supercells_forces for (supercells_task_labels, supercells_forces) in supercells_zip] + + for supercell_idx, supercell_force in enumerate(supercells_forces): path = self["forces_paths"][supercell_idx] - np.savetxt(path + "/force.txt", supercell_forces, fmt='%.6f') + np.savetxt(path + "/force.txt", supercell_force, fmt='%.6f') #Perform csld minimization now import scripts.csld_main_rees as csld_main From 32c4a048557c1c2e713426fc333416db6a851a3e Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 17 Jul 2019 10:25:25 -0700 Subject: [PATCH 019/207] IT WORKS LETS GOOOOOO --- atomate/vasp/firetasks/parse_outputs.py | 31 +++++++++++++++---------- 1 file changed, 19 insertions(+), 12 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 1da28890c..c0976d43e 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1797,7 +1797,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor np.savetxt(supercell_folder + "/sc.txt", self["trans_mat"], fmt="%.0f", delimiter=" ") self["supercell_structure"].to("poscar", filename=supercell_folder + "/SPOSCAR") - self["parent_structure"].to("poscar", filename=supercell_folder + "POSCAR") + self["parent_structure"].to("poscar", filename=supercell_folder + "/POSCAR") disp_folders = [] csld_traindat_disp_folders = '' @@ -1819,12 +1819,8 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor csld_traindat_string += csld_traindat_disp_folders csld_settings = ConfigParser() - csld_settings['convergence_info'] = { - 'iteration': 0, - 'settings_tried': {} - } csld_settings['structure'] = { - 'prim': supercell_folder + 'POSCAR', + 'prim': supercell_folder + '/POSCAR', #original structure poscar 'sym_tol': '1e-3', # 'epsilon_inf': None, # check how it reads 3x3 matrix # 'born_charge': None # check reading n_atom*9 numbers @@ -1850,7 +1846,8 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor 'corr_out': 'Amat.mtx', 'fval_in': 'fval.txt', 'fval_out': 'fval.txt', - 'traindat1': csld_traindat_string + 'traindat1': csld_traindat_string #directories of unperturbed followed + #by perturbed supercell poscars # 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' # Rewrote how it reads forces } @@ -1948,7 +1945,7 @@ def run_task(self, fw_spec): db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) tasks = mmdb["tasks"] - while not_converged or iter < maxIter: + while not_converged and iter < maxIter: self.set_params(iter, cluster_diam_settings[iter], max_order_settings[iter], @@ -1963,7 +1960,9 @@ def run_task(self, fw_spec): supercells_dicts = list(tasks.find({"wf_meta.wf_uuid": uuid, # Date: Wed, 17 Jul 2019 10:47:30 -0700 Subject: [PATCH 020/207] Added conventional standard primitive structure from pymatgen sga --- atomate/vasp/workflows/base/csld.py | 33 +++++++++++++++++++++++------ 1 file changed, 26 insertions(+), 7 deletions(-) diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 6acbd1b3d..b050279f7 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -4,6 +4,8 @@ import numpy as np from uuid import uuid4 + +from pymatgen.symmetry.analyzer import SpacegroupAnalyzer from pymatgen.alchemy.materials import TransformedStructure from pymatgen.transformations.advanced_transformations import ( CubicSupercellTransformation, @@ -36,6 +38,7 @@ class CompressedSensingLatticeDynamicsWF: def __init__( self, parent_structure, + symprec=0.1, min_atoms=-np.Inf, max_atoms=np.Inf, num_nn_dists=5, @@ -75,7 +78,9 @@ def __init__( } # Create supercell - self.parent_structure = parent_structure + sga = SpacegroupAnalyzer(parent_structure, symprec=symprec) + self.parent_structure = sga.get_primitive_standard_structure() + self.min_atoms = min_atoms self.max_atoms = max_atoms self.num_nn_dists = num_nn_dists @@ -102,7 +107,6 @@ def __init__( self.disps = np.repeat(perturbed_supercells_transform.disps, supercells_per_displacement_distance) - def get_wf( self, c=None @@ -207,18 +211,33 @@ def _add_metadata(structure): mpr = MPRester(api_key='auNIrJ23VLXCqbpl') structure = mpr.get_structure_by_material_id('mp-149') - csld_class = CompressedSensingLatticeDynamicsWF(structure) + # prim_structure = structure.get_primitive_structure() #this method is bad + + # CONVENTIONAL PRIMITIVE CELL WITH SYMMETRIZATION + from pymatgen.symmetry.analyzer import SpacegroupAnalyzer + sga = SpacegroupAnalyzer(structure, symprec=0.1) + prim = sga.get_primitive_standard_structure() + prim.to("poscar", filename="POSCAR-pmg_prim_si") + + # CSLD'S POLARON MAIN-GENERATED PRIMITIVE CELL + # from pymatgen.core.structure import Structure + # prim = Structure.from_file('POSCAR_csld_primitivized') + + csld_class = CompressedSensingLatticeDynamicsWF(prim, max_displacement=0.05, + min_displacement=0.01, + num_displacements=5) print("uuid") print(csld_class.uuid) wf = csld_class.get_wf() print("trans mat") print(csld_class.trans_mat) + csld_class.supercell.to("poscar", filename="POSCAR-csld_super_si") + + wf = add_tags(wf, ['csld', 'v1', 'rees', 'sga primitizer']) + wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks + print(wf) - # wf = add_tags(wf, ['csld', 'v1', 'rees']) - # wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks - # print(wf) - # # lpad = LaunchPad.auto_load() # lpad.add_wf(wf) From 827f2cdff29548f1c5c903833048eaccb05c1797 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 19 Jul 2019 13:39:26 -0700 Subject: [PATCH 021/207] Added random search for csld parameters and shengbte stuff --- atomate/vasp/firetasks/parse_outputs.py | 1 + atomate/vasp/workflows/base/csld.py | 53 +++++++++++++------------ 2 files changed, 29 insertions(+), 25 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index c0976d43e..6cb02e24b 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1782,6 +1782,7 @@ class CSLDForceConstantsToDB(FiretaskBase): required_params = ["db_file", "wf_uuid", "parent_structure", "perturbed_supercells", "trans_mat", "supercell_structure", + "supercell_smallest_dim", "disps"] def set_params(self, iteration_number, cluster_diam, max_order, submodel1, export_sbte): diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index b050279f7..c457b2401 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -92,6 +92,7 @@ def __init__( # supercell (Structure) self.supercell = supercell_transform.apply_transformation(self.parent_structure) self.trans_mat = supercell_transform.trans_mat + self.supercell_smallest_dim = supercell_transform.smallest_dim # Generate randomly perturbed supercells perturbed_supercells_transform = PerturbSitesTransformation( @@ -178,6 +179,7 @@ def _add_metadata(structure): parent_structure=self.parent_structure, trans_mat=self.trans_mat, supercell_structure=self.supercell, + supercell_smallest_dim=self.supercell_smallest_dim, perturbed_supercells=self.perturbed_supercells, disps=self.disps ), @@ -208,41 +210,42 @@ def _add_metadata(structure): from atomate.vasp.powerups import add_tags, set_execution_options #get a structure - mpr = MPRester(api_key='auNIrJ23VLXCqbpl') - structure = mpr.get_structure_by_material_id('mp-149') - - # prim_structure = structure.get_primitive_structure() #this method is bad - - # CONVENTIONAL PRIMITIVE CELL WITH SYMMETRIZATION + # mpr = MPRester(api_key='auNIrJ23VLXCqbpl') + # # structure = mpr.get_structure_by_material_id('mp-149') #Si + # structure = mpr.get_structure_by_material_id('mp-1101039') + # test_trans_mat = np.linalg.inv(structure.lattice.matrix) @ (np.eye(3,3) * 20) + # print(test_trans_mat) + # print(np.linalg.det(test_trans_mat)) + # structure_test = structure * test_trans_mat + # structure_test.to("poscar", filename="POSCAR-noninteger_trans_test") + + # # CONVENTIONAL PRIMITIVE CELL WITH SYMMETRIZATION from pymatgen.symmetry.analyzer import SpacegroupAnalyzer - sga = SpacegroupAnalyzer(structure, symprec=0.1) - prim = sga.get_primitive_standard_structure() - prim.to("poscar", filename="POSCAR-pmg_prim_si") + # sga = SpacegroupAnalyzer(structure, symprec=0.1) + # prim = sga.get_primitive_standard_structure() # CSLD'S POLARON MAIN-GENERATED PRIMITIVE CELL - # from pymatgen.core.structure import Structure + from pymatgen.core.structure import Structure # prim = Structure.from_file('POSCAR_csld_primitivized') - csld_class = CompressedSensingLatticeDynamicsWF(prim, max_displacement=0.05, - min_displacement=0.01, - num_displacements=5) + prim = Structure.from_file('POSCAR-well_relaxed_InSb_csld_primitivized') + # sga = SpacegroupAnalyzer(prim, symprec=0.1) + # prim2 = sga.get_primitive_standard_structure() + # prim2.to("poscar", 'POSCAR-InSb-standard') + + csld_class = CompressedSensingLatticeDynamicsWF(prim) print("uuid") print(csld_class.uuid) wf = csld_class.get_wf() print("trans mat") print(csld_class.trans_mat) - csld_class.supercell.to("poscar", filename="POSCAR-csld_super_si") - - wf = add_tags(wf, ['csld', 'v1', 'rees', 'sga primitizer']) - wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks - print(wf) - + print(csld_class.supercell_smallest_dim) + csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_InSb_standard") + # + # wf = add_tags(wf, ['csld', 'v1', 'rees', 'InSb', 'first_try']) + # wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks + # print(wf) + # # lpad = LaunchPad.auto_load() # lpad.add_wf(wf) - - # [[4. 0. - 2.] - # [-1. 4. - 1.] - # [0. - # 0. - # 4.]] From 002e8558c05d184402a10aea31f9b7e74df13da3 Mon Sep 17 00:00:00 2001 From: reeschang Date: Mon, 22 Jul 2019 17:29:24 -0700 Subject: [PATCH 022/207] accounted for CSLD github and added csld random search --- atomate/vasp/firetasks/parse_outputs.py | 265 ++++++++++++++++++------ atomate/vasp/workflows/base/csld.py | 91 +++++++- 2 files changed, 279 insertions(+), 77 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 6cb02e24b..9a7568372 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1785,9 +1785,64 @@ class CSLDForceConstantsToDB(FiretaskBase): "supercell_smallest_dim", "disps"] - def set_params(self, iteration_number, cluster_diam, max_order, submodel1, export_sbte): + def random_search(self, maxIter): + """ + -pair potential is roughly 12 Angstroms, so supercell should be safely + larger than that (at least 20 in each direction) so you don't get artifacts + from periodic boundary conditions (i.e. atoms being double-counted in the + pair potential) + -"most likely" at least 4 nearest neighbor distances is ok + - + -150+ atom-supercell + -for low symmetry, more atoms = finer displacement linspace (0.02 - 0.05 in + steps of 0.01 or 0.005) + -9-12 lattice parameters for pair cutoffs, triplets usually a little more than half of pairs + - -1 meV phonon mode is + -change cutoff diameter (easiest, probably increase) + -either increase supercells or relax primitive cell better (check total drift) + + CSLD CHECKS: IF FITTING IS BAD... + Option 1. + Play with cluster diameters + -random search? bayesopt? + -if tried some max number trials and still bad, pick the best one and move to Option 2 + + Option 2. + Include higher displacement supercells + 1. If Natom>5, generate supercells at large displacements (>0.1 angstroms) + 2. Fit up to 3rd order only with supercells perturbed <0.1 angstroms + -If good, run SBTE + -If bad, then fit including supercells >0.1 angstroms + -If good, run SBTE + -If bad, redo step 2 with 4th order + :return: + """ + import random + + if maxIter % 2 != 0 or maxIter <= 0: + raise AttributeError('maxIter must be even.') + + cluster_diam_settings = [] + for _ in range(maxIter): + pair_diam = random.uniform(10, 14) #self["supercell_smallest_dim"]) + triplet_diam = random.uniform(pair_diam * 0.4, pair_diam) + quadruplet_diam = random.uniform(triplet_diam * 0.6, triplet_diam) + + cluster_diam_settings += [ + str(pair_diam) + ' ' + str(triplet_diam) + ' ' + str( + quadruplet_diam)] + + max_order_settings = [3] * int(maxIter / 2) + [4] * int(maxIter / 2) + submodel1_settings = ['anh 0 1 2 3'] * int(maxIter / 2) + \ + ['anh 0 1 2 3 4'] * int(maxIter / 2) + + return cluster_diam_settings, max_order_settings, submodel1_settings + + def set_params(self, iteration_number, cluster_diam, max_order, submodel1, + export_sbte): from configparser import ConfigParser - supercell_folder = self["parent_structure"].composition.reduced_formula + \ + supercell_folder = self[ + "parent_structure"].composition.reduced_formula + \ "_supercell_iter" + str(iteration_number) # Remove supercell_folder if it already exists, then make a new one @@ -1795,33 +1850,46 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor shutil.rmtree(supercell_folder) os.mkdir(supercell_folder) + # Save transformation matrix, supercell POSCAR, and parent structure + # POSCAR to file np.savetxt(supercell_folder + "/sc.txt", self["trans_mat"], fmt="%.0f", delimiter=" ") - self["supercell_structure"].to("poscar", filename=supercell_folder + "/SPOSCAR") - self["parent_structure"].to("poscar", filename=supercell_folder + "/POSCAR") + self["supercell_structure"].to("poscar", + filename=supercell_folder + "/SPOSCAR") + self["parent_structure"].to("poscar", + filename=supercell_folder + "/POSCAR") + # Create folders for perturbed supercell POSCARS and force.txt's disp_folders = [] csld_traindat_disp_folders = '' for idx, disp in enumerate(self["disps"]): - disp_folder = supercell_folder+'/disp'+str(disp) - disp_folders += [disp_folder] - csld_traindat_disp_folders += ' ' + str(disp_folder) + disp_folder = supercell_folder + '/disp' + str(disp) + disp_folders += [disp_folder] # list of folder paths + csld_traindat_disp_folders += ' ' + str( + disp_folder) # Create string for CSLD input + if os.path.exists(disp_folder) and os.path.isdir(disp_folder): + shutil.rmtree(disp_folder) os.mkdir(disp_folder) self["perturbed_supercells"][idx].to("poscar", filename=disp_folder + "/POSCAR") + # Store information related to convergence of CSLD self['convergence_info'] = { 'iteration': 0, - 'settings_tried': {} + 'settings_tried': [], + 'cross_val_errors': [], + 'most_imaginary_freqs': [], + 'imaginary_freqs_sum': [] } - # Parameters for conducting CSLD + # training>traindat1 setting for CSLD input csld_traindat_string = supercell_folder + '/SPOSCAR' csld_traindat_string += csld_traindat_disp_folders + # Create ConfigParser of all CSLD input settings csld_settings = ConfigParser() csld_settings['structure'] = { - 'prim': supercell_folder + '/POSCAR', #original structure poscar + 'prim': supercell_folder + '/POSCAR', # original structure poscar 'sym_tol': '1e-3', # 'epsilon_inf': None, # check how it reads 3x3 matrix # 'born_charge': None # check reading n_atom*9 numbers @@ -1832,12 +1900,13 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor 'cluster_out': 'clusters.out', 'symC_in': 'Cmat.mtx', 'symC_out': 'Cmat.mtx', - 'max_order': max_order, #3, # this should be variable + 'max_order': max_order, # 3, # this should be variable 'fractional_distance': False, - 'cluster_diameter': cluster_diam, #'11 6.5 5.0', #this should be variable + 'cluster_diameter': cluster_diam, + # '11 6.5 5.0', #this should be variable 'cluster_filter': r"lambda cls: ((cls.order_uniq <= 2) or " r"(cls.bond_counts(2.9) >= 2)) and " - r"cls.is_small_in('" +supercell_folder+ "/sc.txt')" + r"cls.is_small_in('" + supercell_folder + "/sc.txt')" # rewrote how it reads the trans_mat } csld_settings['training'] = { @@ -1847,8 +1916,9 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor 'corr_out': 'Amat.mtx', 'fval_in': 'fval.txt', 'fval_out': 'fval.txt', - 'traindat1': csld_traindat_string #directories of unperturbed followed - #by perturbed supercell poscars + 'traindat1': csld_traindat_string + # directories of unperturbed followed + # by perturbed supercell poscars # 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' # Rewrote how it reads forces } @@ -1863,13 +1933,13 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor 'method': 5, # For weight of L1 or L2 regularization - 'mulist': '1E-5 1E-7 1E-9 1E-11', + 'mulist': '1E-5 1E-6 1E-7 1E-9', 'maxIter': 300, 'tolerance': 1E-6, 'subsetsize': 0.85, 'lambda': 0.5, 'uscale_list': '0.03', - 'submodel1': submodel1, #'anh 0 1 2 3', # this should be variable + 'submodel1': submodel1, # 'anh 0 1 2 3', # this should be variable } csld_settings['phonon'] = { 'qpoint_fractional': False, @@ -1896,7 +1966,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor 'thermal_out': 'thermal_out.txt' } csld_settings['export_potential'] = { - 'export_shengbte': export_sbte, #'5 5 5 2 3' # 5x5x5 supercell + 'export_shengbte': export_sbte, # '5 5 5 2 3' # 5x5x5 supercell # 2 and 3 orders to be considered # should be variable? } @@ -1919,98 +1989,136 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor "bcs_jcutoff": '1E-8'} csld_options = {} - csld_options['pdfout'] = 'plots.pdf' + csld_options['pdfout'] = 'plots.pdf' # Name of pdf to output results csld_options['ldff_step'] = 0 csld_options['phonon_step'] = 1 csld_options['phonon'] = False - csld_options['save_pot_step'] = 1 # usual default is 0 + csld_options[ + 'save_pot_step'] = 1 # usual default is 0. 1 means output to ShengBTE format. csld_options['pot'] = False + # set default values + csld_options['log_level'] = 1 + csld_options['symm_step'] = 2 + csld_options['symm_prim'] = True + csld_options['clus_step'] = 3 + csld_options['symC_step'] = 3 + csld_options['train_step'] = 3 + csld_options['fit_step'] = 3 + csld_options['pred_step'] = 0 + csld_options['refit'] = False + csld_options['cont'] = False + csld_options['predict'] = False + self["csld_settings"] = csld_settings self["csld_options"] = csld_options - self["forces_paths"] = disp_folders + self["forces_paths"] = disp_folders # Paths to perturbed supercell folders def run_task(self, fw_spec): + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + tasks = mmdb["tasks"] iter = 0 not_converged = True - maxIter = 1 + maxIter = 2 summaries = [] - # - cluster_diam_settings = ['11 6.5 5.0'] - max_order_settings = [3] - submodel1_settings = ['anh 0 1 2 3'] - export_sbte_settings = ['5 5 5 2 3'] + # + # cluster_diam_settings = ['11 6.5 5.0'] + # max_order_settings = [3] + # submodel1_settings = ['anh 0 1 2 3'] + # export_sbte_settings = ['5 5 5 2 3'] + + cluster_diam_settings, max_order_settings, submodel1_settings = self.random_search( + maxIter) + print('cluster_diam') + print(cluster_diam_settings) + print('max order') + print(max_order_settings) + print('submodel') + print(submodel1_settings) + export_sbte_settings = ['5 5 5 2 3'] * maxIter - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - tasks = mmdb["tasks"] while not_converged and iter < maxIter: self.set_params(iter, cluster_diam_settings[iter], max_order_settings[iter], submodel1_settings[iter], export_sbte_settings[iter]) + self["csld_options"]["pdfout"] = 'plots' + str(iter) + '.pdf' uuid = self["wf_uuid"] formula = self["parent_structure"].formula - formula_pretty = self["parent_structure"].composition.reduced_formula + formula_pretty = self[ + "parent_structure"].composition.reduced_formula task_label = 'static' - supercells_dicts = list(tasks.find({"wf_meta.wf_uuid": uuid, # + # "iteration": iter, - "cluster_diam": self["csld_settings"]["model"]["cluster_diameter"], + "cluster_diam": self["csld_settings"]["model"][ + "cluster_diameter"], "max_order": self["csld_settings"]["model"]["max_order"], "submodel1": self["csld_settings"]["fitting"]["submodel1"], - "export_potential": self["csld_settings"]["export_potential"]["export_shengbte"], + "export_potential": self["csld_settings"]["export_potential"][ + "export_shengbte"], "cross_val_error": float(rel_err), - "num_imaginary_modes": int(num_imaginary_bands), #number or percent? - "most_imaginary_freq": float(most_imaginary_freq) + "num_imaginary_modes": int(num_imaginary_bands), + # number or percent? + "most_imaginary_freq": float(most_imaginary_freq), + "imaginary_freq_sum": float(sum(imaginary_freqs)) } latest_settings = {str(self["convergence_info"]["iteration"]): {self["csld_settings"]["model"]["max_order"], - self["csld_settings"]["fitting"]["submodel1"], + self["csld_settings"]["fitting"][ + "submodel1"], self["csld_settings"]["export_potential"][ "export_shengbte"]}} self["convergence_info"]["iteration"] += 1 - self["convergence_info"]["settings_tried"].update(latest_settings) + self["convergence_info"]["settings_tried"] += [latest_settings] + self["convergence_info"]["cross_val_errors"] += [rel_err] + self["convergence_info"]["most_imaginary_freqs"] += [ + most_imaginary_freq] + self["convergence_info"]["imaginary_freqs_sum"] += [ + sum(imaginary_freqs)] if fw_spec.get("tags", None): summary["tags"] = fw_spec["tags"] @@ -2044,15 +2162,30 @@ def run_task(self, fw_spec): iter = self['convergence_info']['iteration'] - mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] - mmdb.collection.insert(summaries) - - if iter <= maxIter: - logger.info("Compressed Sensing Lattice Dynamics calculation complete.") + # mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] + # mmdb.collection.insert(summaries) + mmdb.compressed_sensing_lattice_dynamics.insert(summaries) + + best_idx = self["convergence_info"]["cross_val_errors"].index( + min(self["convergence_info"]["cross_val_errors"])) + print("The lowest error was {} percent.".format( + min(self["convergence_info"]["cross_val_errors"]))) + print("The corresponding settings were: {}".format( + self["convergence_info"]["settings_tried"][best_idx])) + + if not_converged is False: + # logger.info("Compressed Sensing Lattice Dynamics calculation complete.") + # from fireworks.core.firework import Firework + # shengbte_fw = Firework(', {fw_spec: dict of info to pass to next firework}') + # BTE.err >BTE.out> + # return FWAction(additions=shengbte_fw) + raise NotImplementedError("Implement ShengBTE firework") else: - logger.info("Compressed Sensing Lattice Dynamics calculation failed." - "Max iterations of CSLD trials (each with different " - "settings) was reached.") + # logger.info("Compressed Sensing Lattice Dynamics calculation failed." + # "Max iterations was reached.") + raise TimeoutError( + "The workflow was unable to find a solution to CSLD" + " for this material.") # the following definitions for backward compatibility diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index c457b2401..993cbb129 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -228,12 +228,12 @@ def _add_metadata(structure): from pymatgen.core.structure import Structure # prim = Structure.from_file('POSCAR_csld_primitivized') - prim = Structure.from_file('POSCAR-well_relaxed_InSb_csld_primitivized') - # sga = SpacegroupAnalyzer(prim, symprec=0.1) - # prim2 = sga.get_primitive_standard_structure() - # prim2.to("poscar", 'POSCAR-InSb-standard') + prim = Structure.from_file('POSCAR-well_relaxed_Sr8Sb4Au4') - csld_class = CompressedSensingLatticeDynamicsWF(prim) + csld_class = CompressedSensingLatticeDynamicsWF(prim, + num_nn_dists=5, + num_displacements=10, + supercells_per_displacement_distance=1) print("uuid") print(csld_class.uuid) @@ -241,11 +241,80 @@ def _add_metadata(structure): print("trans mat") print(csld_class.trans_mat) print(csld_class.supercell_smallest_dim) - csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_InSb_standard") - # - # wf = add_tags(wf, ['csld', 'v1', 'rees', 'InSb', 'first_try']) - # wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks - # print(wf) - # + print(csld_class.supercell.num_sites) + csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_Sr8Sb4Au4") + + wf = add_tags(wf, ['csld', 'v1', 'rees', 'Sr8Sb4Au4', '10disps_1each']) + wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks + print(wf) + # lpad = LaunchPad.auto_load() # lpad.add_wf(wf) + +# uuid +# 0ff0d430-b43f-4cb5-ac8b-55c465b7867c +# DISPS +# [0.01 0.02 0.03 0.04 0.05 0.06 0.07 0.08 0.09 0.1 ] +# trans mat +# [[-3. 3. 3.] +# [ 3. -3. 3.] +# [ 3. 3. -3.]] +# 23.745154105620003 +# 432 + +#################custom csld_main below################## +def csld_main(options, settings): + """ + Runs CSLD minimization. + + Changes from original version: + - Made 'prim' an argument in 'phonon_step()' + - Moved execution files to this main() function to be called from + atomate + - Rewrote 'add_common_parameter' in 'common_main' to treat 'options' as + a dictionary instead of ArgumentParser + """ + import matplotlib + matplotlib.use('Agg') + from matplotlib.backends.backend_pdf import PdfPages + import atexit + import csld + from csld.symmetry_structure import SymmetrizedStructure + + from csld.lattice_dynamics import init_ld_model + + from csld.common_main import upon_exit, \ + init_training, fit_data, phonon_step, \ + save_pot, predict + + freq_matrix = None #Rees + pdfout = PdfPages( + options['pdfout'].strip()) if options['pdfout'].strip() else None + atexit.register(upon_exit, pdfout) + + prim = SymmetrizedStructure.init_structure(settings['structure'], + options['symm_step'], + options['symm_prim'], + options['log_level']) + model = init_ld_model(prim, settings['model'], settings[ + 'LDFF'] if 'LDFF' in settings.sections() else {}, options['clus_step'], + options['symC_step'], options['ldff_step']) + Amat, fval = init_training(model, settings['training'], options['train_step']) + ibest, solutions, rel_err = fit_data(model, Amat, fval, settings['fitting'], + options['fit_step'], pdfout) + if settings.has_section('phonon'): + phonon, freq_matrix = phonon_step(model, solutions, settings['phonon'], + options['phonon_step'], pdfout, prim) + if settings.has_section('export_potential'): + save_pot(model, solutions[ibest], settings['export_potential'], + options['save_pot_step'], phonon) + if settings.has_section('prediction'): + predict(model, solutions, settings['prediction'], options['pred_step']) + + #OUTPUT + # freq_matrix is (nbands, nkpoints) = frequencies. Check for negative entries + # rel_err is cross validation error in percent + return rel_err, freq_matrix #also want to return force constants + + + From 123f034497b6e5be06e973149ee9713b592529f9 Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 23 Jul 2019 14:28:19 -0700 Subject: [PATCH 023/207] Added dynamic fireworks for possible error handling (i.e. larger displacement values) --- atomate/vasp/firetasks/parse_outputs.py | 153 ++++++++++++++++++------ atomate/vasp/workflows/base/csld.py | 5 +- 2 files changed, 119 insertions(+), 39 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 9a7568372..99a902b45 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -8,9 +8,15 @@ import numpy as np from fireworks import FiretaskBase, FWAction, explicit_serialize from fireworks.utilities.fw_serializers import DATETIME_HANDLER +<<<<<<< HEAD from monty.json import MontyEncoder, jsanitize from monty.os.path import zpath from pydash.objects import get, has +======= +from fireworks import Firework + +from pymatgen import Structure +>>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) from pymatgen.analysis.elasticity.elastic import ElasticTensor, ElasticTensorExpansion from pymatgen.analysis.elasticity.strain import Deformation, Strain from pymatgen.analysis.elasticity.stress import Stress @@ -29,12 +35,26 @@ from pymatgen.electronic_structure.boltztrap import BoltztrapAnalyzer from pymatgen.io.vasp.sets import get_vasprun_outcar from pymatgen.symmetry.analyzer import SpacegroupAnalyzer +<<<<<<< HEAD +======= +from pymatgen.analysis.ferroelectricity.polarization import Polarization, get_total_ionic_dipole, \ + EnergyTrend +from pymatgen.analysis.magnetism import CollinearMagneticStructureAnalyzer, Ordering, magnetic_deformation +from pymatgen.command_line.bader_caller import bader_analysis_from_path +from pymatgen.transformations.advanced_transformations import PerturbSitesTransformation +from pymatgen.io.vasp.sets import MPStaticSet +>>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) from atomate.common.firetasks.glue_tasks import get_calc_loc from atomate.utils.utils import env_chk, get_logger, get_meta_from_structure from atomate.vasp.config import DEFUSE_UNSUCCESSFUL, STORE_VOLUMETRIC_DATA from atomate.vasp.database import VaspCalcDb +<<<<<<< HEAD from atomate.vasp.drones import BADER_EXE_EXISTS, VaspDrone +======= +from atomate.vasp.drones import VaspDrone +from atomate.vasp.fireworks.core import StaticFW +>>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) __author__ = "Anubhav Jain, Kiran Mathew, Shyam Dwaraknath" __email__ = "ajain@lbl.gov, kmathew@lbl.gov, shyamd@lbl.gov" @@ -1779,11 +1799,16 @@ class CSLDForceConstantsToDB(FiretaskBase): # to a .json file. """ - required_params = ["db_file", "wf_uuid", "parent_structure", - "perturbed_supercells", - "trans_mat", "supercell_structure", - "supercell_smallest_dim", - "disps"] + logger = get_logger(__name__) + + required_params = ["db_file", + "wf_uuid", "parent_structure", + "perturbed_supercells", + "trans_mat", "supercell_structure", + "supercell_smallest_dim", + "disps", "first_pass"] + + optional_params = ["static_user_incar_settings", "env_vars"] def random_search(self, maxIter): """ @@ -1838,11 +1863,9 @@ def random_search(self, maxIter): return cluster_diam_settings, max_order_settings, submodel1_settings - def set_params(self, iteration_number, cluster_diam, max_order, submodel1, - export_sbte): + def set_params(self, iteration_number, cluster_diam, max_order, submodel1, export_sbte): from configparser import ConfigParser - supercell_folder = self[ - "parent_structure"].composition.reduced_formula + \ + supercell_folder = self["parent_structure"].composition.reduced_formula + \ "_supercell_iter" + str(iteration_number) # Remove supercell_folder if it already exists, then make a new one @@ -1854,19 +1877,16 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, # POSCAR to file np.savetxt(supercell_folder + "/sc.txt", self["trans_mat"], fmt="%.0f", delimiter=" ") - self["supercell_structure"].to("poscar", - filename=supercell_folder + "/SPOSCAR") - self["parent_structure"].to("poscar", - filename=supercell_folder + "/POSCAR") + self["supercell_structure"].to("poscar", filename=supercell_folder + "/SPOSCAR") + self["parent_structure"].to("poscar", filename=supercell_folder + "/POSCAR") # Create folders for perturbed supercell POSCARS and force.txt's disp_folders = [] csld_traindat_disp_folders = '' for idx, disp in enumerate(self["disps"]): disp_folder = supercell_folder + '/disp' + str(disp) - disp_folders += [disp_folder] # list of folder paths - csld_traindat_disp_folders += ' ' + str( - disp_folder) # Create string for CSLD input + disp_folders += [disp_folder] # list of folder paths + csld_traindat_disp_folders += ' ' + str(disp_folder) # Create string for CSLD input if os.path.exists(disp_folder) and os.path.isdir(disp_folder): shutil.rmtree(disp_folder) os.mkdir(disp_folder) @@ -1889,7 +1909,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, # Create ConfigParser of all CSLD input settings csld_settings = ConfigParser() csld_settings['structure'] = { - 'prim': supercell_folder + '/POSCAR', # original structure poscar + 'prim': supercell_folder + '/POSCAR', # original structure poscar 'sym_tol': '1e-3', # 'epsilon_inf': None, # check how it reads 3x3 matrix # 'born_charge': None # check reading n_atom*9 numbers @@ -1900,10 +1920,9 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, 'cluster_out': 'clusters.out', 'symC_in': 'Cmat.mtx', 'symC_out': 'Cmat.mtx', - 'max_order': max_order, # 3, # this should be variable + 'max_order': max_order, # 3, # this should be variable 'fractional_distance': False, - 'cluster_diameter': cluster_diam, - # '11 6.5 5.0', #this should be variable + 'cluster_diameter': cluster_diam, # '11 6.5 5.0', #this should be variable 'cluster_filter': r"lambda cls: ((cls.order_uniq <= 2) or " r"(cls.bond_counts(2.9) >= 2)) and " r"cls.is_small_in('" + supercell_folder + "/sc.txt')" @@ -1916,8 +1935,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, 'corr_out': 'Amat.mtx', 'fval_in': 'fval.txt', 'fval_out': 'fval.txt', - 'traindat1': csld_traindat_string - # directories of unperturbed followed + 'traindat1': csld_traindat_string # directories of unperturbed followed # by perturbed supercell poscars # 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' # Rewrote how it reads forces @@ -1939,7 +1957,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, 'subsetsize': 0.85, 'lambda': 0.5, 'uscale_list': '0.03', - 'submodel1': submodel1, # 'anh 0 1 2 3', # this should be variable + 'submodel1': submodel1, # 'anh 0 1 2 3', # this should be variable } csld_settings['phonon'] = { 'qpoint_fractional': False, @@ -1966,7 +1984,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, 'thermal_out': 'thermal_out.txt' } csld_settings['export_potential'] = { - 'export_shengbte': export_sbte, # '5 5 5 2 3' # 5x5x5 supercell + 'export_shengbte': export_sbte, # '5 5 5 2 3' # 5x5x5 supercell # 2 and 3 orders to be considered # should be variable? } @@ -1993,8 +2011,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, csld_options['ldff_step'] = 0 csld_options['phonon_step'] = 1 csld_options['phonon'] = False - csld_options[ - 'save_pot_step'] = 1 # usual default is 0. 1 means output to ShengBTE format. + csld_options['save_pot_step'] = 1 # usual default is 0. 1 means output to ShengBTE format. csld_options['pot'] = False # set default values @@ -2025,20 +2042,25 @@ def run_task(self, fw_spec): summaries = [] # - # cluster_diam_settings = ['11 6.5 5.0'] - # max_order_settings = [3] - # submodel1_settings = ['anh 0 1 2 3'] - # export_sbte_settings = ['5 5 5 2 3'] - - cluster_diam_settings, max_order_settings, submodel1_settings = self.random_search( - maxIter) + cluster_diam_settings = ['11 6.5 5.0', + '9 6.5 5.0'] + max_order_settings = [3] * len(cluster_diam_settings) + submodel1_settings = ['anh 0 1 2 3'] * len(cluster_diam_settings) + export_sbte_settings = ['5 5 5 2 3'] * len(cluster_diam_settings) + if self["first_pass"] is False: + max_order_settings += [4] * len(cluster_diam_settings) + cluster_diam_settings += cluster_diam_settings + submodel1_settings += submodel1_settings + export_sbte_settings += export_sbte_settings + + # cluster_diam_settings, max_order_settings, submodel1_settings = self.random_search(maxIter) + # export_sbte_settings = ['5 5 5 2 3'] * maxIter print('cluster_diam') print(cluster_diam_settings) print('max order') print(max_order_settings) print('submodel') print(submodel1_settings) - export_sbte_settings = ['5 5 5 2 3'] * maxIter while not_converged and iter < maxIter: self.set_params(iter, @@ -2101,7 +2123,7 @@ def run_task(self, fw_spec): # [-1, 1, 1]] #(nbands, nkpoints) freq_matrix = np.asarray(freq_matrix) - imaginary_idx = freq_matrix < -0.01 # UPDATE THIS NUMBER TO HAVE SOME CUSHION + imaginary_idx = freq_matrix < -1 # UPDATE THIS NUMBER TO HAVE SOME CUSHION imaginary_freqs = freq_matrix[imaginary_idx] print('IMAGINARY FREQUENCIES') print(imaginary_freqs) @@ -2183,9 +2205,64 @@ def run_task(self, fw_spec): else: # logger.info("Compressed Sensing Lattice Dynamics calculation failed." # "Max iterations was reached.") - raise TimeoutError( - "The workflow was unable to find a solution to CSLD" - " for this material.") + if self["parent_structure"].num_sites > 5 and self["first_pass"]: + # logger.info("Compressed Sensing Lattice Dynamics calculation failed." + # " Max iterations was reached. Creating larger displacements" + # " and trying again,") + print('placeholder') + new_fws = [] + + # Create new perturbed supercells + more_perturbed_supercells_transform = PerturbSitesTransformation( + max_displacement=0.2, + min_displacement=0.12, + num_displacements=5, + structures_per_displacement_distance=1, + min_random_distance=None + ) + more_perturbed_supercells = more_perturbed_supercells_transform.apply_transformation(self["supercell_structure"]) + more_disps = more_perturbed_supercells_transform.disps + + # Create new static FWs + for idx, more_perturbed_supercell in enumerate(more_perturbed_supercells): + name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format(idx+len(self["perturbed_supercells"]), + more_disps) + static_vis = MPStaticSet(more_perturbed_supercell, + user_incar_settings=self["static_user_incar_settings"]) + + new_fws.append(StaticFW( + more_perturbed_supercell, + vasp_input_set=static_vis, + vasp_cmd=self["env_vars"]["VASP_CMD"], + db_file=self["env_vars"]["DB_FILE"], + name=name + " static" + )) + + # Create new CSLD FW + new_csld_fw = Firework( + CSLDForceConstantsToDB( + db_file=self["env_vars"]["DB_FILE"], + wf_uuid=self["wf_uuid"], + name='CSLDForceConstantsToDB', + parent_structure=self["parent_structure"], + trans_mat=self["trans_mat"], + supercell_structure=self["supercell_structure"], + supercell_smallest_dim=self["supercell_smallest_dim"], + perturbed_supercells=self["perturbed_supercells"]+more_perturbed_supercells, + disps=self["disps"]+more_disps, + first_pass=False + ), + name="Compressed Sensing Lattice Dynamics", + parents=new_fws[-len(more_perturbed_supercells):] + ) + new_fws.append(new_csld_fw) + + # Dynamically add new fireworks to the workflow + return FWAction(additions=new_fws) + + else: + raise TimeoutError("The workflow was unable to find a solution to CSLD" + " for this material.") # the following definitions for backward compatibility diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 993cbb129..5a4e1890c 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -181,7 +181,10 @@ def _add_metadata(structure): supercell_structure=self.supercell, supercell_smallest_dim=self.supercell_smallest_dim, perturbed_supercells=self.perturbed_supercells, - disps=self.disps + disps=self.disps, + first_pass=True, + static_user_incar_settings=static_user_incar_settings, + env_vars=c ), name="Compressed Sensing Lattice Dynamics", parents=fws[-len(self.perturbed_supercells):] From fa59f5c711f29d9c8aa8f9bd808e36af06797cc6 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 26 Jul 2019 14:20:58 -0700 Subject: [PATCH 024/207] Added fw_spec updates to all dynamically added fireworks and wrote a ShengBTE firetask --- atomate/vasp/firetasks/parse_outputs.py | 162 +++++++++++++++++++++--- atomate/vasp/workflows/base/csld.py | 13 +- 2 files changed, 155 insertions(+), 20 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 99a902b45..cbd49b086 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -53,8 +53,11 @@ from atomate.vasp.drones import BADER_EXE_EXISTS, VaspDrone ======= from atomate.vasp.drones import VaspDrone +<<<<<<< HEAD from atomate.vasp.fireworks.core import StaticFW >>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) +======= +>>>>>>> fd3cc888 (Added fw_spec updates to all dynamically added fireworks and wrote a ShengBTE firetask) __author__ = "Anubhav Jain, Kiran Mathew, Shyam Dwaraknath" __email__ = "ajain@lbl.gov, kmathew@lbl.gov, shyamd@lbl.gov" @@ -2184,9 +2187,9 @@ def run_task(self, fw_spec): iter = self['convergence_info']['iteration'] - # mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] - # mmdb.collection.insert(summaries) - mmdb.compressed_sensing_lattice_dynamics.insert(summaries) + mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] + mmdb.collection.insert(summaries) + # mmdb.compressed_sensing_lattice_dynamics.insert(summaries) best_idx = self["convergence_info"]["cross_val_errors"].index( min(self["convergence_info"]["cross_val_errors"])) @@ -2198,18 +2201,28 @@ def run_task(self, fw_spec): if not_converged is False: # logger.info("Compressed Sensing Lattice Dynamics calculation complete.") # from fireworks.core.firework import Firework - # shengbte_fw = Firework(', {fw_spec: dict of info to pass to next firework}') - # BTE.err >BTE.out> - # return FWAction(additions=shengbte_fw) - raise NotImplementedError("Implement ShengBTE firework") + shengbte_fw = Firework( + ShengBTEToDB( + parent_structure=self["parent_structure"], + shengbte_cmd=">>shengbte_cmd<<", + db_file=self["db_file"], + wf_uuid=self["wf_uuid"] + ) + ) + shengbte_fw.spec["_fworker"] = fw_spec["_fworker"] + CSLD_path = self.get("path", os.getcwd()) + shengbte_fw.spec["successful_CSLD_path"] = CSLD_path + if fw_spec.get("tags", None): + shengbte_fw.spec["tags"] = fw_spec["tags"] + return FWAction(additions=shengbte_fw) + # raise NotImplementedError("Implement ShengBTE firework") else: - # logger.info("Compressed Sensing Lattice Dynamics calculation failed." - # "Max iterations was reached.") + logger.info("Compressed Sensing Lattice Dynamics calculation failed." + "Max iterations was reached.") if self["parent_structure"].num_sites > 5 and self["first_pass"]: - # logger.info("Compressed Sensing Lattice Dynamics calculation failed." - # " Max iterations was reached. Creating larger displacements" - # " and trying again,") - print('placeholder') + logger.info("Compressed Sensing Lattice Dynamics calculation failed." + " Max iterations was reached. Creating larger displacements" + " and trying again,") new_fws = [] # Create new perturbed supercells @@ -2230,13 +2243,18 @@ def run_task(self, fw_spec): static_vis = MPStaticSet(more_perturbed_supercell, user_incar_settings=self["static_user_incar_settings"]) - new_fws.append(StaticFW( + from atomate.vasp.fireworks.core import StaticFW + new_static_fw = StaticFW( more_perturbed_supercell, vasp_input_set=static_vis, vasp_cmd=self["env_vars"]["VASP_CMD"], db_file=self["env_vars"]["DB_FILE"], name=name + " static" - )) + ) + new_static_fw.spec["_fworker"] = fw_spec["_fworker"] + if fw_spec.get("tags", None): + new_static_fw.spec["tags"] = fw_spec["tags"] + new_fws.append(new_static_fw) # Create new CSLD FW new_csld_fw = Firework( @@ -2255,6 +2273,9 @@ def run_task(self, fw_spec): name="Compressed Sensing Lattice Dynamics", parents=new_fws[-len(more_perturbed_supercells):] ) + new_csld_fw.spec["_fworker"] = fw_spec["_fworker"] + if fw_spec.get("tags", None): + new_csld_fw.spec["tags"] = fw_spec["tags"] new_fws.append(new_csld_fw) # Dynamically add new fireworks to the workflow @@ -2264,6 +2285,117 @@ def run_task(self, fw_spec): raise TimeoutError("The workflow was unable to find a solution to CSLD" " for this material.") +@explicit_serialize +class ShengBTEToDB(FiretaskBase): + """ + Run ShengBTE + + Required parameters: + db_file (str): path to the db file that holds your tasks + collection and that you want to hold the magnetic_orderings + collection + wf_uuid (str): auto-generated from get_wf_magnetic_orderings, + used to make it easier to retrieve task docs + parent_structure (Structure): material that CSLD is being run on + csld_settings (ConfigParser): settings for running CSLD + csld_options (dict): options for running CSLD + # Optional parameters: + # to_db (bool): if True, the data will be inserted into + # dedicated collection in database, otherwise, will be dumped + # to a .json file. + """ + + required_params = ["parent_structure", "shengbte_cmd", "db_file", + "wf_uuid"] + + def run_task(self, fw_spec): + from atomate.utils.utils import env_chk + import subprocess + from pymatgen.io.vasp.inputs import Kpoints + import six + import shlex + + # Generate CONTROL file + from pymatgen.io.shengbte import Control + qpts = Kpoints.automatic_density(self["parent_structure"], 50000) + unique_elements = [ + str(self["parent_structure"].types_of_specie[i]) + for i in range(len(self["parent_structure"].types_of_specie)) + ] + nonunique_elements_list = [ + str(self["parent_structure"].species[i]) + for i in range(len(self["parent_structure"].species)) + ] + element_to_number = {ele: idx + 1 for (idx, ele) in + enumerate(unique_elements)} + shengbte_control_dict = { + 'nelements': self["parent_structure"].ntypesp, + 'natoms': self["parent_structure"].num_sites, + 'ngrid': qpts.qpts[0], #[25, 25, 25], # NEED TO GENERATE THIS BY DENSITY + 'norientations': 0, + + 'lfactor': 0.1, # 0.1 nm = 1 Ang + 'lattvec': self["parent_structure"].lattice.matrix.tolist(), + 'elements': unique_elements, + 'types': [element_to_number[ele] for ele in + nonunique_elements_list], + 'positions': [ + self["parent_structure"].sites[i]._frac_coords.tolist() + for i in range(self["parent_structure"].num_sites) + ], + 'scell': [5, 5, 5], + 't': 300, + 'scalebroad': 0.5, + 'nonanalytic': False, + 'isotopes': False, + } + io = Control.from_dict(shengbte_control_dict) + io.to_file() #writes CONTROL file to current directory + + # Copy force constants from previous CSLD firework + force_constants_path = fw_spec["successful_CSLD_path"] + shutil.copy(force_constants_path+"/FORCE_CONSTANTS_2ND", os.getcwd()) + shutil.copy(force_constants_path+"/FORCE_CONSTANTS_3RD", os.getcwd()) + + # Set up/run ShengBTE + shengbte_cmd = env_chk(self["shengbte_cmd"], fw_spec) + if isinstance(shengbte_cmd, six.string_types): + shengbte_cmd = os.path.expandvars(shengbte_cmd) + shengbte_cmd = shlex.split(shengbte_cmd) + shengbte_cmd = list(shengbte_cmd) + logger.info("Running command: {}".format(shengbte_cmd)) + return_code = subprocess.call(shengbte_cmd) #call() waits for the process to finish + logger.info("Command {} finished running with returncode: {}".format(shengbte_cmd, return_code)) + + try: + flattened_kappa = np.loadtxt('BTE.kappa_tensor')[1][1:] #xx, xy, xz, yx, yy, yz, zx, zy, zz + + # Save to DB + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + tasks = mmdb["tasks"] + summary = { + "date": datetime.now(), + "parent_structure": self["parent_structure"].as_dict(), + "wf_meta": {"wf_uuid": self["wf_uuid"]}, + "kappa_xx": flattened_kappa[0], + "kappa_xy": flattened_kappa[1], + "kappa_xz": flattened_kappa[2], + "kappa_yx": flattened_kappa[3], + "kappa_yy": flattened_kappa[4], + "kappa_yz": flattened_kappa[5], + "kappa_zx": flattened_kappa[6], + "kappa_zy": flattened_kappa[7], + "kappa_zz": flattened_kappa[8] + } + if fw_spec.get("tags", None): + summary["tags"] = fw_spec["tags"] + + mmdb.collection = mmdb.db["sheng_bte"] + mmdb.collection.insert(summary) + except: + raise FileNotFoundError('BTE.kappa_tensor was not output from ShengBTE.') + # the following definitions for backward compatibility class VaspToDbTask(VaspToDb): diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 5a4e1890c..0c8252a43 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -175,7 +175,6 @@ def _add_metadata(structure): CSLDForceConstantsToDB( db_file=c["DB_FILE"], # wot wf_uuid=self.uuid, - name='CSLDForceConstantsToDB', parent_structure=self.parent_structure, trans_mat=self.trans_mat, supercell_structure=self.supercell, @@ -210,7 +209,7 @@ def _add_metadata(structure): from fireworks import LaunchPad from pymatgen.ext.matproj import MPRester - from atomate.vasp.powerups import add_tags, set_execution_options + from atomate.vasp.powerups import add_tags, set_execution_options, add_modify_incar #get a structure # mpr = MPRester(api_key='auNIrJ23VLXCqbpl') @@ -247,12 +246,16 @@ def _add_metadata(structure): print(csld_class.supercell.num_sites) csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_Sr8Sb4Au4") - wf = add_tags(wf, ['csld', 'v1', 'rees', 'Sr8Sb4Au4', '10disps_1each']) + wf = add_tags(wf, ['csld', 'v1', 'rees', 'Sr8Sb4Au4', '10disps_1each', '8nodes', + 'encut 500', 'ispin 1']) wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks + wf = add_modify_incar(wf, + modify_incar_params={'incar_update': {'ENCUT': 500, + 'ISPIN': 1}}) print(wf) - # lpad = LaunchPad.auto_load() - # lpad.add_wf(wf) + lpad = LaunchPad.auto_load() + lpad.add_wf(wf) # uuid # 0ff0d430-b43f-4cb5-ac8b-55c465b7867c From 706c9a2ed72916b65de68a36307bc6699a5577ea Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 26 Jul 2019 14:40:04 -0700 Subject: [PATCH 025/207] Added optional temperature ranges for shengbte --- atomate/vasp/firetasks/parse_outputs.py | 12 ++++++++++-- 1 file changed, 10 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index cbd49b086..e3d0ac52e 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1811,7 +1811,7 @@ class CSLDForceConstantsToDB(FiretaskBase): "supercell_smallest_dim", "disps", "first_pass"] - optional_params = ["static_user_incar_settings", "env_vars"] + optional_params = ["static_user_incar_settings", "env_vars", "shengbte_temps"] def random_search(self, maxIter): """ @@ -2206,7 +2206,10 @@ def run_task(self, fw_spec): parent_structure=self["parent_structure"], shengbte_cmd=">>shengbte_cmd<<", db_file=self["db_file"], - wf_uuid=self["wf_uuid"] + wf_uuid=self["wf_uuid"], + t_max=self["shengbte_temps"]["t_max"], + t_min=self["shengbte_temps"]["t_min"], + t_step=self["shengbte_temps"]["t_step"] ) ) shengbte_fw.spec["_fworker"] = fw_spec["_fworker"] @@ -2307,6 +2310,7 @@ class ShengBTEToDB(FiretaskBase): required_params = ["parent_structure", "shengbte_cmd", "db_file", "wf_uuid"] + optional_params = ["t_max", "t_min", "t_step"] def run_task(self, fw_spec): from atomate.utils.utils import env_chk @@ -2349,6 +2353,10 @@ def run_task(self, fw_spec): 'nonanalytic': False, 'isotopes': False, } + if self["shengbte_tmax"] and self["shengbte_tmin"] and self["shengbte_tstep"]: + shengbte_control_dict['t_min'] = self["t_min"] + shengbte_control_dict['t_max'] = self["t_max"] + shengbte_control_dict['t_step'] = self["t_step"] io = Control.from_dict(shengbte_control_dict) io.to_file() #writes CONTROL file to current directory From 63bcd4bf25cabb8842ae15f84dceac74d2741579 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 26 Jul 2019 14:40:26 -0700 Subject: [PATCH 026/207] Added optional temperature ranges for shengbte --- atomate/vasp/workflows/base/csld.py | 14 ++++++++++++-- 1 file changed, 12 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 0c8252a43..c6b12db2a 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -47,7 +47,10 @@ def __init__( num_displacements=10, supercells_per_displacement_distance=1, min_random_distance=None, - #csld input params here + shengbte_tmin=None, + shengbte_tmax=None, + shengbte_tstep=None + #csld input params here? ): """ This workflow will use compressed sensing lattice dynamics (CSLD) @@ -108,6 +111,10 @@ def __init__( self.disps = np.repeat(perturbed_supercells_transform.disps, supercells_per_displacement_distance) + self.shengbte_tmax = shengbte_tmax + self.shengbte_tmin = shengbte_tmin + self.shengbte_tstep = shengbte_tstep + def get_wf( self, c=None @@ -183,7 +190,10 @@ def _add_metadata(structure): disps=self.disps, first_pass=True, static_user_incar_settings=static_user_incar_settings, - env_vars=c + env_vars=c, + shengbte_temps={'t_max': self.shengbte_tmax, + 't_min': self.shengbte_tmin, + 't_step': self.shengbte_tstep} ), name="Compressed Sensing Lattice Dynamics", parents=fws[-len(self.perturbed_supercells):] From d5852e6831107158c29b6035f08a34e7a6f7a977 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 26 Jul 2019 15:55:28 -0700 Subject: [PATCH 027/207] Edited shengbte t_range option and created a CSLD preset workflow --- atomate/vasp/firetasks/parse_outputs.py | 58 ++++++++++++------------- atomate/vasp/workflows/base/csld.py | 15 ++----- atomate/vasp/workflows/presets/core.py | 41 +++++++++++++++++ 3 files changed, 73 insertions(+), 41 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index e3d0ac52e..817b54fa8 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1811,7 +1811,7 @@ class CSLDForceConstantsToDB(FiretaskBase): "supercell_smallest_dim", "disps", "first_pass"] - optional_params = ["static_user_incar_settings", "env_vars", "shengbte_temps"] + optional_params = ["static_user_incar_settings", "env_vars", "shengbte_t_range"] def random_search(self, maxIter): """ @@ -2207,9 +2207,7 @@ def run_task(self, fw_spec): shengbte_cmd=">>shengbte_cmd<<", db_file=self["db_file"], wf_uuid=self["wf_uuid"], - t_max=self["shengbte_temps"]["t_max"], - t_min=self["shengbte_temps"]["t_min"], - t_step=self["shengbte_temps"]["t_step"] + t_range=self["shengbte_t_range"] ) ) shengbte_fw.spec["_fworker"] = fw_spec["_fworker"] @@ -2310,7 +2308,7 @@ class ShengBTEToDB(FiretaskBase): required_params = ["parent_structure", "shengbte_cmd", "db_file", "wf_uuid"] - optional_params = ["t_max", "t_min", "t_step"] + optional_params = ["t_range"] #boolean for multiple temperatures def run_task(self, fw_spec): from atomate.utils.utils import env_chk @@ -2353,10 +2351,10 @@ def run_task(self, fw_spec): 'nonanalytic': False, 'isotopes': False, } - if self["shengbte_tmax"] and self["shengbte_tmin"] and self["shengbte_tstep"]: - shengbte_control_dict['t_min'] = self["t_min"] - shengbte_control_dict['t_max'] = self["t_max"] - shengbte_control_dict['t_step'] = self["t_step"] + if self["t_range"]: + shengbte_control_dict['t_min'] = 100 + shengbte_control_dict['t_max'] = 1000 + shengbte_control_dict['t_step'] = 100 io = Control.from_dict(shengbte_control_dict) io.to_file() #writes CONTROL file to current directory @@ -2376,31 +2374,31 @@ def run_task(self, fw_spec): logger.info("Command {} finished running with returncode: {}".format(shengbte_cmd, return_code)) try: - flattened_kappa = np.loadtxt('BTE.kappa_tensor')[1][1:] #xx, xy, xz, yx, yy, yz, zx, zy, zz - - # Save to DB db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - tasks = mmdb["tasks"] - summary = { - "date": datetime.now(), - "parent_structure": self["parent_structure"].as_dict(), - "wf_meta": {"wf_uuid": self["wf_uuid"]}, - "kappa_xx": flattened_kappa[0], - "kappa_xy": flattened_kappa[1], - "kappa_xz": flattened_kappa[2], - "kappa_yx": flattened_kappa[3], - "kappa_yy": flattened_kappa[4], - "kappa_yz": flattened_kappa[5], - "kappa_zx": flattened_kappa[6], - "kappa_zy": flattened_kappa[7], - "kappa_zz": flattened_kappa[8] - } - if fw_spec.get("tags", None): - summary["tags"] = fw_spec["tags"] + if self["t_range"]: + temps = np.linspace(100, 1000, 10) + else: + temps = 300 + + # Save to DB + summaries = [] + for temp in temps: + # xx, xy, xz, yx, yy, yz, zx, zy, zz + flattened_kappa = list(np.loadtxt('t'+str(temp)+'K/BTE.kappa_tensor')[1][1:]) + summary = { + "date": datetime.now(), + "temperature": temp, + "parent_structure": self["parent_structure"].as_dict(), + "wf_meta": {"wf_uuid": self["wf_uuid"]}, + "flattened_kappa": flattened_kappa + } + if fw_spec.get("tags", None): + summary["tags"] = fw_spec["tags"] + summaries.append(summary) mmdb.collection = mmdb.db["sheng_bte"] - mmdb.collection.insert(summary) + mmdb.collection.insert(summaries) except: raise FileNotFoundError('BTE.kappa_tensor was not output from ShengBTE.') diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index c6b12db2a..ee25558a9 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -47,9 +47,7 @@ def __init__( num_displacements=10, supercells_per_displacement_distance=1, min_random_distance=None, - shengbte_tmin=None, - shengbte_tmax=None, - shengbte_tstep=None + shengbte_t_range=False #whether to calculate 100-1000K or just 300K #csld input params here? ): """ @@ -111,10 +109,7 @@ def __init__( self.disps = np.repeat(perturbed_supercells_transform.disps, supercells_per_displacement_distance) - self.shengbte_tmax = shengbte_tmax - self.shengbte_tmin = shengbte_tmin - self.shengbte_tstep = shengbte_tstep - + self.shengbte_t_range = shengbte_t_range def get_wf( self, c=None @@ -154,7 +149,7 @@ def _add_metadata(structure): # Fast Fourier Transform grid "LCHARG": False, "ENCUT": 700, - "EDIFF": 1e-7, # may need to tune this + "EDIFF": 1e-8, # may need to tune this "PREC": 'Accurate', "LAECHG": False, "LREAL": False, @@ -191,9 +186,7 @@ def _add_metadata(structure): first_pass=True, static_user_incar_settings=static_user_incar_settings, env_vars=c, - shengbte_temps={'t_max': self.shengbte_tmax, - 't_min': self.shengbte_tmin, - 't_step': self.shengbte_tstep} + shengbte_t_range=self.shengbte_t_range ), name="Compressed Sensing Lattice Dynamics", parents=fws[-len(self.perturbed_supercells):] diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index d9634307e..3f9622b7e 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -826,3 +826,44 @@ def wf_nudged_elastic_band(structures, parent, c=None): ) return wf + + +def wf_lattice_thermal_conductivity(structure, c=None): + """ + Lattice thermal conductivity workflow from the given structure and config + dict. + + Args: + structure (Structure): input structure + c (dict): workflow config dict + + Returns: + Workflow + """ + from atomate.vasp.workflows.base.csld import CompressedSensingLatticeDynamicsWF + c = c or {} + vasp_cmd = c.get("VASP_CMD", VASP_CMD) + db_file = c.get("DB_FILE", DB_FILE) + + optimize = {"LAECHG": False, 'ENCUT': 700, + 'ADDGRID': True, 'EDIFFG': -5e-4, + 'PREC': 'Accurate', "LREAL": False, + 'EDIFF': 1e-8, "ISMEAR": 0, + 'LCHARG': False, 'LASPH': True} + vis_relax = MPRelaxSet(structure, user_incar_settings=optimize) + wf = get_wf(structure, "optimize_only.yaml", vis=vis_relax, + params=[{"vasp_cmd": vasp_cmd, "db_file": db_file, + "name": "phonon structure optimization"}]) + wf_csld = CompressedSensingLatticeDynamicsWF(structure, + num_nn_dists=5, + num_displacements=10, + supercells_per_displacement_distance=1).get_wf() + + wf.append(wf_csld, wf.leaf_fw_ids) + wf = add_common_powerups(wf, c) + + if c.get("ADD_WF_METADATA", ADD_WF_METADATA): + wf = add_wf_metadata(wf, structure) + + return wf + From e403133967c3bf729c19ae513f3d3cd0b38a5cb5 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 26 Jul 2019 16:07:07 -0700 Subject: [PATCH 028/207] Minor edits --- atomate/vasp/firetasks/parse_outputs.py | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 817b54fa8..f2d5e74dc 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -2289,7 +2289,7 @@ def run_task(self, fw_spec): @explicit_serialize class ShengBTEToDB(FiretaskBase): """ - Run ShengBTE + Run ShengBTE and output the lattice thermal conductivity matrix to database. Required parameters: db_file (str): path to the db file that holds your tasks @@ -2385,13 +2385,13 @@ def run_task(self, fw_spec): summaries = [] for temp in temps: # xx, xy, xz, yx, yy, yz, zx, zy, zz - flattened_kappa = list(np.loadtxt('t'+str(temp)+'K/BTE.kappa_tensor')[1][1:]) + flattened_kappa = list(np.loadtxt('T'+str(int(temp))+'K/BTE.kappa_tensor')[1][1:]) summary = { "date": datetime.now(), "temperature": temp, "parent_structure": self["parent_structure"].as_dict(), "wf_meta": {"wf_uuid": self["wf_uuid"]}, - "flattened_kappa": flattened_kappa + str(temp)+" K": {"flattened_kappa": flattened_kappa} } if fw_spec.get("tags", None): summary["tags"] = fw_spec["tags"] From fdbde4b904789c7f9c1cb56ea4291eacc2a6b913 Mon Sep 17 00:00:00 2001 From: reeschang Date: Mon, 29 Jul 2019 17:16:45 -0700 Subject: [PATCH 029/207] Added documentation and cleaned up comments --- atomate/vasp/firetasks/parse_outputs.py | 99 ++++++++++++++----------- atomate/vasp/workflows/base/csld.py | 19 ----- 2 files changed, 54 insertions(+), 64 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index f2d5e74dc..7e3ea5ce4 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1784,22 +1784,41 @@ class CSLDForceConstantsToDB(FiretaskBase): #TODO: Update this class once Junsoo has fixed the cluster generation """ Used to aggregate atomic forces of perturbed supercells in compressed - sensing lattice dynamics (CSLD) workflow and generate interatomic force - constants. + sensing lattice dynamics (CSLD) workflow and generate/write interatomic + force constants up to 3rd order to file. The workflow uses a CSLD software + implemented by Zhou et al which can be found at https://github.com/LLNL/csld. Required parameters: db_file (str): path to the db file that holds your tasks - collection and that you want to hold the magnetic_orderings - collection - wf_uuid (str): auto-generated from get_wf_magnetic_orderings, - used to make it easier to retrieve task docs - parent_structure (Structure): material that CSLD is being run on - csld_settings (ConfigParser): settings for running CSLD - csld_options (dict): options for running CSLD - # Optional parameters: - # to_db (bool): if True, the data will be inserted into - # dedicated collection in database, otherwise, will be dumped - # to a .json file. + collection specifying the database that the perturbed supercell + forces are stored and that CSLD results should be stored to + wf_uuid (str): auto-generated from CompressedSensingLatticeDynamicsWF, + used to make it easier to retrieve task docs + parent_structure (Structure): input (usually primitive) structure on + which CSLD is being done + perturbed_supercells (list of Structures): list of perturbed supercell + structures auto-generated from CompressedSensingLatticeDynamicsWF + trans_mat (3x3 np.ndarray): supercell transformation matrix auto- + generated from CompressedSensingLatticeDynamicsWF + supercell_structure (Structure): supercell structure of parent_structure, + auto-generated from CompressedSensingLatticeDynamicsWF + supercell_smallest_dim (float): length of shortest direction of the + supercell lattice, auto-generated from + CompressedSensingLatticeDynamicsWF + disps (list of floats): displacement values corresponding to + perturbed_supercells, auto-generated from + CompressedSensingLatticeDynamicsWF + first_pass (boolean): indicator of whether this firetask has already + been attempted or if it is automatically running a second time + with larger perturbations + static_user_incar_settings (dict): incar settings used in static calculations + in CompressedSensingLatticeDynamicsWF + env_vars (dict): environmental variables used in static calculations in + CompressedSensingLatticeDynamicsWF + Optional parameters: + shengbte_t_range (boolean): If True, pass to the ShengBTEToDB firetask + that lattice thermal conductivity should be calculated for 100 K to + 1000 K in steps of 100 K. If False, only calculate at 300 K. """ logger = get_logger(__name__) @@ -1809,9 +1828,10 @@ class CSLDForceConstantsToDB(FiretaskBase): "perturbed_supercells", "trans_mat", "supercell_structure", "supercell_smallest_dim", - "disps", "first_pass"] + "disps", "first_pass", + "static_user_incar_settings", "env_vars"] - optional_params = ["static_user_incar_settings", "env_vars", "shengbte_t_range"] + optional_params = ["shengbte_t_range"] def random_search(self, maxIter): """ @@ -1843,7 +1863,6 @@ def random_search(self, maxIter): -If bad, then fit including supercells >0.1 angstroms -If good, run SBTE -If bad, redo step 2 with 4th order - :return: """ import random @@ -1852,8 +1871,8 @@ def random_search(self, maxIter): cluster_diam_settings = [] for _ in range(maxIter): - pair_diam = random.uniform(10, 14) #self["supercell_smallest_dim"]) - triplet_diam = random.uniform(pair_diam * 0.4, pair_diam) + pair_diam = random.uniform(8, 12) #self["supercell_smallest_dim"]) + triplet_diam = random.uniform(5.5, 7) quadruplet_diam = random.uniform(triplet_diam * 0.6, triplet_diam) cluster_diam_settings += [ @@ -2044,6 +2063,7 @@ def run_task(self, fw_spec): maxIter = 2 summaries = [] + #Set list of parameter settings to try (i.e. grid search settings) # cluster_diam_settings = ['11 6.5 5.0', '9 6.5 5.0'] @@ -2056,6 +2076,7 @@ def run_task(self, fw_spec): submodel1_settings += submodel1_settings export_sbte_settings += export_sbte_settings + ##Generate list of parameter settings to try from random search # cluster_diam_settings, max_order_settings, submodel1_settings = self.random_search(maxIter) # export_sbte_settings = ['5 5 5 2 3'] * maxIter print('cluster_diam') @@ -2090,7 +2111,6 @@ def run_task(self, fw_spec): # for each supercell supercells_forces = [] - # supercells_task_ids = [] supercells_task_labels = [] for supercell_dict in supercells_dicts: # List of np.ndarrays where each np.ndarray is a matrix of forces @@ -2098,9 +2118,6 @@ def run_task(self, fw_spec): supercells_forces += [ np.asarray(supercell_dict['output']['forces'])] - # #List of task ids for each perturbed supercell - # supercells_task_ids += [supercell_dict['task_id']] - supercells_task_labels += [supercell_dict['task_label']] supercells_zip = sorted( @@ -2121,12 +2138,9 @@ def run_task(self, fw_spec): from atomate.vasp.workflows.base.csld import csld_main rel_err, freq_matrix = csld_main(self["csld_options"], self["csld_settings"]) - # rel_err = 0.01 - # freq_matrix = [[1, -1, 1], - # [-1, 1, 1]] #(nbands, nkpoints) freq_matrix = np.asarray(freq_matrix) - imaginary_idx = freq_matrix < -1 # UPDATE THIS NUMBER TO HAVE SOME CUSHION + imaginary_idx = freq_matrix < -1 imaginary_freqs = freq_matrix[imaginary_idx] print('IMAGINARY FREQUENCIES') print(imaginary_freqs) @@ -2137,8 +2151,8 @@ def run_task(self, fw_spec): else: most_imaginary_freq = 0 print(most_imaginary_freq) - # For imaginary frequencies, w^2 is negative - # code handles it as w = sign(sqrt(abs(w^2)), w^2) + # For imaginary frequencies, w^2 is negative. + # Code handles it as w = sign(sqrt(abs(w^2)), w^2) if num_imaginary_bands == 0: not_converged = False @@ -2151,7 +2165,7 @@ def run_task(self, fw_spec): "parent_structure": self["parent_structure"].as_dict(), "wf_meta": {"wf_uuid": uuid}, - # + # Store relevant CSLD settings "iteration": iter, "cluster_diam": self["csld_settings"]["model"][ "cluster_diameter"], @@ -2162,7 +2176,6 @@ def run_task(self, fw_spec): "cross_val_error": float(rel_err), "num_imaginary_modes": int(num_imaginary_bands), - # number or percent? "most_imaginary_freq": float(most_imaginary_freq), "imaginary_freq_sum": float(sum(imaginary_freqs)) } @@ -2189,7 +2202,6 @@ def run_task(self, fw_spec): mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] mmdb.collection.insert(summaries) - # mmdb.compressed_sensing_lattice_dynamics.insert(summaries) best_idx = self["convergence_info"]["cross_val_errors"].index( min(self["convergence_info"]["cross_val_errors"])) @@ -2199,8 +2211,7 @@ def run_task(self, fw_spec): self["convergence_info"]["settings_tried"][best_idx])) if not_converged is False: - # logger.info("Compressed Sensing Lattice Dynamics calculation complete.") - # from fireworks.core.firework import Firework + logger.info("Compressed Sensing Lattice Dynamics calculation complete.") shengbte_fw = Firework( ShengBTEToDB( parent_structure=self["parent_structure"], @@ -2216,7 +2227,6 @@ def run_task(self, fw_spec): if fw_spec.get("tags", None): shengbte_fw.spec["tags"] = fw_spec["tags"] return FWAction(additions=shengbte_fw) - # raise NotImplementedError("Implement ShengBTE firework") else: logger.info("Compressed Sensing Lattice Dynamics calculation failed." "Max iterations was reached.") @@ -2288,22 +2298,21 @@ def run_task(self, fw_spec): @explicit_serialize class ShengBTEToDB(FiretaskBase): + #TODO: Test this firetask """ Run ShengBTE and output the lattice thermal conductivity matrix to database. Required parameters: + parent_structure (Structure): material that ShengBTE is being run on db_file (str): path to the db file that holds your tasks - collection and that you want to hold the magnetic_orderings - collection - wf_uuid (str): auto-generated from get_wf_magnetic_orderings, - used to make it easier to retrieve task docs - parent_structure (Structure): material that CSLD is being run on - csld_settings (ConfigParser): settings for running CSLD - csld_options (dict): options for running CSLD - # Optional parameters: - # to_db (bool): if True, the data will be inserted into - # dedicated collection in database, otherwise, will be dumped - # to a .json file. + collection specifying the database that ShengBTE results should be + stored to + shengbte_cmd (str): should be set to "<>" + wf_uuid (str): passed from the CSLDForceConstantsToDB firetask, + used for storing task docs + Optional parameters: + t_range (bool): If True, run lattice thermal conductivity calculations + at 100 K through 1000 K at steps of 100 K. """ required_params = ["parent_structure", "shengbte_cmd", "db_file", diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index ee25558a9..bba886f21 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -125,25 +125,6 @@ def _add_metadata(structure): structure, other_parameters={"wf_meta": self.wf_meta} ) - #TODO: Move this relaxation section elsewhere - # relax_user_incar_settings = {"EDIFF": 1e-8, - # "EDIFFG": -1e-5, - # } - # relax_vis = MPRelaxSet(self.parent_structure, - # user_incar_settings=relax_user_incar_settings) - # # relax - # fws.append( - # OptimizeFW( - # self.parent_structure, - # vasp_input_set=relax_vis, - # vasp_cmd=c["VASP_CMD"], - # db_file=c["DB_FILE"], - # max_force_threshold=0.05, #idk, should i change this? - # half_kpts_first_relax=False, #idk what this is - # name="{} - CSLD relax parent".format(self.parent_structure.composition.reduced_formula), - # ) - # ) - ##################### static_user_incar_settings = {"ADDGRID": True, # Fast Fourier Transform grid From efdfcbd6acf5830a8956d1c21cc01d95e67c06e9 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 31 Jul 2019 10:36:58 -0700 Subject: [PATCH 030/207] Updated to reflect changes in PerturbSitesTransformation and CSLD --- atomate/vasp/firetasks/parse_outputs.py | 8 ++++---- atomate/vasp/workflows/base/csld.py | 17 ++++++++++------- atomate/vasp/workflows/presets/core.py | 2 ++ 3 files changed, 16 insertions(+), 11 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 7e3ea5ce4..488aec335 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -2238,9 +2238,9 @@ def run_task(self, fw_spec): # Create new perturbed supercells more_perturbed_supercells_transform = PerturbSitesTransformation( - max_displacement=0.2, - min_displacement=0.12, - num_displacements=5, + max_disp=0.2, + min_disp=0.12, + num_disps=5, structures_per_displacement_distance=1, min_random_distance=None ) @@ -2342,7 +2342,7 @@ def run_task(self, fw_spec): shengbte_control_dict = { 'nelements': self["parent_structure"].ntypesp, 'natoms': self["parent_structure"].num_sites, - 'ngrid': qpts.qpts[0], #[25, 25, 25], # NEED TO GENERATE THIS BY DENSITY + 'ngrid': qpts.kpts[0], #[25, 25, 25], # NEED TO GENERATE THIS BY DENSITY 'norientations': 0, 'lfactor': 0.1, # 0.1 nm = 1 Ang diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index bba886f21..215ebdcd9 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -104,7 +104,8 @@ def __init__( min_random_distance ) # list of perturbed supercell structures (list) - self.perturbed_supercells = perturbed_supercells_transform.apply_transformation(self.supercell) + self.perturbed_supercells = [d['structure'] for d in + perturbed_supercells_transform.apply_transformation(self.supercell)] # list of (non-unique) displacement values used in the perturbation (np.ndarray) self.disps = np.repeat(perturbed_supercells_transform.disps, supercells_per_displacement_distance) @@ -233,9 +234,9 @@ def _add_metadata(structure): wf = add_tags(wf, ['csld', 'v1', 'rees', 'Sr8Sb4Au4', '10disps_1each', '8nodes', 'encut 500', 'ispin 1']) wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks - wf = add_modify_incar(wf, - modify_incar_params={'incar_update': {'ENCUT': 500, - 'ISPIN': 1}}) + # wf = add_modify_incar(wf, + # modify_incar_params={'incar_update': {'ENCUT': 500, + # 'ISPIN': 1}}) print(wf) lpad = LaunchPad.auto_load() @@ -274,8 +275,10 @@ def csld_main(options, settings): from csld.lattice_dynamics import init_ld_model from csld.common_main import upon_exit, \ - init_training, fit_data, phonon_step, \ - save_pot, predict + init_training + from csld.csld_main_functions import phonon_step, \ + save_pot, predict, fit_data + freq_matrix = None #Rees pdfout = PdfPages( @@ -294,7 +297,7 @@ def csld_main(options, settings): options['fit_step'], pdfout) if settings.has_section('phonon'): phonon, freq_matrix = phonon_step(model, solutions, settings['phonon'], - options['phonon_step'], pdfout, prim) + options['phonon_step'], pdfout, prim, return_eigen=True) if settings.has_section('export_potential'): save_pot(model, solutions[ibest], settings['export_potential'], options['save_pot_step'], phonon) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 3f9622b7e..9b722147b 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -845,6 +845,8 @@ def wf_lattice_thermal_conductivity(structure, c=None): vasp_cmd = c.get("VASP_CMD", VASP_CMD) db_file = c.get("DB_FILE", DB_FILE) + ## DFPT AT GAMMA POINT + optimize = {"LAECHG": False, 'ENCUT': 700, 'ADDGRID': True, 'EDIFFG': -5e-4, 'PREC': 'Accurate', "LREAL": False, From f71b330c48c8207aa63dbfc465c1f2a1401a9d73 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 31 Jul 2019 11:11:05 -0700 Subject: [PATCH 031/207] Preset runs smoothly. Waiting on Si test run scraped from MP --- atomate/vasp/workflows/presets/core.py | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 9b722147b..6e91dcb62 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -861,9 +861,13 @@ def wf_lattice_thermal_conductivity(structure, c=None): num_displacements=10, supercells_per_displacement_distance=1).get_wf() - wf.append(wf_csld, wf.leaf_fw_ids) + wf.append_wf(wf_csld, wf.leaf_fw_ids) wf = add_common_powerups(wf, c) + formula = structure.composition.reduced_formula + wf_name = "{} - lattice thermal conductivity preset".format(formula) + wf.name = wf_name + if c.get("ADD_WF_METADATA", ADD_WF_METADATA): wf = add_wf_metadata(wf, structure) From 9fa3175e0a4a69ceab80089044e1405058682e1d Mon Sep 17 00:00:00 2001 From: reeschang Date: Thu, 1 Aug 2019 13:44:00 -0700 Subject: [PATCH 032/207] - Updated workflow to reflect changes in PerturbStructureTransformation and diagonal CubicSupercellTransformation --- atomate/vasp/workflows/base/csld.py | 88 +++++++++++++++++++---------- 1 file changed, 59 insertions(+), 29 deletions(-) diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 215ebdcd9..f5aba8d41 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -7,9 +7,10 @@ from pymatgen.symmetry.analyzer import SpacegroupAnalyzer from pymatgen.alchemy.materials import TransformedStructure +from pymatgen.transformations.standard_transformations import \ + PerturbStructureTransformation from pymatgen.transformations.advanced_transformations import ( - CubicSupercellTransformation, - PerturbSitesTransformation + CubicSupercellTransformation ) from fireworks import Workflow, Firework from atomate.utils.utils import get_logger @@ -42,13 +43,13 @@ def __init__( min_atoms=-np.Inf, max_atoms=np.Inf, num_nn_dists=5, + force_diagonal_transformation=True, max_displacement=0.1, min_displacement=0.01, num_displacements=10, - supercells_per_displacement_distance=1, min_random_distance=None, - shengbte_t_range=False #whether to calculate 100-1000K or just 300K - #csld input params here? + supercells_per_displacement_distance=1, + shengbte_t_range=False ): """ This workflow will use compressed sensing lattice dynamics (CSLD) @@ -66,11 +67,39 @@ def __init__( 5. Output the interatomic force constants to the database. Args: - parent_structure (Structure): - min_atoms (int): - max_atoms (int): - num_nn_dists (int or float): - max_displacement (float) + parent_structure (Structure): Structure to primitize and conduct + CSLD on + symprec (float): symmetry precision parameter for + SpacegroupAnalyzer's 'get_primitive_standard_structure()' + function + min_atoms (int): Minimum number of atoms to constrain the supercell + max_atoms (int): Maximum number of atoms to constrain the supercell + num_nn_dists (int or float): Number of nearest neighbor distances + that the shortest direction of the supercell must be as long as + force_diagonal_transformation (bool): If True, the supercell + transformation will be constrained to have a diagonal + transformation matrix. If False, the supercell transformation + will not be constrained to be diagonal (resulting in a more + cubic supercell). + max_displacement (float): Maximum displacement distance for + perturbing the supercell structure (Angstroms) + min_displacement (float): Minimum displacement distance for + perturbing the supercell structure (Angstroms) + num_displacements (int): Number of unique displacement distances to + generate uniformly between 'min_displacement' and + 'max_displacement' + min_random_distance (Optional float): If None (default), then all + atoms in the supercell will move the same distance from their + original locations. If float, then for a given supercell, the + distances that atoms move will be uniformly distributed from a + minimum distance of 'min_random_distance' to one of the + displacement distances uniformly sampled between + 'min_displacement' and 'max_displacement'. + supercells_per_displacement_distance (int): number of supercells to + generate for each unique displacement distance. + shengbte_t_range (bool): If False (default), calculate the lattice + thermal conductivity with ShengBTE at 300 K. If True, do the + calculation from 100-1000 K with 100 K steps (much slower). """ self.uuid = str(uuid4()) self.wf_meta = { @@ -89,28 +118,29 @@ def __init__( self.min_atoms, self.max_atoms, self.num_nn_dists, + force_diagonal_transformation=force_diagonal_transformation ) # supercell (Structure) self.supercell = supercell_transform.apply_transformation(self.parent_structure) self.trans_mat = supercell_transform.trans_mat self.supercell_smallest_dim = supercell_transform.smallest_dim - # Generate randomly perturbed supercells - perturbed_supercells_transform = PerturbSitesTransformation( - max_displacement, - min_displacement, - num_displacements, - supercells_per_displacement_distance, - min_random_distance - ) - # list of perturbed supercell structures (list) - self.perturbed_supercells = [d['structure'] for d in - perturbed_supercells_transform.apply_transformation(self.supercell)] + # Generate list of perturbed supercells # list of (non-unique) displacement values used in the perturbation (np.ndarray) - self.disps = np.repeat(perturbed_supercells_transform.disps, - supercells_per_displacement_distance) + self.disps = np.repeat( + np.linspace(min_displacement, max_displacement, num_displacements), + supercells_per_displacement_distance + ) + self.min_random_distance = min_random_distance + self.perturbed_supercells = [] # list of perturbed supercell structures + for amplitude in self.disps: + perturb_structure_transformer = PerturbStructureTransformation(amplitude, + self.min_random_distance) + perturbed_supercell = perturb_structure_transformer.apply_transformation(self.supercell) + self.perturbed_supercells += [perturbed_supercell] self.shengbte_t_range = shengbte_t_range + def get_wf( self, c=None @@ -215,12 +245,13 @@ def _add_metadata(structure): from pymatgen.core.structure import Structure # prim = Structure.from_file('POSCAR_csld_primitivized') - prim = Structure.from_file('POSCAR-well_relaxed_Sr8Sb4Au4') + prim = Structure.from_file('POSCAR-well_relaxed_Si') csld_class = CompressedSensingLatticeDynamicsWF(prim, num_nn_dists=5, num_displacements=10, - supercells_per_displacement_distance=1) + supercells_per_displacement_distance=1, + ) print("uuid") print(csld_class.uuid) @@ -229,15 +260,14 @@ def _add_metadata(structure): print(csld_class.trans_mat) print(csld_class.supercell_smallest_dim) print(csld_class.supercell.num_sites) - csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_Sr8Sb4Au4") + csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_Si") - wf = add_tags(wf, ['csld', 'v1', 'rees', 'Sr8Sb4Au4', '10disps_1each', '8nodes', - 'encut 500', 'ispin 1']) + wf = add_tags(wf, ['csld', 'v1', 'rees', 'pre-relaxed si']) wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks # wf = add_modify_incar(wf, # modify_incar_params={'incar_update': {'ENCUT': 500, # 'ISPIN': 1}}) - print(wf) + # print(wf) lpad = LaunchPad.auto_load() lpad.add_wf(wf) From a893c2d5cd819303b5a1efad39ad165577485540 Mon Sep 17 00:00:00 2001 From: reeschang Date: Thu, 1 Aug 2019 14:55:52 -0700 Subject: [PATCH 033/207] -Added a new csld analysis file to atomate parse_outputs: - Made export_sbte be the diagonal of the trans_mat rather than 5,5,5 - Added supercell structure and trans_mat to the CSLD firework DB summary - Passed trans_mat into the sbte firetask csld: - Minor edits --- atomate/vasp/analysis/csld.py | 58 +++++++++++++++++++++++++ atomate/vasp/firetasks/parse_outputs.py | 35 +++++++++------ atomate/vasp/workflows/base/csld.py | 42 ++++++++++-------- 3 files changed, 104 insertions(+), 31 deletions(-) create mode 100644 atomate/vasp/analysis/csld.py diff --git a/atomate/vasp/analysis/csld.py b/atomate/vasp/analysis/csld.py new file mode 100644 index 000000000..8f624bce7 --- /dev/null +++ b/atomate/vasp/analysis/csld.py @@ -0,0 +1,58 @@ +# coding: utf-8 + +from __future__ import division, print_function, unicode_literals, absolute_import + +import numpy as np + +from pymatgen.transformations.standard_transformations import PerturbStructureTransformation + +__author__ = 'Rees Chang' +__email__ = 'rc564@cornell.edu' + + +def generate_perturbed_supercells(supercell, + min_displacement=0.01, max_displacement=0.1, + num_displacements=10, + supercells_per_displacement_distance=1, + min_random_distance=None): + """ + Generate a list of supercells with perturbed atomic sites. + + Args: + supercell (Structure): original structure whose atomic sites are to be + perturbed + max_displacement (float): maximum displacement distance for + perturbing the structure (Angstroms) + min_displacement (float): minimum displacement distance for + perturbing the structure (Angstroms) + num_displacements (int): number of unique displacement distances to + try, uniformly distributed between 'min_displacement' and + 'max_displacement'. + structures_per_displacement_distance (int): number of perturbed + structures to generate for each unique displacement distance. + min_random_distance (Optional float): If None (default), then for a + given perturbed structure, all atoms will move the same distance + from their original locations. If float, then for a given + perturbed structure, the distances that atoms move will be + uniformly distributed from a minimum distance of + 'min_random_distance' to one of the displacement distances + uniformly sampled between 'min_displacement' and + 'max_displacement'. + Returns: + (List of randomly displaced structures (List of Structures), + List of corresponding displacements) + """ + displacements = np.repeat( + np.linspace(min_displacement, max_displacement, num_displacements), + supercells_per_displacement_distance + ) + # self.min_random_distance = min_random_distance + perturbed_supercells = [] # list of perturbed supercell structures + for displacement in displacements: + perturb_structure_transformer = PerturbStructureTransformation( + displacement, + min_random_distance) + perturbed_supercell = perturb_structure_transformer.apply_transformation( + supercell) + perturbed_supercells += [perturbed_supercell] + return perturbed_supercells, displacements diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 488aec335..d8ccfed71 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -41,7 +41,7 @@ EnergyTrend from pymatgen.analysis.magnetism import CollinearMagneticStructureAnalyzer, Ordering, magnetic_deformation from pymatgen.command_line.bader_caller import bader_analysis_from_path -from pymatgen.transformations.advanced_transformations import PerturbSitesTransformation +from pymatgen.transformations.standard_transformations import PerturbStructureTransformation from pymatgen.io.vasp.sets import MPStaticSet >>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) @@ -2069,7 +2069,10 @@ def run_task(self, fw_spec): '9 6.5 5.0'] max_order_settings = [3] * len(cluster_diam_settings) submodel1_settings = ['anh 0 1 2 3'] * len(cluster_diam_settings) - export_sbte_settings = ['5 5 5 2 3'] * len(cluster_diam_settings) + export_sbte_string = str(self["trans_mat"][0][0]) + ' ' + \ + str(self["trans_mat"])[1][1] + ' ' + \ + str(self["trans_mat"])[2][2] + ' 2 3' + export_sbte_settings = [export_sbte_string] * len(cluster_diam_settings) if self["first_pass"] is False: max_order_settings += [4] * len(cluster_diam_settings) cluster_diam_settings += cluster_diam_settings @@ -2163,6 +2166,8 @@ def run_task(self, fw_spec): "formula": formula, "formula_pretty": formula_pretty, "parent_structure": self["parent_structure"].as_dict(), + "supercell_structure": self["supercell_structure"].as_dict(), + "supercell_transformation_matrix": self["trans_mat"].tolist(), "wf_meta": {"wf_uuid": uuid}, # Store relevant CSLD settings @@ -2174,11 +2179,13 @@ def run_task(self, fw_spec): "export_potential": self["csld_settings"]["export_potential"][ "export_shengbte"], + # Store CSLD results "cross_val_error": float(rel_err), "num_imaginary_modes": int(num_imaginary_bands), "most_imaginary_freq": float(most_imaginary_freq), "imaginary_freq_sum": float(sum(imaginary_freqs)) } + latest_settings = {str(self["convergence_info"]["iteration"]): {self["csld_settings"]["model"]["max_order"], self["csld_settings"]["fitting"][ @@ -2218,7 +2225,8 @@ def run_task(self, fw_spec): shengbte_cmd=">>shengbte_cmd<<", db_file=self["db_file"], wf_uuid=self["wf_uuid"], - t_range=self["shengbte_t_range"] + t_range=self["shengbte_t_range"], + trans_mat=self["trans_mat"] ) ) shengbte_fw.spec["_fworker"] = fw_spec["_fworker"] @@ -2237,15 +2245,12 @@ def run_task(self, fw_spec): new_fws = [] # Create new perturbed supercells - more_perturbed_supercells_transform = PerturbSitesTransformation( - max_disp=0.2, - min_disp=0.12, - num_disps=5, - structures_per_displacement_distance=1, - min_random_distance=None - ) - more_perturbed_supercells = more_perturbed_supercells_transform.apply_transformation(self["supercell_structure"]) - more_disps = more_perturbed_supercells_transform.disps + from atomate.vasp.analysis.csld import generate_perturbed_supercells + more_perturbed_supercells, more_disps = generate_perturbed_supercells(self["supercell_structure"], + min_displacement=0.12, + max_displacement=0.2, + num_displacements=5, + ) # Create new static FWs for idx, more_perturbed_supercell in enumerate(more_perturbed_supercells): @@ -2316,7 +2321,7 @@ class ShengBTEToDB(FiretaskBase): """ required_params = ["parent_structure", "shengbte_cmd", "db_file", - "wf_uuid"] + "wf_uuid", "trans_mat"] optional_params = ["t_range"] #boolean for multiple temperatures def run_task(self, fw_spec): @@ -2354,7 +2359,9 @@ def run_task(self, fw_spec): self["parent_structure"].sites[i]._frac_coords.tolist() for i in range(self["parent_structure"].num_sites) ], - 'scell': [5, 5, 5], + 'scell': [self["trans_mat"][0][0], + self["trans_mat"][1][1], + self["trans_mat"][2][2]], 't': 300, 'scalebroad': 0.5, 'nonanalytic': False, diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index f5aba8d41..d64d64071 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -20,6 +20,7 @@ from atomate.vasp.powerups import ( add_additional_fields_to_taskdocs ) +from atomate.vasp.analysis.csld import generate_perturbed_supercells from pymatgen.io.vasp.sets import MPStaticSet, MPRelaxSet @@ -39,6 +40,7 @@ class CompressedSensingLatticeDynamicsWF: def __init__( self, parent_structure, + symmetrize=False, symprec=0.1, min_atoms=-np.Inf, max_atoms=np.Inf, @@ -67,8 +69,14 @@ def __init__( 5. Output the interatomic force constants to the database. Args: - parent_structure (Structure): Structure to primitize and conduct - CSLD on + parent_structure (Structure): Structure to conduct CSLD on + symmetrize (bool): If True, the parent_structure will be primitized + before running CSLD. Else, the parent_structure will be used + for CSLD as is. + tight_relaxation (bool): If True, run a tight relaxation step on the + parent_structure. Else, do not. TODO: IMPLEMENT + dfpt_check (bool): If True, run a DFPT calculation at the gamma + point to check for dynamic instabilities. TODO: IMPLEMENT symprec (float): symmetry precision parameter for SpacegroupAnalyzer's 'get_primitive_standard_structure()' function @@ -108,8 +116,10 @@ def __init__( } # Create supercell - sga = SpacegroupAnalyzer(parent_structure, symprec=symprec) - self.parent_structure = sga.get_primitive_standard_structure() + self.parent_structure = parent_structure + if symmetrize: + sga = SpacegroupAnalyzer(parent_structure, symprec=symprec) + self.parent_structure = sga.get_primitive_standard_structure() self.min_atoms = min_atoms self.max_atoms = max_atoms @@ -126,18 +136,16 @@ def __init__( self.supercell_smallest_dim = supercell_transform.smallest_dim # Generate list of perturbed supercells - # list of (non-unique) displacement values used in the perturbation (np.ndarray) - self.disps = np.repeat( - np.linspace(min_displacement, max_displacement, num_displacements), - supercells_per_displacement_distance - ) - self.min_random_distance = min_random_distance - self.perturbed_supercells = [] # list of perturbed supercell structures - for amplitude in self.disps: - perturb_structure_transformer = PerturbStructureTransformation(amplitude, - self.min_random_distance) - perturbed_supercell = perturb_structure_transformer.apply_transformation(self.supercell) - self.perturbed_supercells += [perturbed_supercell] + # self.perturbed_supercells: list of perturbed supercells (list of Structures) + # self.disps: list of (non-unique) displacement values used in the perturbation (np.array) + self.perturbed_supercells, self.disps = generate_perturbed_supercells( + self.supercell, + min_displacement=min_displacement, + max_displacement=max_displacement, + num_displacements=num_displacements, + supercells_per_displacement_distance=supercells_per_displacement_distance, + min_random_distance=min_random_distance + ) self.shengbte_t_range = shengbte_t_range @@ -262,7 +270,7 @@ def _add_metadata(structure): print(csld_class.supercell.num_sites) csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_Si") - wf = add_tags(wf, ['csld', 'v1', 'rees', 'pre-relaxed si']) + wf = add_tags(wf, ['csld', 'v1', 'rees', 'pre-relaxed si', 'diagonal supercell']) wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks # wf = add_modify_incar(wf, # modify_incar_params={'incar_update': {'ENCUT': 500, From bc5098d59ec51bcceeb61cf22ca1d7fa2a9cac55 Mon Sep 17 00:00:00 2001 From: reeschang Date: Thu, 1 Aug 2019 15:42:49 -0700 Subject: [PATCH 034/207] -Only pass successful static calculations into the CSLD firework --- atomate/vasp/firetasks/parse_outputs.py | 32 ++++++++++++++----------- atomate/vasp/workflows/base/csld.py | 12 +++++++--- 2 files changed, 27 insertions(+), 17 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index d8ccfed71..fc9dddcca 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -41,7 +41,6 @@ EnergyTrend from pymatgen.analysis.magnetism import CollinearMagneticStructureAnalyzer, Ordering, magnetic_deformation from pymatgen.command_line.bader_caller import bader_analysis_from_path -from pymatgen.transformations.standard_transformations import PerturbStructureTransformation from pymatgen.io.vasp.sets import MPStaticSet >>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) @@ -1885,7 +1884,7 @@ def random_search(self, maxIter): return cluster_diam_settings, max_order_settings, submodel1_settings - def set_params(self, iteration_number, cluster_diam, max_order, submodel1, export_sbte): + def set_params(self, disps, iteration_number, cluster_diam, max_order, submodel1, export_sbte): from configparser import ConfigParser supercell_folder = self["parent_structure"].composition.reduced_formula + \ "_supercell_iter" + str(iteration_number) @@ -1905,7 +1904,7 @@ def set_params(self, iteration_number, cluster_diam, max_order, submodel1, expor # Create folders for perturbed supercell POSCARS and force.txt's disp_folders = [] csld_traindat_disp_folders = '' - for idx, disp in enumerate(self["disps"]): + for idx, disp in enumerate(disps): disp_folder = supercell_folder + '/disp' + str(disp) disp_folders += [disp_folder] # list of folder paths csld_traindat_disp_folders += ' ' + str(disp_folder) # Create string for CSLD input @@ -2090,15 +2089,7 @@ def run_task(self, fw_spec): print(submodel1_settings) while not_converged and iter < maxIter: - self.set_params(iter, - cluster_diam_settings[iter], - max_order_settings[iter], - submodel1_settings[iter], - export_sbte_settings[iter]) - self["csld_options"]["pdfout"] = 'plots' + str(iter) + '.pdf' - uuid = self["wf_uuid"] - formula = self["parent_structure"].formula formula_pretty = self[ "parent_structure"].composition.reduced_formula @@ -2106,15 +2097,18 @@ def run_task(self, fw_spec): supercells_dicts = list( tasks.find({"wf_meta.wf_uuid": uuid, # Date: Mon, 5 Aug 2019 15:46:57 -0700 Subject: [PATCH 035/207] Working workflow --- atomate/vasp/firetasks/parse_outputs.py | 58 ++++++++++++++++--------- atomate/vasp/workflows/base/csld.py | 36 ++++++++++----- requirements-optional.txt | 4 ++ 3 files changed, 67 insertions(+), 31 deletions(-) create mode 100644 requirements-optional.txt diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index fc9dddcca..5b9c30bdf 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1828,9 +1828,10 @@ class CSLDForceConstantsToDB(FiretaskBase): "trans_mat", "supercell_structure", "supercell_smallest_dim", "disps", "first_pass", - "static_user_incar_settings", "env_vars"] + "static_user_incar_settings", "env_vars", + "shengbte_t_range", "shengbte_fworker"] - optional_params = ["shengbte_t_range"] + optional_params = [] def random_search(self, maxIter): """ @@ -1983,9 +1984,10 @@ def set_params(self, disps, iteration_number, cluster_diam, max_order, submodel1 csld_settings['phonon'] = { 'qpoint_fractional': False, # 'Auto' or something like "[[10, [0,0,0],'\\Gamma', [0.5,0.5,0.5], 'X', [0.5,0.5,0], 'K']]" - 'wavevector': "[[25, [0,0,0],'\Gamma', [0,0.5,0.5], 'X']," - " [25, [1,0.5,0.5], 'X', [0.75,0.375,0.375], " - "'K', [0,0,0], '\Gamma', [0.5, 0.5, 0.5], 'L']]", + 'wavevector': 'Auto', + # "[[25, [0,0,0],'\Gamma', [0,0.5,0.5], 'X']," + # " [25, [1,0.5,0.5], 'X', [0.75,0.375,0.375], " + # "'K', [0,0,0], '\Gamma', [0.5, 0.5, 0.5], 'L']]", 'unit': 'meV', # THz, meV, eV, cm # number of grid points @@ -2055,7 +2057,8 @@ def set_params(self, disps, iteration_number, cluster_diam, max_order, submodel1 def run_task(self, fw_spec): db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - tasks = mmdb["tasks"] + # tasks = mmdb["tasks"] + tasks = mmdb.collection iter = 0 not_converged = True @@ -2069,8 +2072,8 @@ def run_task(self, fw_spec): max_order_settings = [3] * len(cluster_diam_settings) submodel1_settings = ['anh 0 1 2 3'] * len(cluster_diam_settings) export_sbte_string = str(self["trans_mat"][0][0]) + ' ' + \ - str(self["trans_mat"])[1][1] + ' ' + \ - str(self["trans_mat"])[2][2] + ' 2 3' + str(self["trans_mat"][1][1]) + ' ' + \ + str(self["trans_mat"][2][2]) + ' 2 3' export_sbte_settings = [export_sbte_string] * len(cluster_diam_settings) if self["first_pass"] is False: max_order_settings += [4] * len(cluster_diam_settings) @@ -2101,8 +2104,7 @@ def run_task(self, fw_spec): "state": 'successful'}, ['task_id', 'task_label', - 'output.forces', - 'displacement_value'])) + 'output.forces'])) # list of dicts where each dict contatins a task_id and a list of forces # for each supercell @@ -2112,11 +2114,15 @@ def run_task(self, fw_spec): for supercell_dict in supercells_dicts: # List of np.ndarrays where each np.ndarray is a matrix of forces # for a perturbed supercell + print('SUPERCELL_DICT') + print(supercell_dict) supercells_forces += [ np.asarray(supercell_dict['output']['forces'])] supercells_task_labels += [supercell_dict['task_label']] - successful_disps += supercell_dict['displacement_value'] + + successful_disp = re.search('disp_val: (\d+.\d+)', supercell_dict['task_label']) + successful_disps += [successful_disp.group(1)] supercells_zip = sorted( zip(supercells_task_labels, supercells_forces), @@ -2170,7 +2176,7 @@ def run_task(self, fw_spec): "formula_pretty": formula_pretty, "parent_structure": self["parent_structure"].as_dict(), "supercell_structure": self["supercell_structure"].as_dict(), - "supercell_transformation_matrix": self["trans_mat"].tolist(), + "supercell_transformation_matrix": self["trans_mat"], "wf_meta": {"wf_uuid": uuid}, # Store relevant CSLD settings @@ -2195,7 +2201,7 @@ def run_task(self, fw_spec): "submodel1"], self["csld_settings"]["export_potential"][ "export_shengbte"]}} - self["convergence_info"]["iteration"] += 1 + self["convergence_info"]["iteration"] = iter self["convergence_info"]["settings_tried"] += [latest_settings] self["convergence_info"]["cross_val_errors"] += [rel_err] self["convergence_info"]["most_imaginary_freqs"] += [ @@ -2208,7 +2214,7 @@ def run_task(self, fw_spec): summaries.append(summary) - iter = self['convergence_info']['iteration'] + iter += 1 mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] mmdb.collection.insert(summaries) @@ -2230,9 +2236,13 @@ def run_task(self, fw_spec): wf_uuid=self["wf_uuid"], t_range=self["shengbte_t_range"], trans_mat=self["trans_mat"] - ) + ), + name="ShengBTE for Lattice Thermal Conductivity" ) - shengbte_fw.spec["_fworker"] = fw_spec["_fworker"] + if isinstance(self["shengbte_fworker"], str): + shengbte_fw.spec["_fworker"] = self["shengbte_fworker"] + else: + shengbte_fw.spec["_fworker"] = fw_spec.get("_fworker", None) CSLD_path = self.get("path", os.getcwd()) shengbte_fw.spec["successful_CSLD_path"] = CSLD_path if fw_spec.get("tags", None): @@ -2293,7 +2303,7 @@ def run_task(self, fw_spec): name="Compressed Sensing Lattice Dynamics", parents=new_fws[-len(more_perturbed_supercells):] ) - new_csld_fw.spec["_fworker"] = fw_spec["_fworker"] + new_csld_fw.spec["_fworker"] = fw_spec.get("_fworker", None) if fw_spec.get("tags", None): new_csld_fw.spec["tags"] = fw_spec["tags"] new_fws.append(new_csld_fw) @@ -2390,8 +2400,15 @@ def run_task(self, fw_spec): shengbte_cmd = shlex.split(shengbte_cmd) shengbte_cmd = list(shengbte_cmd) logger.info("Running command: {}".format(shengbte_cmd)) - return_code = subprocess.call(shengbte_cmd) #call() waits for the process to finish + # return_code = subprocess.call(shengbte_cmd) #call() waits for the process to finish + + with open("shengbte.out", 'w') as f_std, \ + open("shengbte_err.txt", "w", buffering=1) as f_err: + # use line buffering for stderr + return_code = subprocess.call(shengbte_cmd, stdout=f_std, stderr=f_err) logger.info("Command {} finished running with returncode: {}".format(shengbte_cmd, return_code)) + if return_code==1: + raise RuntimeError("Running ShengBTE failed") try: db_file = env_chk(self.get("db_file"), fw_spec) @@ -2399,13 +2416,14 @@ def run_task(self, fw_spec): if self["t_range"]: temps = np.linspace(100, 1000, 10) else: - temps = 300 + temps = [300] # Save to DB summaries = [] for temp in temps: # xx, xy, xz, yx, yy, yz, zx, zy, zz - flattened_kappa = list(np.loadtxt('T'+str(int(temp))+'K/BTE.kappa_tensor')[1][1:]) + flattened_kappa = np.loadtxt('T'+str(int(temp))+'K/BTE.kappa_tensor')[1][1:] + flattened_kappa = flattened_kappa.reshape((3, 3)).tolist() summary = { "date": datetime.now(), "temperature": temp, diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 9cd5a0e37..4160175e6 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -51,7 +51,8 @@ def __init__( num_displacements=10, min_random_distance=None, supercells_per_displacement_distance=1, - shengbte_t_range=False + shengbte_t_range=False, + shengbte_fworker=None ): """ This workflow will use compressed sensing lattice dynamics (CSLD) @@ -108,7 +109,14 @@ def __init__( shengbte_t_range (bool): If False (default), calculate the lattice thermal conductivity with ShengBTE at 300 K. If True, do the calculation from 100-1000 K with 100 K steps (much slower). + shengbte_fworker (None or str): If None, the ShengBTE firework's + fworker will be set to all the previous fireworks' fworker. If + str, the ShengBTE firework's fworker will be set to + shengbte_fworker. """ + # if force_diagonal_transformation is True and num_nn_dists==5: + # num_nn_dists = 6 + self.uuid = str(uuid4()) self.wf_meta = { "wf_uuid": self.uuid, @@ -132,7 +140,7 @@ def __init__( ) # supercell (Structure) self.supercell = supercell_transform.apply_transformation(self.parent_structure) - self.trans_mat = supercell_transform.trans_mat + self.trans_mat = supercell_transform.trans_mat.tolist() self.supercell_smallest_dim = supercell_transform.smallest_dim # Generate list of perturbed supercells @@ -148,6 +156,7 @@ def __init__( ) self.shengbte_t_range = shengbte_t_range + self.shengbte_fworker = shengbte_fworker def get_wf( self, @@ -208,7 +217,8 @@ def _add_metadata(structure): first_pass=True, static_user_incar_settings=static_user_incar_settings, env_vars=c, - shengbte_t_range=self.shengbte_t_range + shengbte_t_range=self.shengbte_t_range, + shengbte_fworker=self.shengbte_fworker ), name="Compressed Sensing Lattice Dynamics", parents=fws[-len(self.perturbed_supercells):] @@ -255,11 +265,13 @@ def _add_metadata(structure): from pymatgen.core.structure import Structure # prim = Structure.from_file('POSCAR_csld_primitivized') - prim = Structure.from_file('POSCAR-well_relaxed_Si') + prim = Structure.from_file('POSCAR-Si555') + # prim = Structure.from_file('POSCAR-Mg3Sb2_save') + # print(prim) csld_class = CompressedSensingLatticeDynamicsWF(prim, symmetrize=False, - num_nn_dists=5, + num_nn_dists=6, num_displacements=10, supercells_per_displacement_distance=1, force_diagonal_transformation=True @@ -270,21 +282,23 @@ def _add_metadata(structure): wf = csld_class.get_wf() print("trans mat") print(csld_class.trans_mat) + print(type(csld_class.trans_mat)) print(csld_class.supercell_smallest_dim) print(csld_class.supercell.num_sites) csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_Si") + # csld_class.supercell.to("poscar", filename="SPOSCAR-Mg3Sb2") wf = add_tags(wf, ['csld', 'v1', 'rees', 'pre-relaxed si', 'diagonal supercell', - 'not symmetrized']) + 'not symmetrized', '555']) wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks - # wf = add_modify_incar(wf, - # modify_incar_params={'incar_update': {'ENCUT': 500, - # 'ISPIN': 1}}) + wf = add_modify_incar(wf, + modify_incar_params={'incar_update': {'ENCUT': 500, + 'ISPIN': 1}}) # print(wf) - lpad = LaunchPad.auto_load() - lpad.add_wf(wf) + # lpad = LaunchPad.auto_load() + # lpad.add_wf(wf) # uuid # 0ff0d430-b43f-4cb5-ac8b-55c465b7867c diff --git a/requirements-optional.txt b/requirements-optional.txt new file mode 100644 index 000000000..a46c4ef70 --- /dev/null +++ b/requirements-optional.txt @@ -0,0 +1,4 @@ +nose==1.3.7 +coverage==4.5.3 +coveralls==1.7.0 +f90nml==1.1.2 \ No newline at end of file From da7435ddafb0d86a42ee6156d478c85c6c80b69b Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 6 Aug 2019 14:31:56 -0700 Subject: [PATCH 036/207] Updated doc strings and comments for CSLD firetasks and moved code outside the grid search loop --- atomate/vasp/firetasks/parse_outputs.py | 195 +++++++++++++++--------- atomate/vasp/workflows/base/csld.py | 58 ++----- 2 files changed, 141 insertions(+), 112 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 5b9c30bdf..973e7000c 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1817,7 +1817,12 @@ class CSLDForceConstantsToDB(FiretaskBase): Optional parameters: shengbte_t_range (boolean): If True, pass to the ShengBTEToDB firetask that lattice thermal conductivity should be calculated for 100 K to - 1000 K in steps of 100 K. If False, only calculate at 300 K. + 1000 K in steps of 100 K. If False (default), only calculate at + 300 K. + shengbte_fworker (str): If None (default), set the ShengBTE fworker to + the previous f_worker. Else, set it to the specified fworker + (allowing the user to run ShengBTE with different Fireworks + configurations than used to run the VASP static calculations). """ logger = get_logger(__name__) @@ -1829,9 +1834,9 @@ class CSLDForceConstantsToDB(FiretaskBase): "supercell_smallest_dim", "disps", "first_pass", "static_user_incar_settings", "env_vars", - "shengbte_t_range", "shengbte_fworker"] + ] - optional_params = [] + optional_params = ["shengbte_t_range", "shengbte_fworker"] def random_search(self, maxIter): """ @@ -1885,7 +1890,40 @@ def random_search(self, maxIter): return cluster_diam_settings, max_order_settings, submodel1_settings - def set_params(self, disps, iteration_number, cluster_diam, max_order, submodel1, export_sbte): + def set_params(self, iteration_number, disps, + cluster_diam, max_order, submodel1, export_sbte): + """ + This function deals with creating all the files, directories, and input + parameters necessary for running CSLD. + + Specifically, it will save the transformation matrix (sc.txt) and parent + structure (POSCAR) in the current directory, create a folder for the current + iteration (e.g. Si_supercell_iter0) with subdirectories (e.g. disp0.010) + for each perturbed supercell. POSCARs of each perturbed supercell is written + inside the corresponding subdirectory. Next, all of CSLD's input parameters + are automatically generated in a format readable by CSLD and then saved to + the class' dictionary. + + Args: + disps (list of floats): list of displacement distances for perturbed + supercells that ran successfully + iteration_number (int): current iteration (0-indexed) of the CSLD + grid or random search + cluster_diam (str): Space-separated string containing the spherical + length cutoffs for pair, triplet, and quadruplet interactions + for CSLD (e.g. '11 6.5 5.0') + max_order (int): Max order of interatomic force constants to + consider (up to 6th order) + submodel1 (str): Anharmonicity orders to consider (e.g. + 'anh 0 1 2 3') + export_sbte (str): Space-separated parameters for exporting CSLD's + interatomic force constants into a format readable by ShengBTE. + The first 3 numbers are the size of the supercell for which + interatomic force constants are exported. The next numbers are + the force constant orders to consider. E.g. To output 2nd and + 3rd order force constants for a 5x5x5 supercell, the + corresponding string must be '5 5 5 2 3'. + """ from configparser import ConfigParser supercell_folder = self["parent_structure"].composition.reduced_formula + \ "_supercell_iter" + str(iteration_number) @@ -1902,7 +1940,7 @@ def set_params(self, disps, iteration_number, cluster_diam, max_order, submodel1 self["supercell_structure"].to("poscar", filename=supercell_folder + "/SPOSCAR") self["parent_structure"].to("poscar", filename=supercell_folder + "/POSCAR") - # Create folders for perturbed supercell POSCARS and force.txt's + # Create folders for perturbed supercell POSCARS and force.txt's (e.g. "Si_supercell_iter0/disp0.010") disp_folders = [] csld_traindat_disp_folders = '' for idx, disp in enumerate(disps): @@ -1915,15 +1953,6 @@ def set_params(self, disps, iteration_number, cluster_diam, max_order, submodel1 self["perturbed_supercells"][idx].to("poscar", filename=disp_folder + "/POSCAR") - # Store information related to convergence of CSLD - self['convergence_info'] = { - 'iteration': 0, - 'settings_tried': [], - 'cross_val_errors': [], - 'most_imaginary_freqs': [], - 'imaginary_freqs_sum': [] - } - # training>traindat1 setting for CSLD input csld_traindat_string = supercell_folder + '/SPOSCAR' csld_traindat_string += csld_traindat_disp_folders @@ -2055,18 +2084,29 @@ def set_params(self, disps, iteration_number, cluster_diam, max_order, submodel1 self["forces_paths"] = disp_folders # Paths to perturbed supercell folders def run_task(self, fw_spec): + # Connect to the database db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) # tasks = mmdb["tasks"] tasks = mmdb.collection + # Store information related to convergence of CSLD iter = 0 not_converged = True maxIter = 2 summaries = [] + self['convergence_info'] = { + 'iteration': iter, + 'settings_tried': [], + 'cross_val_errors': [], + 'most_imaginary_freqs': [], + 'imaginary_freqs_sum': [] + } - #Set list of parameter settings to try (i.e. grid search settings) - # + # Set list of parameter settings to try (i.e. grid search settings) + # TODO: FILL THESE IN FURTHER WITH SETTINGS TO TRY, IN THE ORDER YOU WANT + # TO TRY THEM. (May want to generate this with a grid search, depending + # on what settings seem to work on many materials) cluster_diam_settings = ['11 6.5 5.0', '9 6.5 5.0'] max_order_settings = [3] * len(cluster_diam_settings) @@ -2076,14 +2116,14 @@ def run_task(self, fw_spec): str(self["trans_mat"][2][2]) + ' 2 3' export_sbte_settings = [export_sbte_string] * len(cluster_diam_settings) if self["first_pass"] is False: + # If we are running CSLD a second time (i.e. with larger displaced + # supercells, then duplicate all the settings to try with 4th order + # instead of 3rd order anharmonicity max_order_settings += [4] * len(cluster_diam_settings) cluster_diam_settings += cluster_diam_settings submodel1_settings += submodel1_settings export_sbte_settings += export_sbte_settings - ##Generate list of parameter settings to try from random search - # cluster_diam_settings, max_order_settings, submodel1_settings = self.random_search(maxIter) - # export_sbte_settings = ['5 5 5 2 3'] * maxIter print('cluster_diam') print(cluster_diam_settings) print('max order') @@ -2091,47 +2131,51 @@ def run_task(self, fw_spec): print('submodel') print(submodel1_settings) + uuid = self["wf_uuid"] + formula = self["parent_structure"].formula + formula_pretty = self[ + "parent_structure"].composition.reduced_formula + task_label = 'static' + supercells_dicts = list( + tasks.find({"wf_meta.wf_uuid": uuid, # 5 and self["first_pass"]: logger.info("Compressed Sensing Lattice Dynamics calculation failed." " Max iterations was reached. Creating larger displacements" - " and trying again,") + " and trying again.") new_fws = [] # Create new perturbed supercells @@ -2336,7 +2393,7 @@ class ShengBTEToDB(FiretaskBase): required_params = ["parent_structure", "shengbte_cmd", "db_file", "wf_uuid", "trans_mat"] - optional_params = ["t_range"] #boolean for multiple temperatures + optional_params = ["t_range"] def run_task(self, fw_spec): from atomate.utils.utils import env_chk @@ -2345,7 +2402,7 @@ def run_task(self, fw_spec): import six import shlex - # Generate CONTROL file + # Generate CONTROL file (a FORTRAN input file for ShengBTE) from pymatgen.io.shengbte import Control qpts = Kpoints.automatic_density(self["parent_structure"], 50000) unique_elements = [ @@ -2393,24 +2450,24 @@ def run_task(self, fw_spec): shutil.copy(force_constants_path+"/FORCE_CONSTANTS_2ND", os.getcwd()) shutil.copy(force_constants_path+"/FORCE_CONSTANTS_3RD", os.getcwd()) - # Set up/run ShengBTE + # Run ShengBTE shengbte_cmd = env_chk(self["shengbte_cmd"], fw_spec) if isinstance(shengbte_cmd, six.string_types): shengbte_cmd = os.path.expandvars(shengbte_cmd) shengbte_cmd = shlex.split(shengbte_cmd) shengbte_cmd = list(shengbte_cmd) logger.info("Running command: {}".format(shengbte_cmd)) - # return_code = subprocess.call(shengbte_cmd) #call() waits for the process to finish - with open("shengbte.out", 'w') as f_std, \ open("shengbte_err.txt", "w", buffering=1) as f_err: # use line buffering for stderr return_code = subprocess.call(shengbte_cmd, stdout=f_std, stderr=f_err) logger.info("Command {} finished running with returncode: {}".format(shengbte_cmd, return_code)) if return_code==1: - raise RuntimeError("Running ShengBTE failed") + raise RuntimeError("Running ShengBTE failed. Check 'shengbte_err.txt'" + " in the launch_dir for details.") try: + # Store lattice thermal conductivity matrix in the database db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) if self["t_range"]: diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 4160175e6..40d73dc96 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -114,8 +114,8 @@ def __init__( str, the ShengBTE firework's fworker will be set to shengbte_fworker. """ - # if force_diagonal_transformation is True and num_nn_dists==5: - # num_nn_dists = 6 + if force_diagonal_transformation is True and num_nn_dists==5: + num_nn_dists = 6 self.uuid = str(uuid4()) self.wf_meta = { @@ -138,8 +138,10 @@ def __init__( self.num_nn_dists, force_diagonal_transformation=force_diagonal_transformation ) + # supercell (Structure) self.supercell = supercell_transform.apply_transformation(self.parent_structure) + self.nn_dist = supercell_transform.nn_dist self.trans_mat = supercell_transform.trans_mat.tolist() self.supercell_smallest_dim = supercell_transform.smallest_dim @@ -243,31 +245,11 @@ def _add_metadata(structure): if __name__ == "__main__": from fireworks import LaunchPad - from pymatgen.ext.matproj import MPRester from atomate.vasp.powerups import add_tags, set_execution_options, add_modify_incar - - #get a structure - # mpr = MPRester(api_key='auNIrJ23VLXCqbpl') - # # structure = mpr.get_structure_by_material_id('mp-149') #Si - # structure = mpr.get_structure_by_material_id('mp-1101039') - # test_trans_mat = np.linalg.inv(structure.lattice.matrix) @ (np.eye(3,3) * 20) - # print(test_trans_mat) - # print(np.linalg.det(test_trans_mat)) - # structure_test = structure * test_trans_mat - # structure_test.to("poscar", filename="POSCAR-noninteger_trans_test") - - # # CONVENTIONAL PRIMITIVE CELL WITH SYMMETRIZATION from pymatgen.symmetry.analyzer import SpacegroupAnalyzer - # sga = SpacegroupAnalyzer(structure, symprec=0.1) - # prim = sga.get_primitive_standard_structure() - - # CSLD'S POLARON MAIN-GENERATED PRIMITIVE CELL from pymatgen.core.structure import Structure - # prim = Structure.from_file('POSCAR_csld_primitivized') - prim = Structure.from_file('POSCAR-Si555') - # prim = Structure.from_file('POSCAR-Mg3Sb2_save') - # print(prim) + prim = Structure.from_file('POSCAR-well_relaxed_InSb_csld_primitivized') csld_class = CompressedSensingLatticeDynamicsWF(prim, symmetrize=False, @@ -282,35 +264,25 @@ def _add_metadata(structure): wf = csld_class.get_wf() print("trans mat") print(csld_class.trans_mat) - print(type(csld_class.trans_mat)) + print("nn dist") + print(csld_class.nn_dist) + print("supercell shortest direction (Angstroms)") print(csld_class.supercell_smallest_dim) + print("supercell number of atoms") print(csld_class.supercell.num_sites) - csld_class.supercell.to("poscar", filename="SPOSCAR-csld_super_Si") - # csld_class.supercell.to("poscar", filename="SPOSCAR-Mg3Sb2") + csld_class.supercell.to("poscar", filename="SPOSCAR-InSb_diagonal") wf = add_tags(wf, ['csld', 'v1', 'rees', - 'pre-relaxed si', 'diagonal supercell', - 'not symmetrized', '555']) + 'pre-relaxed insb', 'diagonal supercell', + 'not symmetrized']) wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks - wf = add_modify_incar(wf, - modify_incar_params={'incar_update': {'ENCUT': 500, - 'ISPIN': 1}}) - # print(wf) + # wf = add_modify_incar(wf, + # modify_incar_params={'incar_update': {'ENCUT': 500, + # 'ISPIN': 1}}) # lpad = LaunchPad.auto_load() # lpad.add_wf(wf) -# uuid -# 0ff0d430-b43f-4cb5-ac8b-55c465b7867c -# DISPS -# [0.01 0.02 0.03 0.04 0.05 0.06 0.07 0.08 0.09 0.1 ] -# trans mat -# [[-3. 3. 3.] -# [ 3. -3. 3.] -# [ 3. 3. -3.]] -# 23.745154105620003 -# 432 - #################custom csld_main below################## def csld_main(options, settings): """ From 623f0e7909680d6b0437c7adb807f9343892b347 Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 6 Aug 2019 14:49:41 -0700 Subject: [PATCH 037/207] Updated trans_mat doc string --- atomate/vasp/firetasks/parse_outputs.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 973e7000c..89c96315c 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1797,7 +1797,7 @@ class CSLDForceConstantsToDB(FiretaskBase): which CSLD is being done perturbed_supercells (list of Structures): list of perturbed supercell structures auto-generated from CompressedSensingLatticeDynamicsWF - trans_mat (3x3 np.ndarray): supercell transformation matrix auto- + trans_mat (3x3 nested list): supercell transformation matrix auto- generated from CompressedSensingLatticeDynamicsWF supercell_structure (Structure): supercell structure of parent_structure, auto-generated from CompressedSensingLatticeDynamicsWF From 6731adab0de2ef81f8cf268671859421d7345660 Mon Sep 17 00:00:00 2001 From: reeschang Date: Tue, 6 Aug 2019 14:53:51 -0700 Subject: [PATCH 038/207] docstring --- atomate/vasp/firetasks/parse_outputs.py | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 89c96315c..f4eaff023 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1779,13 +1779,13 @@ def split_abc(var, var_name): @explicit_serialize class CSLDForceConstantsToDB(FiretaskBase): - #TODO: Update this class once a public version of CSLD is released - #TODO: Update this class once Junsoo has fixed the cluster generation + #TODO: Update this class once Fei's CSLD is modified correctly """ Used to aggregate atomic forces of perturbed supercells in compressed sensing lattice dynamics (CSLD) workflow and generate/write interatomic force constants up to 3rd order to file. The workflow uses a CSLD software - implemented by Zhou et al which can be found at https://github.com/LLNL/csld. + implemented by Zhou et al (https://github.com/LLNL/csld) and modified for + use in atomate (Aug 6, 2019: https://github.com/rees-c/csld). Required parameters: db_file (str): path to the db file that holds your tasks From 3b6860fe40c1de5bfc9c546e728cf7ad321ba116 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 7 Aug 2019 10:55:54 -0700 Subject: [PATCH 039/207] Cleaned up code (made functions for CSLD firetask, adhered to PEP guidelines, etc.) --- atomate/vasp/firetasks/parse_outputs.py | 855 ++++++++++++------------ atomate/vasp/workflows/base/csld.py | 335 ++++------ 2 files changed, 584 insertions(+), 606 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index f4eaff023..25cbb8137 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -3,9 +3,20 @@ import shutil import re from collections import defaultdict +from copy import deepcopy from datetime import datetime import numpy as np +<<<<<<< HEAD +======= + +from monty.json import MontyEncoder, jsanitize +from pydash.objects import has, get + +from atomate.vasp.analysis.csld import default_csld_options, \ + default_csld_settings +from atomate.vasp.config import DEFUSE_UNSUCCESSFUL +>>>>>>> 816883c7 (Cleaned up code (made functions for CSLD firetask, adhered to PEP guidelines, etc.)) from fireworks import FiretaskBase, FWAction, explicit_serialize from fireworks.utilities.fw_serializers import DATETIME_HANDLER <<<<<<< HEAD @@ -1779,7 +1790,6 @@ def split_abc(var, var_name): @explicit_serialize class CSLDForceConstantsToDB(FiretaskBase): - #TODO: Update this class once Fei's CSLD is modified correctly """ Used to aggregate atomic forces of perturbed supercells in compressed sensing lattice dynamics (CSLD) workflow and generate/write interatomic @@ -1787,6 +1797,10 @@ class CSLDForceConstantsToDB(FiretaskBase): implemented by Zhou et al (https://github.com/LLNL/csld) and modified for use in atomate (Aug 6, 2019: https://github.com/rees-c/csld). + TODO: Update this class once Fei's CSLD is modified correctly + TODO: Add to the summary inside 'run_CSLD()' as needed + TODO: Rename this class to something more accurate + Required parameters: db_file (str): path to the db file that holds your tasks collection specifying the database that the perturbed supercell @@ -1799,7 +1813,7 @@ class CSLDForceConstantsToDB(FiretaskBase): structures auto-generated from CompressedSensingLatticeDynamicsWF trans_mat (3x3 nested list): supercell transformation matrix auto- generated from CompressedSensingLatticeDynamicsWF - supercell_structure (Structure): supercell structure of parent_structure, + supercell_structure (Structure): supercell structure of parent_structure auto-generated from CompressedSensingLatticeDynamicsWF supercell_smallest_dim (float): length of shortest direction of the supercell lattice, auto-generated from @@ -1807,15 +1821,24 @@ class CSLDForceConstantsToDB(FiretaskBase): disps (list of floats): displacement values corresponding to perturbed_supercells, auto-generated from CompressedSensingLatticeDynamicsWF + force_diagonal_transformation (bool): Whether the transformation matrix + used to generate the supercell was diagonal (True) or not (False) first_pass (boolean): indicator of whether this firetask has already been attempted or if it is automatically running a second time with larger perturbations - static_user_incar_settings (dict): incar settings used in static calculations - in CompressedSensingLatticeDynamicsWF + static_user_incar_settings (dict): incar settings used in static + calculations in CompressedSensingLatticeDynamicsWF env_vars (dict): environmental variables used in static calculations in CompressedSensingLatticeDynamicsWF + Optional parameters: - shengbte_t_range (boolean): If True, pass to the ShengBTEToDB firetask + dynamic_static_calcs (bool): If True, dynamically create more static + perturbed supercell calculations with larger displacements if CSLD + fails. Default: False. + do_shengbte (bool): If True, dynamically create a ShengBTE firework + for computing lattice thermal conductivity if CSLD yields a good + solution. Default: False. + shengbte_t_range (bool): If True, pass to the ShengBTEToDB firetask that lattice thermal conductivity should be calculated for 100 K to 1000 K in steps of 100 K. If False (default), only calculate at 300 K. @@ -1827,55 +1850,40 @@ class CSLDForceConstantsToDB(FiretaskBase): logger = get_logger(__name__) - required_params = ["db_file", - "wf_uuid", "parent_structure", - "perturbed_supercells", - "trans_mat", "supercell_structure", - "supercell_smallest_dim", - "disps", "first_pass", - "static_user_incar_settings", "env_vars", + required_params = [ + "db_file", "wf_uuid", "parent_structure", + "perturbed_supercells", "trans_mat", "supercell_structure", + "supercell_smallest_dim", "disps", "force_diagonal_transformation", + "first_pass", "static_user_incar_settings", "env_vars" ] - optional_params = ["shengbte_t_range", "shengbte_fworker"] + optional_params = [ + "dynamic_static_calcs", "do_shengbte", "shengbte_t_range", + "shengbte_fworker" + ] - def random_search(self, maxIter): + @staticmethod + def random_search(max_iter): """ - -pair potential is roughly 12 Angstroms, so supercell should be safely - larger than that (at least 20 in each direction) so you don't get artifacts - from periodic boundary conditions (i.e. atoms being double-counted in the - pair potential) - -"most likely" at least 4 nearest neighbor distances is ok - - - -150+ atom-supercell - -for low symmetry, more atoms = finer displacement linspace (0.02 - 0.05 in - steps of 0.01 or 0.005) - -9-12 lattice parameters for pair cutoffs, triplets usually a little more than half of pairs - - -1 meV phonon mode is - -change cutoff diameter (easiest, probably increase) - -either increase supercells or relax primitive cell better (check total drift) - - CSLD CHECKS: IF FITTING IS BAD... - Option 1. - Play with cluster diameters - -random search? bayesopt? - -if tried some max number trials and still bad, pick the best one and move to Option 2 - - Option 2. - Include higher displacement supercells - 1. If Natom>5, generate supercells at large displacements (>0.1 angstroms) - 2. Fit up to 3rd order only with supercells perturbed <0.1 angstroms - -If good, run SBTE - -If bad, then fit including supercells >0.1 angstroms - -If good, run SBTE - -If bad, redo step 2 with 4th order + Generates a tuple of cluster diameter, max order, and submodel1 input + settings for CSLD using a random search. The length of each returned + list of settings is the number of total settings to try. + + Args: + max_iter (int): Number of settings to try + + Returns: + cluster_diam_settings (list[str]): List of cluster diameter settings + max_order_settings (list[int]): List of max order settings + submodel1_settings (list[str]): List of submodel1 settings """ import random - if maxIter % 2 != 0 or maxIter <= 0: + if max_iter % 2 != 0 or max_iter <= 0: raise AttributeError('maxIter must be even.') cluster_diam_settings = [] - for _ in range(maxIter): + for _ in range(max_iter): pair_diam = random.uniform(8, 12) #self["supercell_smallest_dim"]) triplet_diam = random.uniform(5.5, 7) quadruplet_diam = random.uniform(triplet_diam * 0.6, triplet_diam) @@ -1884,25 +1892,86 @@ def random_search(self, maxIter): str(pair_diam) + ' ' + str(triplet_diam) + ' ' + str( quadruplet_diam)] - max_order_settings = [3] * int(maxIter / 2) + [4] * int(maxIter / 2) - submodel1_settings = ['anh 0 1 2 3'] * int(maxIter / 2) + \ - ['anh 0 1 2 3 4'] * int(maxIter / 2) + max_order_settings = [3] * int(max_iter / 2) + [4] * int(max_iter / 2) + submodel1_settings = ['anh 0 1 2 3'] * int(max_iter / 2) + \ + ['anh 0 1 2 3 4'] * int(max_iter / 2) return cluster_diam_settings, max_order_settings, submodel1_settings - def set_params(self, iteration_number, disps, - cluster_diam, max_order, submodel1, export_sbte): + def collect_successful_static_calcs_results(self, tasks): + """ + Search a database's tasks collection for successful static calculations + and return a list of forces for each supercell + + Args: + tasks (MongoDB collection): MongoDB collection containing static + perturbed supercells calculations + + Returns: + supercells_forces (list[np.array]): List of forces for each + successful static perturbed supercell calculation + successful_disps (list[float]): List of displacement distances for + each successful static perturbed supercell calculation + """ + uuid = self["wf_uuid"] + formula_pretty = self[ + "parent_structure"].composition.reduced_formula + task_label = 'static' + supercells_dicts = list( + tasks.find({"wf_meta.wf_uuid": uuid, # = 2)) and cls.is_small_in('" + supercell_folder + "/sc.txt')" + }) + + # directories of unperturbed followed by perturbed supercell poscars + # e.g., 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' + csld_settings_dict["training"]['traindat1'] = csld_traindat_string + csld_settings_dict['fitting']['submodel1'] = submodel1 + + # e.g., '5 5 5 2 3' is a 5x5x5 supercell + csld_settings_dict['export_potential']['export_shengbte'] = export_sbte + csld_settings = ConfigParser() - csld_settings['structure'] = { - 'prim': supercell_folder + '/POSCAR', # original structure poscar - 'sym_tol': '1e-3', - # 'epsilon_inf': None, # check how it reads 3x3 matrix - # 'born_charge': None # check reading n_atom*9 numbers - } - csld_settings['model'] = { - 'model_type': 'LD', - 'cluster_in': 'clusters.out', - 'cluster_out': 'clusters.out', - 'symC_in': 'Cmat.mtx', - 'symC_out': 'Cmat.mtx', - 'max_order': max_order, # 3, # this should be variable - 'fractional_distance': False, - 'cluster_diameter': cluster_diam, # '11 6.5 5.0', #this should be variable - 'cluster_filter': r"lambda cls: ((cls.order_uniq <= 2) or " - r"(cls.bond_counts(2.9) >= 2)) and " - r"cls.is_small_in('" + supercell_folder + "/sc.txt')" - # rewrote how it reads the trans_mat - } - csld_settings['training'] = { - 'interface': 'VASP', - 'corr_type': 'f', - 'corr_in': 'Amat.mtx', - 'corr_out': 'Amat.mtx', - 'fval_in': 'fval.txt', - 'fval_out': 'fval.txt', - 'traindat1': csld_traindat_string # directories of unperturbed followed - # by perturbed supercell poscars - # 'fcc333/SPOSCAR fcc333/dir*0.01 fcc333/dir*0.02 fcc333/dir*0.05' - # Rewrote how it reads forces - } - csld_settings['fitting'] = { - 'solution_in': 'solution_all', - 'solution_out': 'solution_all', - 'nsubset': 5, - 'holdsize': 0.1, - ## 1 FPC 2 FPC sparse 3 split 4 sparse split - ## 5 split+ right preconditioning 6 sparse split + r preconditioning - ## 101 Bayesian CS - 'method': 5, - - # For weight of L1 or L2 regularization - 'mulist': '1E-5 1E-6 1E-7 1E-9', - 'maxIter': 300, - 'tolerance': 1E-6, - 'subsetsize': 0.85, - 'lambda': 0.5, - 'uscale_list': '0.03', - 'submodel1': submodel1, # 'anh 0 1 2 3', # this should be variable - } - csld_settings['phonon'] = { - 'qpoint_fractional': False, - # 'Auto' or something like "[[10, [0,0,0],'\\Gamma', [0.5,0.5,0.5], 'X', [0.5,0.5,0], 'K']]" - 'wavevector': 'Auto', - # "[[25, [0,0,0],'\Gamma', [0,0.5,0.5], 'X']," - # " [25, [1,0.5,0.5], 'X', [0.75,0.375,0.375], " - # "'K', [0,0,0], '\Gamma', [0.5, 0.5, 0.5], 'L']]", - 'unit': 'meV', # THz, meV, eV, cm - - # number of grid points - 'dos_grid': '15 15 15', - - # number of points in DOS - 'nE_dos': 500, - - ## 0 (Gaussian), 1 (Lorentzian), -1 (tetrahedron method) - 'ismear': -1, - - ## width in THz of Gaussian/Lorentzian smearing - 'epsilon': 0.05, - 'pdos': True, - - 'thermal_T_range': '50 800 50', - 'thermal_out': 'thermal_out.txt' - } - csld_settings['export_potential'] = { - 'export_shengbte': export_sbte, # '5 5 5 2 3' # 5x5x5 supercell - # 2 and 3 orders to be considered - # should be variable? - } - csld_settings['prediction'] = { - 'interface': 'VASP', - 'corr_type': 'f', - 'corr_in': 'Amat_pred.mtx', - 'corr_out': 'Amat_pred.mtx', - 'fval_in': 'fval_pred.txt', - 'fval_out': 'fval_pred.txt', - 'traindat0': 'fcc222/POSCAR fcc222/traj*' - } - # set default values - csld_settings['DEFAULT'] = { - "qpoint_fractional": False, - "true_v_fit": 'true_fit.txt', - 'epsilon': '0.05', - "bcs_reweight": 'True', - "bcs_penalty": 'arctan', - "bcs_jcutoff": '1E-8'} - - csld_options = {} - csld_options['pdfout'] = 'plots.pdf' # Name of pdf to output results - csld_options['ldff_step'] = 0 - csld_options['phonon_step'] = 1 - csld_options['phonon'] = False - csld_options['save_pot_step'] = 1 # usual default is 0. 1 means output to ShengBTE format. - csld_options['pot'] = False - - # set default values - csld_options['log_level'] = 1 - csld_options['symm_step'] = 2 - csld_options['symm_prim'] = True - csld_options['clus_step'] = 3 - csld_options['symC_step'] = 3 - csld_options['train_step'] = 3 - csld_options['fit_step'] = 3 - csld_options['pred_step'] = 0 - csld_options['refit'] = False - csld_options['cont'] = False - csld_options['predict'] = False + csld_settings.read_dict(csld_settings_dict) + csld_options = deepcopy(default_csld_options) self["csld_settings"] = csld_settings self["csld_options"] = csld_options self["forces_paths"] = disp_folders # Paths to perturbed supercell folders + # Create force.txt files for perturbed supercells + for supercell_idx, supercell_force in enumerate(supercells_forces): + path = self["forces_paths"][supercell_idx] + np.savetxt(path + "/force.txt", supercell_force, fmt='%.6f') + + def run_csld(self, iter): + """ + Run CSLD, check for imaginary frequencies, and generate a summary of the + results. + + Args: + iter (int): Current iteration of the grid/random search over CSLD + input parameters (0-indexed) + Return: + summary (dict): Summary of the results from CSLD + """ + # Perform csld minimization now + from atomate.vasp.analysis.csld import csld_main + rel_err, freq_matrix = csld_main(self["csld_options"], + self["csld_settings"]) + + freq_matrix = np.asarray(freq_matrix) + + # CHECK FOR IMAGINARY PHONON MODES + # For imaginary frequencies, w^2 is negative. + # CSLD handles these as w = sign(sqrt(abs(w^2)), w^2). + # i.e. if w < 0, it is imaginary. + # Here, we consider phonon frequencies < -1 meV to be imaginary + # (numerical noise can sometimes make frequencies slightly negative, + # so we ignore these) + imaginary_idx = freq_matrix < -1 + imaginary_freqs = freq_matrix[imaginary_idx] + print('IMAGINARY FREQUENCIES') + print(imaginary_freqs) + num_imaginary_bands = np.sum(np.any(imaginary_idx, axis=1)) + print(num_imaginary_bands) + if np.any(imaginary_freqs): + most_imaginary_freq = np.amin(imaginary_freqs) + else: + most_imaginary_freq = 0 + print(most_imaginary_freq) + + if num_imaginary_bands == 0: + not_converged = False + + # Save to DB + summary = { + "date": datetime.now(), + "formula": self["parent_structure"].formula, + "formula_pretty": self[ + "parent_structure"].composition.reduced_formula, + "parent_structure": self["parent_structure"].as_dict(), + "supercell_structure": self["supercell_structure"].as_dict(), + "supercell_transformation_matrix": self["trans_mat"], + "wf_meta": {"wf_uuid": self["wf_uuid"]}, + + # Store relevant CSLD settings + "iteration": iter, + "cluster_diam": self["csld_settings"]["model"][ + "cluster_diameter"], + "max_order": self["csld_settings"]["model"]["max_order"], + "submodel1": self["csld_settings"]["fitting"]["submodel1"], + "export_potential": self["csld_settings"]["export_potential"][ + "export_shengbte"], + + # Store CSLD results + "cross_val_error": float(rel_err), + "num_imaginary_modes": int(num_imaginary_bands), + "most_imaginary_freq": float(most_imaginary_freq), + "imaginary_freq_sum": float(sum(imaginary_freqs)) + } + + # Store latest CSLD input settings tried + # TODO: If desired, store this information in a database to keep + # track of what settings work and what doesn't for different materials + latest_settings = {str(self["convergence_info"]["iteration"]): + {self["csld_settings"]["model"]["max_order"], + self["csld_settings"]["fitting"][ + "submodel1"], + self["csld_settings"]["export_potential"][ + "export_shengbte"]}} + self["convergence_info"]["iteration"] = iter + self["convergence_info"]["settings_tried"] += [latest_settings] + self["convergence_info"]["cross_val_errors"] += [rel_err] + self["convergence_info"]["most_imaginary_freqs"] += [ + most_imaginary_freq] + self["convergence_info"]["imaginary_freqs_sum"] += [ + sum(imaginary_freqs)] + + return summary + + def add_sbte_fw(self, fw_spec): + """ + This function dynamically creates a ShengBTE firework for calculating + the lattice thermal conductivity matrix. + + Args: + fw_spec (dict): The fw_spec for the CSLD firework. + + Returns: + FWAction: Dynamically adds a ShengBTE Firework to the workflow + """ + shengbte_fw = Firework( + ShengBTEToDB( + parent_structure=self["parent_structure"], + shengbte_cmd=">>shengbte_cmd<<", + db_file=self["db_file"], + wf_uuid=self["wf_uuid"], + t_range=self.get("shengbte_t_range", False), + trans_mat=self["trans_mat"] + ), + name="ShengBTE for Lattice Thermal Conductivity" + ) + + # Set the ShengBTE fworker + if isinstance(self["shengbte_fworker"], str): + shengbte_fw.spec["_fworker"] = self["shengbte_fworker"] + else: + shengbte_fw.spec["_fworker"] = fw_spec.get("_fworker", None) + + # Pass the CSLD launcher path to the ShengBTE FW + CSLD_path = self.get("path", os.getcwd()) + shengbte_fw.spec["successful_CSLD_path"] = CSLD_path + + # Add tags + if fw_spec.get("tags", None): + shengbte_fw.spec["tags"] = fw_spec["tags"] + + return FWAction(additions=shengbte_fw) + + def add_more_static_calcs(self, successful_disps, fw_spec): + """ + This function will dynamically create more static perturbed supercell + calculations with displacement distances of 0.12, 0.14, 0.16, 0.18, and + 0.20, and also append another CSLD Firework. A 'first_pass=False' + argument will be passed into the CSLD Firework to ensure that more + static perturbed supercell calculations will not be created. + + Args: + successful_disps (list[float]): List of displacement distances of + previous successful static perturbed supercell calculations + fw_spec (dict): Firework spec of the first CSLD Firework + + Returns: + FWAction: Dynamically adds a more static calculations and a CSLD + Firework to the workflow + """ + + new_fws = [] + + # Create new perturbed supercells + from atomate.vasp.analysis.csld import generate_perturbed_supercells + more_perturbed_supercells, more_disps = generate_perturbed_supercells( + self["supercell_structure"], + min_displacement=0.12, + max_displacement=0.2, + num_displacements=5 + ) + + # Create new static FWs + for idx, more_perturbed_supercell in enumerate( + more_perturbed_supercells): + name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format( + idx + len(self["perturbed_supercells"]), + more_disps) + static_vis = MPStaticSet(more_perturbed_supercell, + user_incar_settings=self[ + "static_user_incar_settings"]) + + from atomate.vasp.fireworks.core import StaticFW + new_static_fw = StaticFW( + more_perturbed_supercell, + vasp_input_set=static_vis, + vasp_cmd=self["env_vars"]["VASP_CMD"], + db_file=self["env_vars"]["DB_FILE"], + name=name + " static" + ) + new_static_fw.spec["_fworker"] = fw_spec["_fworker"] + new_static_fw.spec["displacement_value"] = more_disps[idx] + if fw_spec.get("tags", None): + new_static_fw.spec["tags"] = fw_spec["tags"] + new_fws.append(new_static_fw) + + # Create new CSLD FW + # static_user_incar_settings and env_vars can be None since we + # are done trying more static calculations. + new_csld_fw = Firework( + CSLDForceConstantsToDB( + db_file=self["env_vars"]["DB_FILE"], + wf_uuid=self["wf_uuid"], + name='CSLDForceConstantsToDB', + parent_structure=self["parent_structure"], + trans_mat=self["trans_mat"], + supercell_structure=self["supercell_structure"], + supercell_smallest_dim=self["supercell_smallest_dim"], + perturbed_supercells=self[ + "perturbed_supercells"] + more_perturbed_supercells, + disps=successful_disps + more_disps, + force_diagonal_transformation=self.force_diagonal_transformation, + first_pass=False, + do_shengbte=self.get("do_shengbte", False), + shengbte_t_range=self.get("shengbte_t_range", False), + shengbte_fworker=self.get("shengbte_fworker", None), + static_user_incar_settings=None, + env_vars=None + ), + name="Compressed Sensing Lattice Dynamics", + parents=new_fws[-len(more_perturbed_supercells):] + ) + new_csld_fw.spec["_fworker"] = fw_spec.get("_fworker", None) + if fw_spec.get("tags", None): + new_csld_fw.spec["tags"] = fw_spec["tags"] + new_fws.append(new_csld_fw) + + # Dynamically add new fireworks to the workflow + return FWAction(additions=new_fws) + def run_task(self, fw_spec): # Connect to the database db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - # tasks = mmdb["tasks"] tasks = mmdb.collection # Store information related to convergence of CSLD - iter = 0 + iteration = 0 not_converged = True - maxIter = 2 + max_iter = 2 summaries = [] self['convergence_info'] = { - 'iteration': iter, + 'iteration': iteration, 'settings_tried': [], 'cross_val_errors': [], 'most_imaginary_freqs': [], @@ -2111,9 +2310,12 @@ def run_task(self, fw_spec): '9 6.5 5.0'] max_order_settings = [3] * len(cluster_diam_settings) submodel1_settings = ['anh 0 1 2 3'] * len(cluster_diam_settings) - export_sbte_string = str(self["trans_mat"][0][0]) + ' ' + \ - str(self["trans_mat"][1][1]) + ' ' + \ - str(self["trans_mat"][2][2]) + ' 2 3' + if self["force_diagonal_transformation"]: + export_sbte_string = str(self["trans_mat"][0][0]) + ' ' + \ + str(self["trans_mat"][1][1]) + ' ' + \ + str(self["trans_mat"][2][2]) + ' 2 3' + else: + export_sbte_string = '5 5 5 2 3' export_sbte_settings = [export_sbte_string] * len(cluster_diam_settings) if self["first_pass"] is False: # If we are running CSLD a second time (i.e. with larger displaced @@ -2124,150 +2326,41 @@ def run_task(self, fw_spec): submodel1_settings += submodel1_settings export_sbte_settings += export_sbte_settings - print('cluster_diam') - print(cluster_diam_settings) - print('max order') - print(max_order_settings) - print('submodel') - print(submodel1_settings) + logger.info('Cluster diameter settings to search over: ' + '{}'.format(cluster_diam_settings)) + logger.info('Max order settings to search over: ' + '{}'.format(max_order_settings)) + logger.info('"submodel1" settings to search over: ' + '{}'.format(submodel1_settings)) - uuid = self["wf_uuid"] - formula = self["parent_structure"].formula - formula_pretty = self[ - "parent_structure"].composition.reduced_formula - task_label = 'static' - supercells_dicts = list( - tasks.find({"wf_meta.wf_uuid": uuid, # 5 and self["first_pass"]: - logger.info("Compressed Sensing Lattice Dynamics calculation failed." - " Max iterations was reached. Creating larger displacements" - " and trying again.") - new_fws = [] - - # Create new perturbed supercells - from atomate.vasp.analysis.csld import generate_perturbed_supercells - more_perturbed_supercells, more_disps = generate_perturbed_supercells(self["supercell_structure"], - min_displacement=0.12, - max_displacement=0.2, - num_displacements=5, - ) - - # Create new static FWs - for idx, more_perturbed_supercell in enumerate(more_perturbed_supercells): - name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format(idx+len(self["perturbed_supercells"]), - more_disps) - static_vis = MPStaticSet(more_perturbed_supercell, - user_incar_settings=self["static_user_incar_settings"]) - - from atomate.vasp.fireworks.core import StaticFW - new_static_fw = StaticFW( - more_perturbed_supercell, - vasp_input_set=static_vis, - vasp_cmd=self["env_vars"]["VASP_CMD"], - db_file=self["env_vars"]["DB_FILE"], - name=name + " static" - ) - new_static_fw.spec["_fworker"] = fw_spec["_fworker"] - new_static_fw.spec["displacement_value"] = more_disps[idx] - if fw_spec.get("tags", None): - new_static_fw.spec["tags"] = fw_spec["tags"] - new_fws.append(new_static_fw) - - # Create new CSLD FW - new_csld_fw = Firework( - CSLDForceConstantsToDB( - db_file=self["env_vars"]["DB_FILE"], - wf_uuid=self["wf_uuid"], - name='CSLDForceConstantsToDB', - parent_structure=self["parent_structure"], - trans_mat=self["trans_mat"], - supercell_structure=self["supercell_structure"], - supercell_smallest_dim=self["supercell_smallest_dim"], - perturbed_supercells=self["perturbed_supercells"]+more_perturbed_supercells, - disps=successful_disps+more_disps, - first_pass=False - ), - name="Compressed Sensing Lattice Dynamics", - parents=new_fws[-len(more_perturbed_supercells):] - ) - new_csld_fw.spec["_fworker"] = fw_spec.get("_fworker", None) - if fw_spec.get("tags", None): - new_csld_fw.spec["tags"] = fw_spec["tags"] - new_fws.append(new_csld_fw) + logger.info("Compressed Sensing Lattice Dynamics calculation " + "failed. Max iterations was reached.") + if self["parent_structure"].num_sites > 5 and self["first_pass"] \ + and self.get("dynamic_static_calcs", False): + logger.info("Compressed Sensing Lattice Dynamics calculation " + "failed. Max iterations was reached. Creating " + "larger displacements and trying again.") - # Dynamically add new fireworks to the workflow - return FWAction(additions=new_fws) + self.add_more_static_calcs(successful_disps, fw_spec) else: - raise TimeoutError("The workflow was unable to find a solution to CSLD" - " for this material.") + raise TimeoutError("The workflow was unable to find a solution " + "to CSLD for this material.") @explicit_serialize class ShengBTEToDB(FiretaskBase): - #TODO: Test this firetask + #TODO: Rename this class to something more accurate (since this class only + # calculates the lattice thermal conductivity matrix even though ShengBTE + # has more capabilities) """ Run ShengBTE and output the lattice thermal conductivity matrix to database. @@ -2392,7 +2420,7 @@ class ShengBTEToDB(FiretaskBase): """ required_params = ["parent_structure", "shengbte_cmd", "db_file", - "wf_uuid", "trans_mat"] + "wf_uuid", "trans_mat", "force_diagonal_transformation"] optional_params = ["t_range"] def run_task(self, fw_spec): @@ -2418,7 +2446,7 @@ def run_task(self, fw_spec): shengbte_control_dict = { 'nelements': self["parent_structure"].ntypesp, 'natoms': self["parent_structure"].num_sites, - 'ngrid': qpts.kpts[0], #[25, 25, 25], # NEED TO GENERATE THIS BY DENSITY + 'ngrid': qpts.kpts[0], 'norientations': 0, 'lfactor': 0.1, # 0.1 nm = 1 Ang @@ -2430,20 +2458,23 @@ def run_task(self, fw_spec): self["parent_structure"].sites[i]._frac_coords.tolist() for i in range(self["parent_structure"].num_sites) ], - 'scell': [self["trans_mat"][0][0], - self["trans_mat"][1][1], - self["trans_mat"][2][2]], 't': 300, 'scalebroad': 0.5, 'nonanalytic': False, 'isotopes': False, } + if self["force_diagonal_transformation"]: + shengbte_control_dict['scell'] = [self["trans_mat"][0][0], + self["trans_mat"][1][1], + self["trans_mat"][2][2]] + else: + shengbte_control_dict['scell'] = [5, 5, 5] if self["t_range"]: shengbte_control_dict['t_min'] = 100 shengbte_control_dict['t_max'] = 1000 shengbte_control_dict['t_step'] = 100 io = Control.from_dict(shengbte_control_dict) - io.to_file() #writes CONTROL file to current directory + io.to_file() # writes CONTROL file to current directory # Copy force constants from previous CSLD firework force_constants_path = fw_spec["successful_CSLD_path"] @@ -2461,10 +2492,12 @@ def run_task(self, fw_spec): open("shengbte_err.txt", "w", buffering=1) as f_err: # use line buffering for stderr return_code = subprocess.call(shengbte_cmd, stdout=f_std, stderr=f_err) - logger.info("Command {} finished running with returncode: {}".format(shengbte_cmd, return_code)) + logger.info("Command {} finished running " + "with returncode: {}".format(shengbte_cmd, return_code)) if return_code==1: - raise RuntimeError("Running ShengBTE failed. Check 'shengbte_err.txt'" - " in the launch_dir for details.") + raise RuntimeError("Running ShengBTE failed. Check " + "'shengbte_err.txt' in the launch_dir for " + "details.") try: # Store lattice thermal conductivity matrix in the database @@ -2479,7 +2512,8 @@ def run_task(self, fw_spec): summaries = [] for temp in temps: # xx, xy, xz, yx, yy, yz, zx, zy, zz - flattened_kappa = np.loadtxt('T'+str(int(temp))+'K/BTE.kappa_tensor')[1][1:] + flattened_kappa = np.loadtxt( + 'T'+str(int(temp))+'K/BTE.kappa_tensor')[1][1:] flattened_kappa = flattened_kappa.reshape((3, 3)).tolist() summary = { "date": datetime.now(), @@ -2495,7 +2529,8 @@ def run_task(self, fw_spec): mmdb.collection = mmdb.db["sheng_bte"] mmdb.collection.insert(summaries) except: - raise FileNotFoundError('BTE.kappa_tensor was not output from ShengBTE.') + raise FileNotFoundError('BTE.kappa_tensor was not output from ' + 'ShengBTE.') # the following definitions for backward compatibility diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index 40d73dc96..e0edef612 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -1,42 +1,105 @@ # coding: utf-8 -import os - import numpy as np from uuid import uuid4 -from pymatgen.symmetry.analyzer import SpacegroupAnalyzer -from pymatgen.alchemy.materials import TransformedStructure -from pymatgen.transformations.standard_transformations import \ - PerturbStructureTransformation from pymatgen.transformations.advanced_transformations import ( - CubicSupercellTransformation -) + CubicSupercellTransformation) +from pymatgen.io.vasp.sets import MPStaticSet + from fireworks import Workflow, Firework from atomate.utils.utils import get_logger -from atomate.vasp.config import VASP_CMD, DB_FILE, ADD_WF_METADATA # what is this? -from atomate.vasp.fireworks.core import StaticFW, OptimizeFW +from atomate.vasp.config import VASP_CMD, DB_FILE +from atomate.vasp.fireworks.core import StaticFW from atomate.vasp.firetasks.parse_outputs import CSLDForceConstantsToDB -from atomate.vasp.powerups import ( - add_additional_fields_to_taskdocs -) +from atomate.vasp.powerups import add_additional_fields_to_taskdocs from atomate.vasp.analysis.csld import generate_perturbed_supercells -from pymatgen.io.vasp.sets import MPStaticSet, MPRelaxSet - -# NEW THINGS TO INSTALL? -# from configparser import ConfigParser -# from scripts import csld_main_rees #csld>scripts - -logger = get_logger(__name__) - __author__ = "Rees Chang" __email__ = "rc564@cornell.edu" __date__ = "July 2019" - __csld_wf_version__ = 1.0 +logger = get_logger(__name__) + + class CompressedSensingLatticeDynamicsWF: + """ + This workflow will use compressed sensing lattice dynamics (CSLD) + (doi: 10.1103/PhysRevLett.113.185501) to generate interatomic force + constants from an input structure and output a summary to a database. + + TODO: Implement 'tight_relaxation', 'dfpt_check', and 'nscf_check' options + + A summary of the workflow is as follows: + 1. Transform the input structure into a supercell + 2. Transform the supercell into a list of supercells with all atoms + randomly perturbed from their original sites + 3. Run static VASP calculations on each perturbed supercell to + calculate atomic forces. + 4. Aggregate the forces and conduct the CSLD minimization algorithm + to compute interatomic force constants. + 5. Output the interatomic force constants to the database. + + Args: + parent_structure (Structure): Structure to conduct CSLD on + symmetrize (bool): If True, the parent_structure will be primitized + before running CSLD. Else, the parent_structure will be used + for CSLD as is. + tight_relaxation (bool): If True, run a tight relaxation step on the + parent_structure. Else, do not. TODO: IMPLEMENT + dfpt_check (bool): If True, run a DFPT calculation at the gamma + point to check for dynamic instabilities. TODO: IMPLEMENT + nscf_check (bool): If True, run a nscf electronic bands calculation to + determine if parent_structure is a metal or not. If metal, set + ISMEAR=1 for the static perturbed supercell calculations. Else, set + ISMEAR=0. TODO: IMPLEMENT + symprec (float): symmetry precision parameter for + SpacegroupAnalyzer's 'get_primitive_standard_structure()' + function + min_atoms (int): Minimum number of atoms to constrain the supercell + max_atoms (int): Maximum number of atoms to constrain the supercell + num_nn_dists (int or float): Number of nearest neighbor distances + that the shortest direction of the supercell must be as long as + force_diagonal_transformation (bool): If True, the supercell + transformation will be constrained to have a diagonal + transformation matrix. If False, the supercell transformation + will not be constrained to be diagonal (resulting in a more + cubic supercell). + max_displacement (float): Maximum displacement distance for + perturbing the supercell structure (Angstroms) + min_displacement (float): Minimum displacement distance for + perturbing the supercell structure (Angstroms) + num_displacements (int): Number of unique displacement distances to + generate uniformly between 'min_displacement' and + 'max_displacement' + min_random_distance (Optional float): If None (default), then all + atoms in the supercell will move the same distance from their + original locations. If float, then for a given supercell, the + distances that atoms move will be uniformly distributed from a + minimum distance of 'min_random_distance' to one of the + displacement distances uniformly sampled between + 'min_displacement' and 'max_displacement'. + supercells_per_displacement_distance (int): number of supercells to + generate for each unique displacement distance. + dynamic_static_calcs (bool): If True and CSLD fails to return all real + harmonic phonon frequencies on the first try, then the CSLD firework + will dynamically create more static perturbed supercell calculations + with larger displacements with the aim of handling materials with + loosely bound atoms (e.g. rattling modes). + do_shengbte (bool): If True and CSLD successfully returns all real + harmonic phonon frequencies, then the CSLD firework will dynamically + create a ShengBTE firework for calculating the lattice thermal + conductivity matrix and storing it to a database. + shengbte_t_range (bool): If False (default), calculate the lattice + thermal conductivity with ShengBTE at 300 K. If True, do the + calculation from 100-1000 K with 100 K steps (much slower). + shengbte_fworker (None or str): If None, the ShengBTE firework's + fworker will be set to all the previous fireworks' fworker. If + str, the ShengBTE firework's fworker will be set to + shengbte_fworker. + """ + def __init__( self, parent_structure, @@ -51,84 +114,29 @@ def __init__( num_displacements=10, min_random_distance=None, supercells_per_displacement_distance=1, + dynamic_static_calcs=False, + do_shengbte=False, shengbte_t_range=False, shengbte_fworker=None ): - """ - This workflow will use compressed sensing lattice dynamics (CSLD) - (doi: 10.1103/PhysRevLett.113.185501) to generate interatomic force - constants from an input structure and output a summary to a database. - - A summary of the workflow is as follows: - 1. Transform the input structure into a supercell - 2. Transform the supercell into a list of supercells with all atoms - randomly perturbed from their original sites - 3. Run static VASP calculations on each perturbed supercell to - calculate atomic forces. - 4. Aggregate the forces and conduct the CSLD minimization algorithm - to compute interatomic force constants. - 5. Output the interatomic force constants to the database. - - Args: - parent_structure (Structure): Structure to conduct CSLD on - symmetrize (bool): If True, the parent_structure will be primitized - before running CSLD. Else, the parent_structure will be used - for CSLD as is. - tight_relaxation (bool): If True, run a tight relaxation step on the - parent_structure. Else, do not. TODO: IMPLEMENT - dfpt_check (bool): If True, run a DFPT calculation at the gamma - point to check for dynamic instabilities. TODO: IMPLEMENT - symprec (float): symmetry precision parameter for - SpacegroupAnalyzer's 'get_primitive_standard_structure()' - function - min_atoms (int): Minimum number of atoms to constrain the supercell - max_atoms (int): Maximum number of atoms to constrain the supercell - num_nn_dists (int or float): Number of nearest neighbor distances - that the shortest direction of the supercell must be as long as - force_diagonal_transformation (bool): If True, the supercell - transformation will be constrained to have a diagonal - transformation matrix. If False, the supercell transformation - will not be constrained to be diagonal (resulting in a more - cubic supercell). - max_displacement (float): Maximum displacement distance for - perturbing the supercell structure (Angstroms) - min_displacement (float): Minimum displacement distance for - perturbing the supercell structure (Angstroms) - num_displacements (int): Number of unique displacement distances to - generate uniformly between 'min_displacement' and - 'max_displacement' - min_random_distance (Optional float): If None (default), then all - atoms in the supercell will move the same distance from their - original locations. If float, then for a given supercell, the - distances that atoms move will be uniformly distributed from a - minimum distance of 'min_random_distance' to one of the - displacement distances uniformly sampled between - 'min_displacement' and 'max_displacement'. - supercells_per_displacement_distance (int): number of supercells to - generate for each unique displacement distance. - shengbte_t_range (bool): If False (default), calculate the lattice - thermal conductivity with ShengBTE at 300 K. If True, do the - calculation from 100-1000 K with 100 K steps (much slower). - shengbte_fworker (None or str): If None, the ShengBTE firework's - fworker will be set to all the previous fireworks' fworker. If - str, the ShengBTE firework's fworker will be set to - shengbte_fworker. - """ - if force_diagonal_transformation is True and num_nn_dists==5: + + if force_diagonal_transformation is True and num_nn_dists == 5: num_nn_dists = 6 + # default name is CompressedSensingLatticeDynamicsWF self.uuid = str(uuid4()) self.wf_meta = { "wf_uuid": self.uuid, - "wf_name": self.__class__.__name__, #"CompressedSensingLatticeDynamicsWF" + "wf_name": self.__class__.__name__, } - # Create supercell + # Create supercell self.parent_structure = parent_structure if symmetrize: sga = SpacegroupAnalyzer(parent_structure, symprec=symprec) self.parent_structure = sga.get_primitive_standard_structure() + self.force_diagonal_transformation = force_diagonal_transformation self.min_atoms = min_atoms self.max_atoms = max_atoms self.num_nn_dists = num_nn_dists @@ -136,18 +144,19 @@ def __init__( self.min_atoms, self.max_atoms, self.num_nn_dists, - force_diagonal_transformation=force_diagonal_transformation + force_diagonal_transformation=self.force_diagonal_transformation ) - # supercell (Structure) - self.supercell = supercell_transform.apply_transformation(self.parent_structure) + self.supercell = supercell_transform.apply_transformation( + self.parent_structure) self.nn_dist = supercell_transform.nn_dist self.trans_mat = supercell_transform.trans_mat.tolist() self.supercell_smallest_dim = supercell_transform.smallest_dim - # Generate list of perturbed supercells - # self.perturbed_supercells: list of perturbed supercells (list of Structures) - # self.disps: list of (non-unique) displacement values used in the perturbation (np.array) + # Generate list of perturbed supercells + # perturbed_supercells: list of perturbed supercells (list[Structures]) + # disps: list of (non-unique) displacement values used in the + # perturbation (np.array) self.perturbed_supercells, self.disps = generate_perturbed_supercells( self.supercell, min_displacement=min_displacement, @@ -157,42 +166,35 @@ def __init__( min_random_distance=min_random_distance ) + self.dynamic_static_calcs = dynamic_static_calcs + self.do_shengbte = do_shengbte self.shengbte_t_range = shengbte_t_range self.shengbte_fworker = shengbte_fworker - def get_wf( - self, - c=None - ): + def get_wf(self, c=None): fws = [] c = c or {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} - def _add_metadata(structure): - """ - Add metadata for easy querying from the database later. - """ - return TransformedStructure( - structure, other_parameters={"wf_meta": self.wf_meta} - ) - - - static_user_incar_settings = {"ADDGRID": True, - # Fast Fourier Transform grid - "LCHARG": False, - "ENCUT": 700, - "EDIFF": 1e-8, # may need to tune this - "PREC": 'Accurate', - "LAECHG": False, - "LREAL": False, - "LASPH": True} + static_user_incar_settings = { + "ADDGRID": True, # Fast Fourier Transform grid + "LCHARG": False, + "ENCUT": 700, + "EDIFF": 1e-8, # may need to tune this + "PREC": 'Accurate', + "LAECHG": False, + "LREAL": False, + "LASPH": True} static_user_incar_settings.update(c.get("user_incar_settings", {})) for idx, perturbed_supercell in enumerate(self.perturbed_supercells): - # Run static calculations on the perturbed supercells to compute forces on each atom - name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format(idx, self.disps[idx]) + # Run static calculations on the perturbed supercells to compute + # forces on each atom + name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format( + idx, self.disps[idx]) - static_vis = MPStaticSet(perturbed_supercell, - user_incar_settings=static_user_incar_settings) + static_vis = MPStaticSet( + perturbed_supercell, + user_incar_settings=static_user_incar_settings) static_fw = StaticFW( perturbed_supercell, vasp_input_set=static_vis, @@ -203,12 +205,13 @@ def _add_metadata(structure): static_fw.spec["displacement_value"] = self.disps[idx] fws.append(static_fw) - print('DISPS') - print(self.disps) + logger.debug("using {} displacements".format(len(self.disps))) + logger.debug("displacements: {}".format(self.disps)) + # Collect force constants from the DB and output on cluster csld_fw = Firework( CSLDForceConstantsToDB( - db_file=c["DB_FILE"], # wot + db_file=c["DB_FILE"], wf_uuid=self.uuid, parent_structure=self.parent_structure, trans_mat=self.trans_mat, @@ -216,9 +219,12 @@ def _add_metadata(structure): supercell_smallest_dim=self.supercell_smallest_dim, perturbed_supercells=self.perturbed_supercells, disps=self.disps, + force_diagonal_transformation=self.force_diagonal_transformation, first_pass=True, static_user_incar_settings=static_user_incar_settings, env_vars=c, + dynamic_static_calcs=self.dynamic_static_calcs, + do_shengbte=self.do_shengbte, shengbte_t_range=self.shengbte_t_range, shengbte_fworker=self.shengbte_fworker ), @@ -231,33 +237,29 @@ def _add_metadata(structure): wf_name = "{} - compressed sensing lattice dynamics".format(formula) wf = Workflow(fws, name=wf_name) - wf = add_additional_fields_to_taskdocs(wf, - {"wf_meta": self.wf_meta}, - task_name_constraint="VaspToDb" - #may need to change this to "CSLDForceConstantsToDB"? - ) - #tag = #insert anything relevant to every firework in the workflow - # wf = add_tags(wf, [tag, ]) + wf = add_additional_fields_to_taskdocs( + wf, {"wf_meta": self.wf_meta}, task_name_constraint="VaspToDb") + return wf # SCRIPT FOR CREATING THE WORKFLOW AND ADDING IT TO THE DATABASE if __name__ == "__main__": - from fireworks import LaunchPad - from atomate.vasp.powerups import add_tags, set_execution_options, add_modify_incar + from atomate.vasp.powerups import add_tags, set_execution_options from pymatgen.symmetry.analyzer import SpacegroupAnalyzer from pymatgen.core.structure import Structure prim = Structure.from_file('POSCAR-well_relaxed_InSb_csld_primitivized') - csld_class = CompressedSensingLatticeDynamicsWF(prim, - symmetrize=False, - num_nn_dists=6, - num_displacements=10, - supercells_per_displacement_distance=1, - force_diagonal_transformation=True - ) + csld_class = CompressedSensingLatticeDynamicsWF( + prim, + symmetrize=False, + num_nn_dists=6, + num_displacements=10, + supercells_per_displacement_distance=1, + force_diagonal_transformation=True + ) print("uuid") print(csld_class.uuid) @@ -275,69 +277,10 @@ def _add_metadata(structure): wf = add_tags(wf, ['csld', 'v1', 'rees', 'pre-relaxed insb', 'diagonal supercell', 'not symmetrized']) - wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") #need this to run the fireworks + wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") # wf = add_modify_incar(wf, # modify_incar_params={'incar_update': {'ENCUT': 500, # 'ISPIN': 1}}) # lpad = LaunchPad.auto_load() # lpad.add_wf(wf) - -#################custom csld_main below################## -def csld_main(options, settings): - """ - Runs CSLD minimization. - - Changes from original version: - - Made 'prim' an argument in 'phonon_step()' - - Moved execution files to this main() function to be called from - atomate - - Rewrote 'add_common_parameter' in 'common_main' to treat 'options' as - a dictionary instead of ArgumentParser - """ - import matplotlib - matplotlib.use('Agg') - from matplotlib.backends.backend_pdf import PdfPages - import atexit - import csld - from csld.symmetry_structure import SymmetrizedStructure - - from csld.lattice_dynamics import init_ld_model - - from csld.common_main import upon_exit, \ - init_training - from csld.csld_main_functions import phonon_step, \ - save_pot, predict, fit_data - - - freq_matrix = None #Rees - pdfout = PdfPages( - options['pdfout'].strip()) if options['pdfout'].strip() else None - atexit.register(upon_exit, pdfout) - - prim = SymmetrizedStructure.init_structure(settings['structure'], - options['symm_step'], - options['symm_prim'], - options['log_level']) - model = init_ld_model(prim, settings['model'], settings[ - 'LDFF'] if 'LDFF' in settings.sections() else {}, options['clus_step'], - options['symC_step'], options['ldff_step']) - Amat, fval = init_training(model, settings['training'], options['train_step']) - ibest, solutions, rel_err = fit_data(model, Amat, fval, settings['fitting'], - options['fit_step'], pdfout) - if settings.has_section('phonon'): - phonon, freq_matrix = phonon_step(model, solutions, settings['phonon'], - options['phonon_step'], pdfout, prim, return_eigen=True) - if settings.has_section('export_potential'): - save_pot(model, solutions[ibest], settings['export_potential'], - options['save_pot_step'], phonon) - if settings.has_section('prediction'): - predict(model, solutions, settings['prediction'], options['pred_step']) - - #OUTPUT - # freq_matrix is (nbands, nkpoints) = frequencies. Check for negative entries - # rel_err is cross validation error in percent - return rel_err, freq_matrix #also want to return force constants - - - From e7b2b68bd23e54b90fbe0e82f5eeda538c744234 Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 7 Aug 2019 11:13:33 -0700 Subject: [PATCH 040/207] Added csld_main to csld analysis file. Add beginnings of testing files --- atomate/vasp/analysis/csld.py | 145 + atomate/vasp/test_files/csld_wf/FW.json | 55600 ++++++++++++++++ .../test_files/csld_wf/POSCAR-well_relaxed_Si | 10 + atomate/vasp/test_files/csld_wf/__init__.py | 0 .../workflows/tests/test_csld_workflow.py | 89 + 5 files changed, 55844 insertions(+) create mode 100644 atomate/vasp/test_files/csld_wf/FW.json create mode 100644 atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si create mode 100644 atomate/vasp/test_files/csld_wf/__init__.py create mode 100644 atomate/vasp/workflows/tests/test_csld_workflow.py diff --git a/atomate/vasp/analysis/csld.py b/atomate/vasp/analysis/csld.py index 8f624bce7..a1b367d63 100644 --- a/atomate/vasp/analysis/csld.py +++ b/atomate/vasp/analysis/csld.py @@ -56,3 +56,148 @@ def generate_perturbed_supercells(supercell, supercell) perturbed_supercells += [perturbed_supercell] return perturbed_supercells, displacements + + +def csld_main(options, settings): + """ + Runs CSLD minimization. + + Changes from original version: + - Made 'prim' an argument in 'phonon_step()' + - Moved execution files to this main() function to be called from + atomate + - Rewrote 'add_common_parameter' in 'common_main' to treat 'options' as + a dictionary instead of ArgumentParser + """ + import matplotlib + matplotlib.use('Agg') + from matplotlib.backends.backend_pdf import PdfPages + import atexit + import csld + from csld.symmetry_structure import SymmetrizedStructure + + from csld.lattice_dynamics import init_ld_model + + from csld.common_main import upon_exit, \ + init_training + from csld.csld_main_functions import phonon_step, \ + save_pot, predict, fit_data + + + freq_matrix = None #Rees + pdfout = PdfPages( + options['pdfout'].strip()) if options['pdfout'].strip() else None + atexit.register(upon_exit, pdfout) + + prim = SymmetrizedStructure.init_structure(settings['structure'], + options['symm_step'], + options['symm_prim'], + options['log_level']) + model = init_ld_model(prim, settings['model'], settings[ + 'LDFF'] if 'LDFF' in settings.sections() else {}, options['clus_step'], + options['symC_step'], options['ldff_step']) + Amat, fval = init_training(model, settings['training'], options['train_step']) + ibest, solutions, rel_err = fit_data(model, Amat, fval, settings['fitting'], + options['fit_step'], pdfout) + if settings.has_section('phonon'): + phonon, freq_matrix = phonon_step(model, solutions, settings['phonon'], + options['phonon_step'], pdfout, prim, return_eigen=True) + if settings.has_section('export_potential'): + save_pot(model, solutions[ibest], settings['export_potential'], + options['save_pot_step'], phonon) + if settings.has_section('prediction'): + predict(model, solutions, settings['prediction'], options['pred_step']) + + #OUTPUT + # freq_matrix is (nbands, nkpoints) = frequencies. Check for negative entries + # rel_err is cross validation error in percent + return rel_err, freq_matrix # also want to return force constants + + +default_csld_settings = { + "structure": {"sym_tol": "1e-3"}, + "model": { + 'model_type': 'LD', + 'cluster_in': 'clusters.out', + 'cluster_out': 'clusters.out', + 'symC_in': 'Cmat.mtx', + 'symC_out': 'Cmat.mtx', + 'fractional_distance': False, + }, + "training":{ + 'interface': 'VASP', + 'corr_type': 'f', + 'corr_in': 'Amat.mtx', + 'corr_out': 'Amat.mtx', + 'fval_in': 'fval.txt', + 'fval_out': 'fval.txt' + }, + "fitting": { + 'solution_in': 'solution_all', + 'solution_out': 'solution_all', + 'nsubset': 5, + 'holdsize': 0.1, + ## 1 FPC 2 FPC sparse 3 split 4 sparse split + ## 5 split+ right preconditioning 6 sparse split + r preconditioning + ## 101 Bayesian CS + 'method': 5, + # For weight of L1 or L2 regularization + 'mulist': '1E-5 1E-6 1E-7 1E-9', + 'maxIter': 300, + 'tolerance': 1E-6, + 'subsetsize': 0.85, + 'lambda': 0.5, + 'uscale_list': '0.03', + }, + "phonon": { + 'qpoint_fractional': False, + # 'Auto' or something like + # "[[10, [0,0,0],'\\Gamma', [0.5,0.5,0.5], 'X', [0.5,0.5,0], 'K']]" + 'wavevector': 'Auto', + 'unit': 'cm', # THz, meV, eV, cm + 'dos_grid': '15 15 15', # number of grid points + 'nE_dos': 500, # number of points in DOS + 'ismear': -1, # 0 (Gaussian), 1 (Lorentzian), -1 (tetrahedron method) + 'epsilon': 0.05, # width in THz of Gaussian/Lorentzian smearing + 'pdos': True, + 'thermal_T_range': '50 800 50', + 'thermal_out': 'thermal_out.txt' + }, + 'prediction': { + 'interface': 'VASP', + 'corr_type': 'f', + 'corr_in': 'Amat_pred.mtx', + 'corr_out': 'Amat_pred.mtx', + 'fval_in': 'fval_pred.txt', + 'fval_out': 'fval_pred.txt', + 'traindat0': 'fcc222/POSCAR fcc222/traj*' + }, + 'DEFAULT': { + "qpoint_fractional": False, + "true_v_fit": 'true_fit.txt', + 'epsilon': '0.05', + "bcs_reweight": 'True', + "bcs_penalty": 'arctan', + "bcs_jcutoff": '1E-8' + } +} + +default_csld_options = { + 'pdfout': 'plots.pdf', + 'ldff_step': 0, + 'phonon_step': 1, + 'phonon': False, + 'save_pot_step': 1, + 'pot': False, + 'log_level': 1, + 'symm_step': 2, + 'symm_prim': True, + 'clus_step': 3, + 'symC_step': 3, + 'train_step': 3, + 'fit_step': 3, + 'pred_step': 0, + 'refit': False, + 'cont': False, + 'predict': False +} \ No newline at end of file diff --git a/atomate/vasp/test_files/csld_wf/FW.json b/atomate/vasp/test_files/csld_wf/FW.json new file mode 100644 index 000000000..df18899c0 --- /dev/null +++ b/atomate/vasp/test_files/csld_wf/FW.json @@ -0,0 +1,55600 @@ +{ + "spec": { + "tags": [ + "csld", + "v1", + "rees", + "pre-relaxed si", + "diagonal supercell", + "not symmetrized", + "555" + ], + "_fworker": "rees_the_fire_worker", + "_tasks": [ + { + "db_file": ">>db_file<<", + "wf_uuid": "b8ab536c-b75d-4011-a069-48cbab8b8bda", + "parent_structure": { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 2.734364, + 2.734364 + ], + [ + 2.734364, + 0.0, + 2.734364 + ], + [ + 2.734364, + 2.734364, + 0.0 + ] + ], + "a": 3.8669746532647453, + "b": 3.8669746532647453, + "c": 3.8669746532647453, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 40.88829284866483 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.5, + 0.5 + ], + "xyz": [ + 2.734364, + 2.734364, + 2.734364 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.75, + 0.75, + 0.75 + ], + "xyz": [ + 4.101546, + 4.101546, + 4.101546 + ], + "label": "Si", + "properties": {} + } + ] + }, + "trans_mat": [ + [ + 5, + 0, + 0 + ], + [ + 0, + 5, + 0 + ], + [ + 0, + 0, + 5 + ] + ], + "supercell_structure": { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1, + 0.1, + 0.1 + ], + "xyz": [ + 2.734364, + 2.734364, + 2.734364 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1, + 0.1, + 0.3 + ], + "xyz": [ + 5.468728, + 5.468728, + 2.734364 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1, + 0.10000000000000002, + 0.5000000000000001 + ], + "xyz": [ + 8.203092000000002, + 8.203092, + 2.734364 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1, + 0.1, + 0.7000000000000001 + ], + "xyz": [ + 10.937456, + 10.937456, + 2.734364 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000000000000002, + 0.09999999999999999, + 0.9 + ], + "xyz": [ + 13.671819999999999, + 13.671819999999999, + 2.734364 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1, + 0.30000000000000004, + 0.10000000000000003 + ], + "xyz": [ + 5.4687280000000005, + 2.7343640000000002, + 5.4687280000000005 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999998, + 0.30000000000000004, + 0.3000000000000001 + ], + "xyz": [ + 8.203092000000002, + 5.4687280000000005, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000000000000002, + 0.3, + 0.5 + ], + "xyz": [ + 10.937455999999997, + 8.203092, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999992, + 0.3000000000000001, + 0.7000000000000001 + ], + "xyz": [ + 13.67182, + 10.937456, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999994, + 0.3000000000000001, + 0.9 + ], + "xyz": [ + 16.406184, + 13.671819999999999, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999999, + 0.5000000000000001, + 0.10000000000000005 + ], + "xyz": [ + 8.203092000000002, + 2.7343640000000002, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000000000000002, + 0.5, + 0.30000000000000004 + ], + "xyz": [ + 10.937456, + 5.4687280000000005, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000000000000007, + 0.5, + 0.5 + ], + "xyz": [ + 13.671819999999999, + 8.203092, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999996, + 0.5000000000000001, + 0.7000000000000002 + ], + "xyz": [ + 16.406184000000003, + 10.937456000000001, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999999, + 0.5000000000000001, + 0.9000000000000001 + ], + "xyz": [ + 19.140548000000003, + 13.67182, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000000000000003, + 0.7000000000000001, + 0.09999999999999998 + ], + "xyz": [ + 10.937456, + 2.734364, + 10.937456000000001 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000000000000003, + 0.7000000000000001, + 0.30000000000000004 + ], + "xyz": [ + 13.67182, + 5.4687280000000005, + 10.937456000000001 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999998, + 0.7000000000000001, + 0.5000000000000001 + ], + "xyz": [ + 16.406184, + 8.203092, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999998, + 0.7000000000000001, + 0.7000000000000001 + ], + "xyz": [ + 19.140548, + 10.937456, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999998, + 0.7000000000000001, + 0.9 + ], + "xyz": [ + 21.874912, + 13.671819999999999, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000000000000005, + 0.9, + 0.09999999999999996 + ], + "xyz": [ + 13.671819999999999, + 2.734364, + 13.67182 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999994, + 0.9000000000000001, + 0.30000000000000016 + ], + "xyz": [ + 16.406184000000003, + 5.4687280000000005, + 13.67182 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999999, + 0.9, + 0.5 + ], + "xyz": [ + 19.140548, + 8.203091999999998, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999999, + 0.9, + 0.7000000000000002 + ], + "xyz": [ + 21.874912000000002, + 10.937456000000001, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09999999999999999, + 0.9, + 0.9000000000000001 + ], + "xyz": [ + 24.609275999999998, + 13.67182, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.1, + 0.10000000000000003 + ], + "xyz": [ + 2.7343640000000002, + 5.4687280000000005, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.09999999999999999, + 0.3 + ], + "xyz": [ + 5.468727999999999, + 8.203092, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3, + 0.10000000000000003, + 0.5 + ], + "xyz": [ + 8.203092, + 10.937455999999997, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3000000000000001, + 0.09999999999999995, + 0.7000000000000001 + ], + "xyz": [ + 10.937456, + 13.67182, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3000000000000001, + 0.09999999999999994, + 0.9 + ], + "xyz": [ + 13.671819999999999, + 16.406184, + 5.468728 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.30000000000000004, + 0.09999999999999999 + ], + "xyz": [ + 5.468728, + 5.468728, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.30000000000000004, + 0.30000000000000004 + ], + "xyz": [ + 8.203092, + 8.203092, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.30000000000000004, + 0.5 + ], + "xyz": [ + 10.937456, + 10.937456, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3, + 0.30000000000000004, + 0.7000000000000002 + ], + "xyz": [ + 13.671820000000002, + 13.67182, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.30000000000000004, + 0.9000000000000001 + ], + "xyz": [ + 16.406184, + 16.406184, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3, + 0.5000000000000001, + 0.10000000000000009 + ], + "xyz": [ + 8.203092000000002, + 5.4687280000000005, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.5, + 0.30000000000000004 + ], + "xyz": [ + 10.937456, + 8.203092, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.5, + 0.5 + ], + "xyz": [ + 13.671819999999999, + 10.937456, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.5, + 0.7000000000000001 + ], + "xyz": [ + 16.406184, + 13.67182, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.5, + 0.9 + ], + "xyz": [ + 19.140548, + 16.406184, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3, + 0.7000000000000001, + 0.10000000000000007 + ], + "xyz": [ + 10.937456000000001, + 5.468728, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.7, + 0.30000000000000004 + ], + "xyz": [ + 13.671819999999999, + 8.203092, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29999999999999993, + 0.7000000000000001, + 0.5000000000000002 + ], + "xyz": [ + 16.406184000000003, + 10.937456000000001, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.7, + 0.7000000000000002 + ], + "xyz": [ + 19.140548, + 13.671820000000002, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.7, + 0.9000000000000001 + ], + "xyz": [ + 21.874912, + 16.406184, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3000000000000001, + 0.9, + 0.09999999999999999 + ], + "xyz": [ + 13.671819999999999, + 5.4687280000000005, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.9000000000000001, + 0.30000000000000004 + ], + "xyz": [ + 16.406184, + 8.203092, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000004, + 0.9000000000000001, + 0.5 + ], + "xyz": [ + 19.140548, + 10.937456, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3000000000000001, + 0.9, + 0.7 + ], + "xyz": [ + 21.874912, + 13.671819999999999, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30000000000000016, + 0.9, + 0.8999999999999999 + ], + "xyz": [ + 24.609275999999998, + 16.406184, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.09999999999999999, + 0.09999999999999999 + ], + "xyz": [ + 2.7343639999999994, + 8.203092000000002, + 8.203092000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.10000000000000002, + 0.30000000000000004 + ], + "xyz": [ + 5.4687280000000005, + 10.937456, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.10000000000000005, + 0.5 + ], + "xyz": [ + 8.203092, + 13.671819999999999, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.09999999999999999, + 0.7 + ], + "xyz": [ + 10.937455999999997, + 16.406184, + 8.203092000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.09999999999999996, + 0.8999999999999999 + ], + "xyz": [ + 13.671819999999997, + 19.140548, + 8.203092 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.3, + 0.09999999999999998 + ], + "xyz": [ + 5.468727999999999, + 8.203091999999998, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.30000000000000004, + 0.30000000000000004 + ], + "xyz": [ + 8.203092, + 10.937456, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.30000000000000004, + 0.5 + ], + "xyz": [ + 10.937456, + 13.671819999999999, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.30000000000000004, + 0.7000000000000001 + ], + "xyz": [ + 13.67182, + 16.406184, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.30000000000000004, + 0.9 + ], + "xyz": [ + 16.406184, + 19.140548, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.5, + 0.10000000000000007 + ], + "xyz": [ + 8.203092, + 8.203092, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.5, + 0.30000000000000004 + ], + "xyz": [ + 10.937456, + 10.937456, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.5, + 0.5 + ], + "xyz": [ + 13.671819999999999, + 13.671819999999999, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.5, + 0.7000000000000002 + ], + "xyz": [ + 16.406184, + 16.406184, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.5, + 0.9000000000000001 + ], + "xyz": [ + 19.140548, + 19.140548, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.7000000000000001, + 0.09999999999999999 + ], + "xyz": [ + 10.937456, + 8.203092000000002, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.7000000000000001, + 0.29999999999999993 + ], + "xyz": [ + 13.671819999999999, + 10.937456, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.7000000000000002, + 0.5 + ], + "xyz": [ + 16.406184, + 13.671819999999999, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.7000000000000001, + 0.7 + ], + "xyz": [ + 19.140548, + 16.406184, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.7000000000000001, + 0.8999999999999999 + ], + "xyz": [ + 21.874912, + 19.140548, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.9, + 0.09999999999999998 + ], + "xyz": [ + 13.671819999999999, + 8.203092, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.9000000000000001, + 0.30000000000000016 + ], + "xyz": [ + 16.406184000000003, + 10.937456000000001, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5, + 0.9000000000000001, + 0.5000000000000001 + ], + "xyz": [ + 19.140548000000003, + 13.67182, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.9, + 0.7000000000000001 + ], + "xyz": [ + 21.874912, + 16.406184, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000000000000001, + 0.9, + 0.9 + ], + "xyz": [ + 24.609275999999998, + 19.140548, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.09999999999999998, + 0.09999999999999998 + ], + "xyz": [ + 2.734363999999999, + 10.937456, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.10000000000000003, + 0.30000000000000004 + ], + "xyz": [ + 5.4687280000000005, + 13.67182, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.09999999999999998, + 0.5000000000000001 + ], + "xyz": [ + 8.203092, + 16.406184, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.09999999999999998, + 0.7000000000000001 + ], + "xyz": [ + 10.937456, + 19.140548, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.09999999999999998, + 0.9 + ], + "xyz": [ + 13.671819999999999, + 21.874912, + 10.937456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.3, + 0.10000000000000007 + ], + "xyz": [ + 5.468728, + 10.937456000000001, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7, + 0.30000000000000004, + 0.30000000000000004 + ], + "xyz": [ + 8.203092, + 13.671819999999999, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.3, + 0.5 + ], + "xyz": [ + 10.937455999999997, + 16.406184, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7, + 0.30000000000000004, + 0.7000000000000002 + ], + "xyz": [ + 13.671820000000002, + 19.140548, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7, + 0.30000000000000004, + 0.9000000000000001 + ], + "xyz": [ + 16.406184, + 21.874912, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.5000000000000001, + 0.09999999999999999 + ], + "xyz": [ + 8.203092000000002, + 10.937456, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.5000000000000001, + 0.29999999999999993 + ], + "xyz": [ + 10.937456, + 13.671819999999999, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000002, + 0.5, + 0.5 + ], + "xyz": [ + 13.671819999999999, + 16.406184, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.5000000000000001, + 0.7 + ], + "xyz": [ + 16.406184, + 19.140548, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.5000000000000001, + 0.9000000000000001 + ], + "xyz": [ + 19.140548000000003, + 21.874912, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.7000000000000001, + 0.09999999999999998 + ], + "xyz": [ + 10.937456, + 10.937456, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.7000000000000001, + 0.29999999999999993 + ], + "xyz": [ + 13.671819999999999, + 13.671819999999999, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.7000000000000001, + 0.5000000000000001 + ], + "xyz": [ + 16.406184, + 16.406184, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.7000000000000001, + 0.7000000000000001 + ], + "xyz": [ + 19.140548, + 19.140548, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.7000000000000001, + 0.9 + ], + "xyz": [ + 21.874912, + 21.874912, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.9, + 0.09999999999999996 + ], + "xyz": [ + 13.671819999999999, + 10.937456, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7, + 0.9000000000000001, + 0.30000000000000004 + ], + "xyz": [ + 16.406184, + 13.671819999999999, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.9, + 0.5 + ], + "xyz": [ + 19.140548, + 16.406184, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.9, + 0.7 + ], + "xyz": [ + 21.874912, + 19.140548, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000000000000001, + 0.9, + 0.9000000000000001 + ], + "xyz": [ + 24.609275999999998, + 21.874912, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.09999999999999999, + 0.09999999999999996 + ], + "xyz": [ + 2.734363999999999, + 13.671819999999999, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000000000000001, + 0.09999999999999994, + 0.30000000000000004 + ], + "xyz": [ + 5.468728, + 16.406184, + 13.67182 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.09999999999999999, + 0.5 + ], + "xyz": [ + 8.203091999999998, + 19.140548, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.09999999999999999, + 0.7000000000000002 + ], + "xyz": [ + 10.937456000000001, + 21.874912000000002, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.09999999999999999, + 0.9000000000000001 + ], + "xyz": [ + 13.67182, + 24.609275999999998, + 13.671819999999999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.3000000000000001, + 0.09999999999999999 + ], + "xyz": [ + 5.4687280000000005, + 13.671819999999999, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000000000000001, + 0.30000000000000004, + 0.30000000000000004 + ], + "xyz": [ + 8.203092, + 16.406184, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000000000000001, + 0.30000000000000004, + 0.5 + ], + "xyz": [ + 10.937456, + 19.140548, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.30000000000000016, + 0.7000000000000002 + ], + "xyz": [ + 13.671820000000004, + 21.874912000000002, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.30000000000000016, + 0.9000000000000001 + ], + "xyz": [ + 16.406184000000003, + 24.609275999999998, + 16.406184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.5000000000000001, + 0.09999999999999998 + ], + "xyz": [ + 8.203092, + 13.671819999999999, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000000000000001, + 0.5, + 0.29999999999999993 + ], + "xyz": [ + 10.937455999999997, + 16.406184, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000000000000001, + 0.5, + 0.4999999999999999 + ], + "xyz": [ + 13.671819999999997, + 19.140548, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.5000000000000001, + 0.7000000000000001 + ], + "xyz": [ + 16.406184, + 21.874912, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.5000000000000001, + 0.9 + ], + "xyz": [ + 19.140548, + 24.609275999999998, + 19.140548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.7000000000000001, + 0.09999999999999996 + ], + "xyz": [ + 10.937456, + 13.671819999999999, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000000000000001, + 0.7, + 0.30000000000000004 + ], + "xyz": [ + 13.671819999999999, + 16.406184, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.7000000000000001, + 0.5 + ], + "xyz": [ + 16.406184, + 19.140548, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.7000000000000001, + 0.7000000000000002 + ], + "xyz": [ + 19.140548000000003, + 21.874912000000002, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.7000000000000001, + 0.9000000000000001 + ], + "xyz": [ + 21.874912, + 24.609275999999998, + 21.874912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.9, + 0.09999999999999995 + ], + "xyz": [ + 13.671819999999999, + 13.671819999999999, + 24.609275999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.9, + 0.30000000000000016 + ], + "xyz": [ + 16.406184, + 16.406184, + 24.609275999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.9, + 0.5000000000000001 + ], + "xyz": [ + 19.140548, + 19.140548, + 24.609275999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.9, + 0.7000000000000001 + ], + "xyz": [ + 21.874912, + 21.874912, + 24.609275999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9, + 0.9, + 0.9 + ], + "xyz": [ + 24.609275999999998, + 24.609275999999998, + 24.609275999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000002, + 0.15000000000000002, + 0.15000000000000002 + ], + "xyz": [ + 4.101546, + 4.101546, + 4.101546 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15, + 0.15000000000000002, + 0.3500000000000001 + ], + "xyz": [ + 6.835910000000001, + 6.83591, + 4.101546 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000002, + 0.15000000000000002, + 0.55 + ], + "xyz": [ + 9.570274, + 9.570274, + 4.101546 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000005, + 0.15, + 0.7500000000000001 + ], + "xyz": [ + 12.304638, + 12.304638, + 4.101546 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000005, + 0.15, + 0.9500000000000001 + ], + "xyz": [ + 15.039001999999998, + 15.039002, + 4.101546 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15, + 0.3500000000000001, + 0.15000000000000005 + ], + "xyz": [ + 6.835910000000001, + 4.101546, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000005, + 0.35000000000000003, + 0.35000000000000003 + ], + "xyz": [ + 9.570274, + 6.83591, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15, + 0.3500000000000001, + 0.55 + ], + "xyz": [ + 12.304638, + 9.570274, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000008, + 0.35, + 0.7500000000000002 + ], + "xyz": [ + 15.039002, + 12.304638000000002, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000008, + 0.35, + 0.9500000000000002 + ], + "xyz": [ + 17.773366, + 15.039002000000002, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000002, + 0.55, + 0.14999999999999997 + ], + "xyz": [ + 9.570274, + 4.101545999999999, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15, + 0.55, + 0.35000000000000003 + ], + "xyz": [ + 12.304638, + 6.835909999999999, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000002, + 0.55, + 0.55 + ], + "xyz": [ + 15.039002, + 9.570274, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500000000000001, + 0.5499999999999999, + 0.7500000000000001 + ], + "xyz": [ + 17.773366, + 12.304638000000002, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15, + 0.55, + 0.9500000000000003 + ], + "xyz": [ + 20.507730000000002, + 15.039002000000002, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000005, + 0.7500000000000001, + 0.15 + ], + "xyz": [ + 12.304638, + 4.101546, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500000000000001, + 0.7500000000000001, + 0.35 + ], + "xyz": [ + 15.039002, + 6.83591, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500000000000001, + 0.7500000000000001, + 0.5499999999999999 + ], + "xyz": [ + 17.773366, + 9.570274, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000005, + 0.7500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 20.507730000000002, + 12.304638, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500000000000001, + 0.7500000000000001, + 0.9500000000000001 + ], + "xyz": [ + 23.242094, + 15.039002, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000005, + 0.9500000000000001, + 0.15 + ], + "xyz": [ + 15.039001999999998, + 4.101546, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500000000000001, + 0.9500000000000001, + 0.3499999999999999 + ], + "xyz": [ + 17.773365999999996, + 6.83591, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15, + 0.9500000000000002, + 0.55 + ], + "xyz": [ + 20.50773, + 9.570274, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15000000000000005, + 0.9500000000000001, + 0.7500000000000002 + ], + "xyz": [ + 23.242094, + 12.304638000000002, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500000000000001, + 0.9500000000000001, + 0.9500000000000002 + ], + "xyz": [ + 25.976458, + 15.039002000000002, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.15000000000000002, + 0.15000000000000005 + ], + "xyz": [ + 4.101546000000001, + 6.83591, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.15000000000000005, + 0.35000000000000003 + ], + "xyz": [ + 6.83591, + 9.570274, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.14999999999999997, + 0.5500000000000002 + ], + "xyz": [ + 9.570274000000001, + 12.304638000000002, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.15000000000000002, + 0.7500000000000002 + ], + "xyz": [ + 12.304638000000002, + 15.039002000000002, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.15000000000000002, + 0.9500000000000002 + ], + "xyz": [ + 15.039002000000002, + 17.773366, + 6.83591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.35000000000000003, + 0.15000000000000008 + ], + "xyz": [ + 6.83591, + 6.83591, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.35000000000000003, + 0.35000000000000003 + ], + "xyz": [ + 9.570274, + 9.570274, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.35000000000000003, + 0.5500000000000002 + ], + "xyz": [ + 12.304638, + 12.304638, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.35, + 0.7500000000000001 + ], + "xyz": [ + 15.039002, + 15.039002000000002, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.35, + 0.9500000000000001 + ], + "xyz": [ + 17.773366, + 17.773366, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.55, + 0.15 + ], + "xyz": [ + 9.570274, + 6.83591, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.5500000000000002, + 0.35 + ], + "xyz": [ + 12.304638, + 9.570274, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000014, + 0.55, + 0.5500000000000002 + ], + "xyz": [ + 15.039002000000002, + 12.304638000000002, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000014, + 0.55, + 0.7500000000000001 + ], + "xyz": [ + 17.773366, + 15.039002000000002, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.5500000000000002, + 0.9500000000000001 + ], + "xyz": [ + 20.50773, + 17.773366, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.7500000000000001, + 0.15 + ], + "xyz": [ + 12.304638, + 6.835909999999999, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.7500000000000001, + 0.3499999999999999 + ], + "xyz": [ + 15.039002, + 9.570274, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000014, + 0.75, + 0.55 + ], + "xyz": [ + 17.773366, + 12.304638, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.7500000000000001, + 0.7500000000000002 + ], + "xyz": [ + 20.507730000000002, + 15.039002000000002, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.7500000000000001, + 0.9500000000000002 + ], + "xyz": [ + 23.242094, + 17.773366000000003, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.9500000000000001, + 0.14999999999999997 + ], + "xyz": [ + 15.039001999999998, + 6.83591, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.9500000000000001, + 0.3499999999999999 + ], + "xyz": [ + 17.773365999999996, + 9.570274, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35000000000000003, + 0.9500000000000001, + 0.5500000000000002 + ], + "xyz": [ + 20.50773, + 12.304638, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.9500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 23.242093999999998, + 15.039002000000002, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500000000000001, + 0.9500000000000001, + 0.9500000000000001 + ], + "xyz": [ + 25.976457999999997, + 17.773366, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.15000000000000002, + 0.14999999999999997 + ], + "xyz": [ + 4.101545999999999, + 9.570274, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.15, + 0.35000000000000014 + ], + "xyz": [ + 6.835910000000001, + 12.304638, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.15, + 0.5500000000000002 + ], + "xyz": [ + 9.570274000000001, + 15.039002000000002, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.15000000000000002, + 0.7500000000000001 + ], + "xyz": [ + 12.304638, + 17.773366, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.15000000000000002, + 0.9500000000000001 + ], + "xyz": [ + 15.039002, + 20.50773, + 9.570274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.3500000000000001, + 0.15 + ], + "xyz": [ + 6.83591, + 9.570274, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.35000000000000003, + 0.3500000000000001 + ], + "xyz": [ + 9.570274000000001, + 12.304638000000002, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.3500000000000001, + 0.5500000000000002 + ], + "xyz": [ + 12.304638000000002, + 15.039002000000002, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.3500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 15.039002000000002, + 17.773366000000003, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.35000000000000003, + 0.9500000000000001 + ], + "xyz": [ + 17.773366, + 20.50773, + 12.304638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.55, + 0.15 + ], + "xyz": [ + 9.570274, + 9.570274, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.55, + 0.35000000000000003 + ], + "xyz": [ + 12.304638, + 12.304638, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.55, + 0.55 + ], + "xyz": [ + 15.039002, + 15.039002, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.55, + 0.75 + ], + "xyz": [ + 17.773366, + 17.773366, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.5500000000000002, + 0.9500000000000002 + ], + "xyz": [ + 20.507730000000002, + 20.507730000000002, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.7500000000000001, + 0.14999999999999997 + ], + "xyz": [ + 12.304638, + 9.570274, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.75, + 0.35000000000000014 + ], + "xyz": [ + 15.039002, + 12.304638000000002, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.75, + 0.5500000000000002 + ], + "xyz": [ + 17.773366, + 15.039002000000002, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.7500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 20.507730000000002, + 17.773366, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.7500000000000001, + 0.9500000000000001 + ], + "xyz": [ + 23.242094, + 20.50773, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.9500000000000001, + 0.14999999999999997 + ], + "xyz": [ + 15.039001999999998, + 9.570274, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500000000000002, + 0.95, + 0.35000000000000003 + ], + "xyz": [ + 17.773366, + 12.304638, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.9500000000000001, + 0.5500000000000002 + ], + "xyz": [ + 20.50773, + 15.039002000000002, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.9500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 23.242093999999998, + 17.773366, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55, + 0.9500000000000001, + 0.9500000000000001 + ], + "xyz": [ + 25.976457999999997, + 20.50773, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.15000000000000005, + 0.15 + ], + "xyz": [ + 4.101546, + 12.304638, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.15000000000000005, + 0.3500000000000001 + ], + "xyz": [ + 6.835910000000001, + 15.039002000000002, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.15000000000000005, + 0.5499999999999999 + ], + "xyz": [ + 9.570274, + 17.773366, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.1500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 12.304638000000002, + 20.507730000000002, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.1500000000000001, + 0.9500000000000001 + ], + "xyz": [ + 15.039002, + 23.242094, + 12.304638000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.35000000000000003, + 0.1500000000000001 + ], + "xyz": [ + 6.835910000000001, + 12.304638000000002, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.35000000000000003, + 0.35000000000000003 + ], + "xyz": [ + 9.570274, + 15.039002000000002, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.3500000000000001, + 0.55 + ], + "xyz": [ + 12.304638, + 17.773366, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.3500000000000001, + 0.75 + ], + "xyz": [ + 15.039002, + 20.50773, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.35000000000000003, + 0.95 + ], + "xyz": [ + 17.773366, + 23.242093999999998, + 15.039002000000002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.55, + 0.15000000000000008 + ], + "xyz": [ + 9.570274000000001, + 12.304638000000002, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.55, + 0.35000000000000014 + ], + "xyz": [ + 12.304638, + 15.039002000000002, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.55, + 0.5500000000000002 + ], + "xyz": [ + 15.039002000000002, + 17.773366000000003, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.55, + 0.7500000000000001 + ], + "xyz": [ + 17.773366, + 20.507730000000002, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.75, + 0.5500000000000002, + 0.9500000000000001 + ], + "xyz": [ + 20.50773, + 23.242093999999998, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.75, + 0.15000000000000008 + ], + "xyz": [ + 12.304638, + 12.304638000000002, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.75, + 0.35000000000000003 + ], + "xyz": [ + 15.039002, + 15.039002000000002, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.75, + 0.5499999999999999 + ], + "xyz": [ + 17.773366, + 17.773366, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.75, + 0.7500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 20.507730000000002, + 20.50773, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.75, + 0.7500000000000001, + 0.9500000000000001 + ], + "xyz": [ + 23.242094, + 23.242093999999998, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.95, + 0.15000000000000016 + ], + "xyz": [ + 15.039002, + 12.304638000000002, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500000000000001, + 0.95, + 0.35000000000000014 + ], + "xyz": [ + 17.773366, + 15.039002000000002, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.75, + 0.9500000000000001, + 0.55 + ], + "xyz": [ + 20.50773, + 17.773366, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.75, + 0.9500000000000001, + 0.75 + ], + "xyz": [ + 23.242093999999998, + 20.50773, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.75, + 0.9500000000000001, + 0.95 + ], + "xyz": [ + 25.976457999999997, + 23.242093999999998, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000002, + 0.15, + 0.15 + ], + "xyz": [ + 4.101545999999999, + 15.039002, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.15000000000000005, + 0.35000000000000003 + ], + "xyz": [ + 6.83591, + 17.773366, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.15000000000000005, + 0.55 + ], + "xyz": [ + 9.570274, + 20.50773, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.1500000000000001, + 0.75 + ], + "xyz": [ + 12.304638, + 23.242093999999998, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.15000000000000005, + 0.95 + ], + "xyz": [ + 15.039001999999998, + 25.976457999999997, + 15.039002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.35000000000000003, + 0.15000000000000008 + ], + "xyz": [ + 6.83591, + 15.039002, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.35000000000000003, + 0.3499999999999999 + ], + "xyz": [ + 9.570273999999998, + 17.773365999999996, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.3500000000000001, + 0.5500000000000002 + ], + "xyz": [ + 12.304638000000002, + 20.50773, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.3500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 15.039002000000002, + 23.242093999999998, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.35000000000000003, + 0.9500000000000001 + ], + "xyz": [ + 17.773366, + 25.976457999999997, + 17.773366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.55, + 0.15000000000000008 + ], + "xyz": [ + 9.570274000000001, + 15.039002, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.55, + 0.35000000000000003 + ], + "xyz": [ + 12.304638, + 17.773366, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.55, + 0.5499999999999999 + ], + "xyz": [ + 15.039001999999998, + 20.50773, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.55, + 0.7499999999999999 + ], + "xyz": [ + 17.773365999999996, + 23.242093999999994, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95, + 0.5500000000000002, + 0.9500000000000001 + ], + "xyz": [ + 20.50773, + 25.976457999999997, + 20.50773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.75, + 0.15000000000000016 + ], + "xyz": [ + 12.304638, + 15.039002, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.75, + 0.35000000000000014 + ], + "xyz": [ + 15.039002, + 17.773366, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.75, + 0.55 + ], + "xyz": [ + 17.773366, + 20.50773, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95, + 0.7500000000000001, + 0.75 + ], + "xyz": [ + 20.50773, + 23.242093999999998, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95, + 0.7500000000000001, + 0.95 + ], + "xyz": [ + 23.242093999999998, + 25.976457999999997, + 23.242093999999998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.95, + 0.15000000000000005 + ], + "xyz": [ + 15.039002, + 15.039002, + 25.976457999999997 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.95, + 0.35 + ], + "xyz": [ + 17.773366, + 17.773366, + 25.976457999999997 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95, + 0.9500000000000001, + 0.5500000000000002 + ], + "xyz": [ + 20.50773, + 20.50773, + 25.976457999999997 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95, + 0.9500000000000001, + 0.7500000000000001 + ], + "xyz": [ + 23.242093999999998, + 23.242093999999998, + 25.976457999999997 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500000000000001, + 0.9500000000000001, + 0.9500000000000001 + ], + "xyz": [ + 25.976457999999997, + 25.976457999999997, + 25.976457999999997 + ], + "label": "Si", + "properties": {} + } + ] + }, + "supercell_smallest_dim": 16.74449142758895, + "perturbed_supercells": [ + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10044424773297675, + 0.09950121535593849, + 0.10023626935595284 + ], + "xyz": [ + 2.73077493823373, + 2.743667907146769, + 2.733618381168293 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10050564196859288, + 0.0999908018568735, + 0.30003106773738425 + ], + "xyz": [ + 5.469026997156164, + 5.476065798492372, + 2.7411512906218873 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0997099537538339, + 0.10038677518534767, + 0.4995665433682368 + ], + "xyz": [ + 8.202453779667266, + 8.193200398883468, + 2.735686460645281 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.100279222507373, + 0.10021179072485692, + 0.7001363471141373 + ], + "xyz": [ + 10.942215677869918, + 10.943137593062756, + 2.7410770445286654 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1003696115018536, + 0.1001109422302662, + 0.9001275582016001 + ], + "xyz": [ + 13.675080734974397, + 13.67861721469507, + 2.74093404412587 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10018629754522747, + 0.30015442692392574, + 0.09937225880473773 + ], + "xyz": [ + 5.462256932478855, + 2.728328661876581, + 5.473386323611858 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09942058677768296, + 0.3003961157083183, + 0.29997858741613675 + ], + "xyz": [ + 8.208214873670986, + 5.460513617726548, + 5.466221989382161 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10020974348279003, + 0.29945451511427434, + 0.4999060646420115 + ], + "xyz": [ + 10.928713961523583, + 8.204675307836823, + 5.464137803972516 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09984833591024671, + 0.2999642795762544, + 0.7005902592898597 + ], + "xyz": [ + 13.679401555560515, + 10.943452394628718, + 5.466166112660654 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10059858058696342, + 0.2997070505811901, + 0.899995792580138 + ], + "xyz": [ + 16.402121325189906, + 13.679946162953438, + 5.472906534317384 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10056776084928998, + 0.4995624806503097, + 0.09985508240803964 + ], + "xyz": [ + 8.1951290269724, + 2.740145036902424, + 8.204872638339056 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0998207789327033, + 0.5002699031662314, + 0.30041613079574553 + ], + "xyz": [ + 10.946835332842035, + 5.471966987163601, + 8.204331789333857 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09985748846314861, + 0.5005705807665299, + 0.49956517308738047 + ], + "xyz": [ + 13.673676002254968, + 8.195198732639753, + 8.208944485455703 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09994514673893229, + 0.500515310965165, + 0.6994865511453154 + ], + "xyz": [ + 16.406209458439307, + 10.929686275767814, + 8.20938729484803 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10005142950617686, + 0.49945479037020224, + 0.9000089992047828 + ], + "xyz": [ + 19.133217027587072, + 13.672646170459071, + 8.196341127030276 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10057497321702974, + 0.6996479393492786, + 0.09972180117384971 + ], + "xyz": [ + 10.928839205878916, + 2.738421446052713, + 10.940503620482305 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09942348108115474, + 0.7001742506311651, + 0.2999874230940533 + ], + "xyz": [ + 13.674030374069915, + 5.460673987920693, + 10.931956260379128 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10059125762616206, + 0.6998863874596947, + 0.4999320959400623 + ], + "xyz": [ + 16.403702337714464, + 8.210247195753777, + 10.943986277637716 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10053713226154967, + 0.699799303490753, + 0.7001052847715065 + ], + "xyz": [ + 19.139243547895724, + 10.946239010040877, + 10.942055689047047 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09982161667890585, + 0.6998916506261924, + 0.8996688539428319 + ], + "xyz": [ + 21.868903297576875, + 13.664853806055685, + 10.933535842207187 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10011565513786799, + 0.8995321959615246, + 0.10052304051929159 + ], + "xyz": [ + 13.67257518322315, + 2.7430961320594673, + 13.667005483617695 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10057439869135831, + 0.8999823501322247, + 0.299563888372024 + ], + "xyz": [ + 16.399980254507156, + 5.470618635838891, + 13.679431769701237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10060232695606068, + 0.8997454366089532, + 0.4996729483300275 + ], + "xyz": [ + 19.132596263576456, + 8.206855514161845, + 13.676574560863427 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09968716728110733, + 0.900417513008275, + 0.6995889596630137 + ], + "xyz": [ + 21.875000493196776, + 10.927559337877172, + 13.673251170073982 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.100195657610068, + 0.9004946062282089, + 0.8995716732645876 + ], + "xyz": [ + 24.610182161295203, + 13.668638989598733, + 13.681257162949429 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30041112127450165, + 0.09988238649473655, + 0.09946013988596143 + ], + "xyz": [ + 2.725375139022154, + 5.466967905758842, + 5.472740785389625 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30013598790322626, + 0.09940250481417712, + 0.3003935485531298 + ], + "xyz": [ + 5.465939678348213, + 8.210331727114736, + 5.46241835550365 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3005590014834154, + 0.10009415548536428, + 0.4996864048254551 + ], + "xyz": [ + 8.200091860068666, + 10.940811150881741, + 5.477657844508901 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29984207284423203, + 0.10050618691333424, + 0.700136662215998 + ], + "xyz": [ + 10.946244917583385, + 13.671529269571153, + 5.473489344718689 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30054025305546506, + 0.10011050687311478, + 0.8997725043659659 + ], + "xyz": [ + 13.670220550718687, + 16.410459963169465, + 5.477625072606756 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2995801218071716, + 0.30055601082502026, + 0.09979001772574511 + ], + "xyz": [ + 5.473458840060925, + 5.460116661068921, + 8.204953180843452 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29980384961490825, + 0.30056514729243294, + 0.29958199965666155 + ], + "xyz": [ + 8.205103766601567, + 8.194695441788031, + 8.208136859297724 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30024945855298185, + 0.29987430530962433, + 0.500412093061602 + ], + "xyz": [ + 10.941371586979697, + 10.946500614595298, + 8.204784077252055 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29936835621119945, + 0.30024850296728844, + 0.7002123792340137 + ], + "xyz": [ + 13.678121098497405, + 13.666087890474572, + 8.197853767653633 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29971633051337465, + 0.3004056880431327, + 0.8995631605543587 + ], + "xyz": [ + 16.405758103632152, + 16.396333331569657, + 8.204760215741228 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3002099578529094, + 0.5004640585569241, + 0.09981857192696325 + ], + "xyz": [ + 8.20695607310222, + 5.469118054015057, + 10.946671031032288 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2994321146036323, + 0.4999499483871705, + 0.30021132118393845 + ], + "xyz": [ + 10.939660848547678, + 8.198217118269225, + 10.929007676438916 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3003716707273712, + 0.499458316336343, + 0.5002959324494456 + ], + "xyz": [ + 13.668460133634518, + 10.946583350464866, + 10.935131613737429 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3006308934266021, + 0.49975097825658715, + 0.6998410072629321 + ], + "xyz": [ + 16.400605699465473, + 13.678271741285185, + 10.94267688091566 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3005525407600691, + 0.4995296533246696, + 0.9000093352844232 + ], + "xyz": [ + 19.134245135245564, + 16.413865868142608, + 10.93857974273161 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3001420109996047, + 0.7002616149713389, + 0.09937103038047043 + ], + "xyz": [ + 10.932433593373773, + 5.462070389400938, + 13.677338301622063 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29972771526741304, + 0.7006145727902098, + 0.2997180119090455 + ], + "xyz": [ + 13.676367038142972, + 8.19551408172565, + 13.676499700711968 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30040090451914947, + 0.6994218631144071, + 0.4999783444468812 + ], + "xyz": [ + 16.39798374574057, + 10.942641023598757, + 13.66939691098781 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29956126195722804, + 0.6997252496808998, + 0.7002777491488076 + ], + "xyz": [ + 19.14058899945997, + 13.66961898881972, + 13.662065315544387 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29981790316616386, + 0.7004554061886579, + 0.8995048142889193 + ], + "xyz": [ + 21.874368141529747, + 16.396924314956753, + 13.675556636303437 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30052737735375057, + 0.8996815618515407, + 0.10015402076089794 + ], + "xyz": [ + 13.66957211507239, + 5.478043952371813, + 16.409040579205683 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29944042106882135, + 0.9004032039528429, + 0.3002315880836174 + ], + "xyz": [ + 16.414862762459915, + 8.198607768170493, + 16.404046069443687 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3002568028818206, + 0.8994897111027735, + 0.5004238305375148 + ], + "xyz": [ + 19.139365956868527, + 10.946761497595137, + 16.40271838482485 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2997962318740507, + 0.900289724360601, + 0.7004074861809656 + ], + "xyz": [ + 21.8844441370264, + 13.67460519657893, + 16.407359178168033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29973811193799077, + 0.8995443497823921, + 0.9003848362675669 + ], + "xyz": [ + 24.60830784442155, + 16.407864925735705, + 16.39637394579796 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500584813812994, + 0.0999198140545025, + 0.09991977679150464 + ], + "xyz": [ + 2.732170914920257, + 8.209990671918396, + 8.209991181371395 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4995605944619482, + 0.1000901312905473, + 0.29980531684736916 + ], + "xyz": [ + 5.467298585760928, + 10.92878685355695, + 8.198316785357482 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000760969015139, + 0.09953889842625425, + 0.49984431247344363 + ], + "xyz": [ + 8.194659370442707, + 13.67073185130073, + 8.197828285422085 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5002202286070385, + 0.1000520559431625, + 0.7003364633537125 + ], + "xyz": [ + 10.9427677658934, + 16.41379499228283, + 8.206814625359128 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5002801170679617, + 0.09980028843386149, + 0.9004144450554793 + ], + "xyz": [ + 13.674755797614237, + 19.1500439283305, + 8.204191289547936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5004875789791271, + 0.30021539381819146, + 0.09969198154815147 + ], + "xyz": [ + 5.467461652681074, + 8.205546919208057, + 10.947066917549835 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4999313251805624, + 0.2995637964786778, + 0.30057843859305106 + ], + "xyz": [ + 8.205036612298363, + 10.944425398555362, + 10.930553394203232 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49946060000730647, + 0.3002402376833799, + 0.49988352052322477 + ], + "xyz": [ + 10.93914799992422, + 13.662852933951726, + 10.933365906756277 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.50049176555322, + 0.3000163309433746, + 0.6994597604035497 + ], + "xyz": [ + 13.664657215198705, + 16.405521271606283, + 10.94440260384407 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5005395893519433, + 0.3001078725000712, + 0.8995699782240167 + ], + "xyz": [ + 16.401779633086598, + 19.14204598817636, + 10.946307981897608 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5001276887215991, + 0.5001499900216869, + 0.099382810390027 + ], + "xyz": [ + 8.196704531324878, + 8.196399631964312, + 13.67561637379603 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5002131144209466, + 0.49938744380213035, + 0.3003311977703589 + ], + "xyz": [ + 10.933609318223589, + 10.944897738303334, + 13.666358903925428 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49976385045185756, + 0.5005153581612637, + 0.4995648853795778 + ], + "xyz": [ + 13.672917075246547, + 13.662642597114933, + 13.675637289901042 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003285483745252, + 0.5003349711704783, + 0.6998858559975277 + ], + "xyz": [ + 16.409203109292086, + 16.40911529798192, + 13.680891519785769 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4997678945006039, + 0.4997960861737301, + 0.8998029904934473 + ], + "xyz": [ + 19.135066648359846, + 19.134681216879365, + 13.665858822262972 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4997191912940008, + 0.7000060513743362, + 0.10059473854346575 + ], + "xyz": [ + 10.945669891614003, + 8.20738399223047, + 16.40242756721782 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49968260613766813, + 0.7004055722859999, + 0.3003205178364174 + ], + "xyz": [ + 13.681746973457464, + 10.937498710411381, + 16.40738955953627 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49963940634795817, + 0.6999078738334309, + 0.4998429544907566 + ], + "xyz": [ + 16.40277736969919, + 13.664742930561957, + 16.399994496129516 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4995917820610007, + 0.7005343864251263, + 0.7001303350927858 + ], + "xyz": [ + 19.14963595294302, + 16.40238483574548, + 16.407908952832 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4995788476494608, + 0.7000408422311708, + 0.899813567237372 + ], + "xyz": [ + 21.872921512460213, + 19.132241205698097, + 16.400984468503815 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4994456251878285, + 0.8999544160686641, + 0.10045098845321036 + ], + "xyz": [ + 13.677362617650253, + 8.201678520309827, + 19.132345472051338 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003759852371765, + 0.9002995807046059, + 0.2994676869652477 + ], + "xyz": [ + 16.403002125474057, + 10.935318714490547, + 19.149784215954178 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5001227478729324, + 0.9002222101055256, + 0.5002808694886162 + ], + "xyz": [ + 19.147426013656776, + 13.677338183915966, + 19.14526420338904 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000415876263925, + 0.8999523557585, + 0.6994877738976862 + ], + "xyz": [ + 21.867257553436037, + 16.399749515472127, + 19.14046519504844 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4998974904408591, + 0.9006202863308056, + 0.8996878090581811 + ], + "xyz": [ + 24.613488224701054, + 19.134878289396966, + 19.147626950822378 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000841888834732, + 0.09965395781260167, + 0.10056328964733707 + ], + "xyz": [ + 2.7373341681677394, + 10.946308209927102, + 10.93387598876233 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7002986881839947, + 0.10036290866669594, + 0.2998873981963562 + ], + "xyz": [ + 5.472150150376413, + 13.674364139496607, + 10.946501233055207 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6993829744184767, + 0.10032719099109944, + 0.5001959834369919 + ], + "xyz": [ + 8.210244746609467, + 16.40042758758755, + 10.93349343364995 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7001482455305685, + 0.10005805753342793, + 0.6994027006318949 + ], + "xyz": [ + 10.930083582699822, + 19.134408616762887, + 10.940276538356406 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6995959439921661, + 0.10033444459992208, + 0.9003935916690848 + ], + "xyz": [ + 13.681773580823332, + 21.8747689334442, + 10.936504285361082 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6995670272353, + 0.29982568593872694, + 0.10056126970052034 + ], + "xyz": [ + 5.4740183878477735, + 10.939210052613085, + 13.663517283826922 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6997920871842911, + 0.29951801994345884, + 0.3004485887490487 + ], + "xyz": [ + 8.202635480054397, + 13.675110478038953, + 13.662387908831313 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6997821355236475, + 0.29998310675968215, + 0.4996379593368858 + ], + "xyz": [ + 10.93227528388038, + 16.398255641316137, + 13.668610434754072 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998577030742323, + 0.3000021920278037, + 0.7005725084909405 + ], + "xyz": [ + 13.679677202046177, + 19.14642977508096, + 13.669904511053916 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.700612870706503, + 0.29989435369221, + 0.8996474380181206 + ], + "xyz": [ + 16.39991945874113, + 21.878470894027483, + 13.678754680678813 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7004572737429068, + 0.5002352130490687, + 0.0995296626344726 + ], + "xyz": [ + 8.199877422667752, + 10.937277396502983, + 16.415651554772264 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7005381689624536, + 0.500104098893072, + 0.29955996348883585 + ], + "xyz": [ + 10.932863121354213, + 13.673161649210186, + 16.41496497051253 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6994189262344227, + 0.5000969347142196, + 0.5004301568579191 + ], + "xyz": [ + 13.679026301097796, + 16.40412069120354, + 16.399564938034864 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7001314156887214, + 0.49989703784421635, + 0.7004891200170477 + ], + "xyz": [ + 16.411463480770784, + 19.149031852472845, + 16.406573011580686 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7003453308326946, + 0.5002625041515985, + 0.8999807740618253 + ], + "xyz": [ + 19.14387405594385, + 21.879370447418992, + 16.414494210494954 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7002005847736716, + 0.6997147987938876, + 0.10049498807537602 + ], + "xyz": [ + 10.940324168314936, + 10.946965746789067, + 19.139391139366627 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6994399434588889, + 0.6999086395129438, + 0.30030558490410825 + ], + "xyz": [ + 13.67474883766954, + 13.668340909583792, + 19.13164194364596 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7005590743359482, + 0.6995794854667439, + 0.49979656335407896 + ], + "xyz": [ + 16.3976534517895, + 16.411046214483264, + 19.14244236468164 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7003048540011892, + 0.7004147366071986, + 0.6995655577861072 + ], + "xyz": [ + 19.140278588492283, + 19.138776293281794, + 19.150386113271566 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.699474754737723, + 0.7002969352680136, + 0.9003832982617807 + ], + "xyz": [ + 21.88421203037731, + 21.87297132615967, + 19.13742658685423 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6996882644438628, + 0.8995994454235373, + 0.10046498076196435 + ], + "xyz": [ + 13.672700823211464, + 10.93955114086993, + 21.865173697519317 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.700055343459345, + 0.8993922813673375, + 0.3003470679734397 + ], + "xyz": [ + 16.40262043110422, + 13.677321696674973, + 21.86736002605793 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7001788937966325, + 0.9002042504046505, + 0.5002488090420778 + ], + "xyz": [ + 19.146742147204964, + 16.412031476224332, + 21.88015027855398 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7003979015636627, + 0.8997234501308489, + 0.6995566862964666 + ], + "xyz": [ + 21.865070154809697, + 19.13992713339787, + 21.876571098524053 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6995602111631443, + 0.9004006795932815, + 0.8997193305924982 + ], + "xyz": [ + 24.610916757658142, + 21.865062024565624, + 21.874377305461515 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9005954921819675, + 0.09976229290056539, + 0.09999412678271079 + ], + "xyz": [ + 2.7310338137542085, + 13.679881164353667, + 13.676711573247074 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8997216312384697, + 0.1006287753225893, + 0.29984418881549907 + ], + "xyz": [ + 5.475194280562398, + 16.40024796993025, + 13.676610695429616 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8998269718050519, + 0.10025669731911825, + 0.4994914430748192 + ], + "xyz": [ + 8.199648620800641, + 19.131229490922916, + 13.67296390920521 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8998478165231611, + 0.10040473419191076, + 0.6994761497747222 + ], + "xyz": [ + 10.93582746703269, + 21.865669388910725, + 13.675272827917333 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8996733840263553, + 0.1000118062326715, + 0.9005925037624706 + ], + "xyz": [ + 13.680082017477782, + 24.612911169989022, + 13.667515977887167 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8998192859167712, + 0.299488150103906, + 0.1003301306623186 + ], + "xyz": [ + 5.466243567345284, + 13.67386279657433, + 16.39671538993621 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994399367821356, + 0.30003964714537334, + 0.3004655527599326 + ], + "xyz": [ + 8.20999900216936, + 16.404891870031037, + 16.399068965131793 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.899855114121477, + 0.300580554720674, + 0.4999847151876429 + ], + "xyz": [ + 10.945184268437924, + 19.138358175145008, + 16.412140385989495 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8995153527327476, + 0.30003424239434845, + 0.7005394509603097 + ], + "xyz": [ + 13.67966343228008, + 21.875661266226814, + 16.400026145650532 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8996217957427698, + 0.29965515320042246, + 0.9004377910800809 + ], + "xyz": [ + 16.40745471747307, + 24.610090660316384, + 16.396298576100513 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9002466154036934, + 0.49938431275721895, + 0.10030071489789345 + ], + "xyz": [ + 8.198785754795718, + 13.67930300136384, + 19.135502116248922 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994677661986458, + 0.4999430065484297, + 0.3001011238219944 + ], + "xyz": [ + 10.93805934248097, + 16.400289941961987, + 19.13249219105892 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9003018036607293, + 0.49974028879267396, + 0.49954561163864625 + ], + "xyz": [ + 13.662056959234931, + 19.138461889438307, + 19.141123480446286 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.900288368148021, + 0.4996293749027972, + 0.6996467366610523 + ], + "xyz": [ + 16.396287127600868, + 21.874024764630782, + 19.139423397797035 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9001245289950816, + 0.4993855402270395, + 0.9001403047642346 + ], + "xyz": [ + 19.1340654380686, + 24.612896759487292, + 19.133849754592376 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8999259504779898, + 0.7005448710425694, + 0.10001135615670437 + ], + "xyz": [ + 10.945060638147574, + 13.670962867594344, + 21.88134898708121 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8997401644253199, + 0.7001118141749251, + 0.3005451900481677 + ], + "xyz": [ + 13.680802443477363, + 16.410085314997715, + 21.872888278066398 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.899565620019205, + 0.7004925733694572, + 0.49974508885503427 + ], + "xyz": [ + 16.409433275154047, + 19.131124135801, + 21.875707609534977 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994910811082424, + 0.7002157243723931, + 0.6998412490132806 + ], + "xyz": [ + 19.14132692987372, + 21.865783737602037, + 21.87090349730626 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9002004928385059, + 0.7004774019455271, + 0.8995248333096223 + ], + "xyz": [ + 21.874942560006055, + 24.6055207085385, + 21.884180055466235 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8999264507651086, + 0.8998512281244031, + 0.09961986829981954 + ], + "xyz": [ + 13.664588925514614, + 13.665617355918263, + 24.6062364657952 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9002761046571044, + 0.9004450519230331, + 0.29962134331013424 + ], + "xyz": [ + 16.40709174367672, + 16.40478192706745, + 24.619135522955453 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9001972914074405, + 0.89937472556414, + 0.500131786576435 + ], + "xyz": [ + 19.133801122813754, + 19.14504709496151, + 24.60342469307239 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.899652101238138, + 0.8996673908989266, + 0.7001508017988511 + ], + "xyz": [ + 21.87242636328933, + 21.872217325799166, + 24.599972218989357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9005662761872006, + 0.8995436670108305, + 0.8999494887202126 + ], + "xyz": [ + 24.60234651638679, + 24.61632744497647, + 24.610779123613703 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15042210323873015, + 0.14978597182565462, + 0.14951559078135002 + ], + "xyz": [ + 4.091997089681698, + 4.100694163857612, + 4.104390764826757 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1506140688722234, + 0.14968533518763535, + 0.34976640476420034 + ], + "xyz": [ + 6.828414287308306, + 6.84111176707193, + 4.105639398413658 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15007974098388668, + 0.14940676808458084, + 0.5504065334177525 + ], + "xyz": [ + 9.56772149174563, + 9.576922256089818, + 4.094525644412455 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14962275838415906, + 0.14984507889908547, + 0.7506030395877652 + ], + "xyz": [ + 12.310764595290893, + 12.307725069228512, + 4.094270367125808 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14978839807927335, + 0.15017539486044262, + 0.9504970596105683 + ], + "xyz": [ + 15.048195676485856, + 15.042904726153129, + 4.101050983589068 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14971281682243556, + 0.34981096792697236, + 0.14984862445818284 + ], + "xyz": [ + 6.831256008363211, + 4.095550104129184, + 6.829399270812649 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.150597200936992, + 0.3497834202659105, + 0.3496379336576334 + ], + "xyz": [ + 9.562362854998986, + 6.83912471785349, + 6.841113784574266 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1501933580259242, + 0.35020017488346594, + 0.54936728591431 + ], + "xyz": [ + 12.298724401884249, + 9.564267203034973, + 6.8412903111012575 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15010406384459776, + 0.34974281971959537, + 0.750548945113175 + ], + "xyz": [ + 15.042990956275965, + 12.313565820929057, + 6.833816619650606 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1502921436219815, + 0.3493735069615719, + 0.9501421160741418 + ], + "xyz": [ + 17.76674368533213, + 15.04493912039865, + 6.831338834961237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15021196581680338, + 0.5499263015911742, + 0.1504182430283629 + ], + "xyz": [ + 9.574984552020279, + 4.110162101893521, + 9.572164367113734 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15046245156879057, + 0.5498289850414821, + 0.35020742248907283 + ], + "xyz": [ + 12.305135757204392, + 6.845068397541777, + 9.574258468877057 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15057087382519105, + 0.5497866629742054, + 0.5495979983510286 + ], + "xyz": [ + 15.030589200399561, + 9.572582789996282, + 9.575162178764725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15011923807214375, + 0.5501893801006544, + 0.7503132841828125 + ], + "xyz": [ + 17.780238335603986, + 12.310551366415755, + 9.574493372107225 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14999638523162256, + 0.5498907249437072, + 0.950564709557354 + ], + "xyz": [ + 20.513956618520297, + 15.046673186957824, + 9.568730590637275 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500748006416289, + 0.7494074508992935, + 0.15011012821562333 + ], + "xyz": [ + 12.298042428494902, + 4.104074314049158, + 12.297559436262212 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14961412219494155, + 0.7499088837777116, + 0.3498751606942508 + ], + "xyz": [ + 15.036049494892664, + 6.828927567590116, + 12.298116623517037 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14969210102629002, + 0.7506244039769864, + 0.5498522889984753 + ], + "xyz": [ + 17.779883260555774, + 9.564044982428385, + 12.308965199433894 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14976494798317097, + 0.7496854314441275, + 0.7506137408438099 + ], + "xyz": [ + 20.511820229669667, + 12.309815365478492, + 12.297123686461726 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14986599234694137, + 0.7494626933810968, + 0.950296900331283 + ], + "xyz": [ + 23.238807208508785, + 15.041229039376, + 12.295459912110307 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1505708968592921, + 0.9499372810384431, + 0.1499408633267349 + ], + "xyz": [ + 15.037336011694727, + 4.108542693146527, + 15.045949716745813 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15034091926064136, + 0.949425215605673, + 0.3502916359824814 + ], + "xyz": [ + 17.769494845879958, + 6.844558181424031, + 15.035804637987972 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14951675903512834, + 0.950146815888585, + 0.5498340535877634 + ], + "xyz": [ + 20.507468450924126, + 9.561398427033902, + 15.03440245691352 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14971186997734845, + 0.9495710947566578, + 0.7502845458294928 + ], + "xyz": [ + 23.24012034407854, + 12.304588997556287, + 15.02919882290968 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14978609044159513, + 0.9495138453806673, + 0.9504126560456881 + ], + "xyz": [ + 25.97545314073087, + 15.041719226199767, + 15.029430848573522 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3496921857962323, + 0.14987129796896204, + 0.14981303900937148 + ], + "xyz": [ + 4.097230311987119, + 6.829145522601749, + 6.829942028610659 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34948588827510374, + 0.15024939467876977, + 0.3504268461550253 + ], + "xyz": [ + 6.845155442956296, + 9.569080920836527, + 6.832290836194426 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34988710010809004, + 0.1495827169795978, + 0.549942931872624 + ], + "xyz": [ + 9.563788756490782, + 12.302314227834565, + 6.828661434655792 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35035010487923285, + 0.1499507969087986, + 0.7494225088585722 + ], + "xyz": [ + 12.296069949256454, + 15.035893215952797, + 6.840023875083643 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3495186690583163, + 0.14985732043352723, + 0.9505220773467403 + ], + "xyz": [ + 15.044189058160216, + 17.77392307751558, + 6.827378640654375 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3495791975069369, + 0.3504985397124701, + 0.150191732711594 + ], + "xyz": [ + 6.845347280332767, + 6.832778199180314, + 9.571336809271031 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34968400872050753, + 0.35027938847183315, + 0.3504404469769522 + ], + "xyz": [ + 9.58011546068541, + 9.571975535893642, + 9.569773573002186 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34956649312683336, + 0.3497563152988614, + 0.5501677341433006 + ], + "xyz": [ + 12.303599617644338, + 12.30100440307636, + 9.561015558690581 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3506119574922189, + 0.3498163219441523, + 0.7496534767080699 + ], + "xyz": [ + 15.031753182609423, + 15.042630968608192, + 9.576129359363767 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3496295196249096, + 0.3501472896859863, + 0.9505306031354763 + ], + "xyz": [ + 17.782634028634327, + 17.775555169557897, + 9.567222577072892 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3494530772637272, + 0.5502675696579582, + 0.15038993139624576 + ], + "xyz": [ + 9.579263236062886, + 6.833763642657591, + 12.300818734996836 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500245231454986, + 0.5494240691017354, + 0.35043487205841095 + ], + "xyz": [ + 12.302709468932111, + 9.576554768536713, + 12.297099252457576 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34995235843072975, + 0.5503277841024462, + 0.5494205883169351 + ], + "xyz": [ + 15.035561793010743, + 12.296065040803658, + 12.308468058287925 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3499503443191883, + 0.5494373132037206, + 0.7504253943225467 + ], + "xyz": [ + 17.77148896201177, + 15.044139031076844, + 12.296266163874854 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3498501967958452, + 0.5496943445386383, + 0.9506248467590028 + ], + "xyz": [ + 20.512093925966912, + 17.77986070997404, + 12.298411051107617 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35042499937346533, + 0.7500491895628694, + 0.15010896940258078 + ], + "xyz": [ + 12.30680032090702, + 6.8432103249917215, + 15.045485025783558 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3505004410902633, + 0.7500938848647235, + 0.3494802109498497 + ], + "xyz": [ + 15.033179114639596, + 9.570009478175056, + 15.047127517477906 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3497117379295541, + 0.7495661617655786, + 0.5503225339257362 + ], + "xyz": [ + 17.77184426752643, + 12.305106558636593, + 15.029129574609907 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34940040369829684, + 0.7502943973147905, + 0.7500072837257155 + ], + "xyz": [ + 20.51185452888321, + 15.030904009077357, + 15.034829374386746 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3497943890225249, + 0.7498502929716768, + 0.9506288676843744 + ], + "xyz": [ + 23.24864499824061, + 17.779152689510518, + 15.034144156181965 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500027985656835, + 0.9505320160130325, + 0.14949921547033124 + ], + "xyz": [ + 15.03942899121888, + 6.829101625537866, + 17.780677888653578 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3497208423086766, + 0.950205656362017, + 0.3495828413780558 + ], + "xyz": [ + 17.770474379172683, + 9.560754088701941, + 17.77236110305596 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3504724473307376, + 0.9494448340713934, + 0.5500325505628408 + ], + "xyz": [ + 20.500584896790013, + 12.311542240301383, + 17.77223508621928 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35001648489599535, + 0.9497975915471489, + 0.7505810536455024 + ], + "xyz": [ + 23.24727076891779, + 15.047171439382419, + 17.770824086596907 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35003475010527335, + 0.9496377382787126, + 0.9497460723120155 + ], + "xyz": [ + 25.968033569310524, + 17.770369443541135, + 17.768888320137943 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5505397577224826, + 0.14967999785840858, + 0.15013209951450007 + ], + "xyz": [ + 4.09897702910488, + 9.579459511209725, + 9.57327845874594 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5505826608727189, + 0.14962209995330403, + 0.34977167034391926 + ], + "xyz": [ + 6.827621736624983, + 12.309482352614257, + 9.573073453156436 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502281874582624, + 0.14978919826031936, + 0.5504594599140219 + ], + "xyz": [ + 9.573673609801121, + 15.048403391097342, + 9.57051169441502 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5494771786691306, + 0.14994598005902088, + 0.7505033146039612 + ], + "xyz": [ + 12.31078067575925, + 17.77309930754092, + 9.562387529962715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5498212670216157, + 0.15053166560810172, + 0.9495423775518929 + ], + "xyz": [ + 15.040014304755676, + 20.499029863152984, + 9.575099231385623 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497955659732778, + 0.35063332713560025, + 0.14979332770101914 + ], + "xyz": [ + 6.841743148128389, + 9.564653428314125, + 12.310501749383821 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5495516153133678, + 0.3498044293762257, + 0.3505321634569318 + ], + "xyz": [ + 9.574875836628218, + 12.305783408267356, + 12.295833958908077 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5501592538624943, + 0.3503214296782636, + 0.5493783546133776 + ], + "xyz": [ + 12.300533504874144, + 15.032680266312592, + 12.311209818846203 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5495412840066359, + 0.349786826091617, + 0.7504993624555483 + ], + "xyz": [ + 15.042914718302903, + 17.773921711114617, + 12.295452042203495 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5494151344356935, + 0.3503680219287741, + 0.9499780883800363 + ], + "xyz": [ + 17.7780979578422, + 20.499434251556547, + 12.301673352846853 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502169101375576, + 0.5501626543816337, + 0.1502514948595328 + ], + "xyz": [ + 9.575936173878363, + 9.576677948807319, + 15.044191337784769 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5505910599752656, + 0.549814713672412, + 0.34998283207040765 + ], + "xyz": [ + 12.301870081837595, + 12.312484148747876, + 15.04454966427179 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497237342817011, + 0.5497283568984673, + 0.5506165746810211 + ], + "xyz": [ + 15.04371784246708, + 15.043654642882723, + 15.031511089238847 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5501829750607, + 0.5504519527364959, + 0.7494638076661262 + ], + "xyz": [ + 17.772214291387776, + 17.768536877020274, + 15.047682618556259 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5494138843189151, + 0.5499717540316013, + 0.9503383458288641 + ], + "xyz": [ + 20.511969629474304, + 20.50434253517901, + 15.030602558113355 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5495681418523163, + 0.7498528500743469, + 0.15057164967694264 + ], + "xyz": [ + 12.310441684189673, + 9.572185204625551, + 17.76544990584279 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500785264449303, + 0.7496741921286618, + 0.3505664165232842 + ], + "xyz": [ + 15.042291558179848, + 12.313455544171692, + 17.769985212848805 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5503033565405245, + 0.750294524402757, + 0.5499989617218883 + ], + "xyz": [ + 17.777378489468646, + 15.04313524086642, + 17.781540120637974 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.549646644014137, + 0.7502796654503188, + 0.7504425568002219 + ], + "xyz": [ + 20.517604092609385, + 17.774585537477765, + 17.772358516262333 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5499268083500655, + 0.7497923111407279, + 0.9496676541246387 + ], + "xyz": [ + 23.23471074231434, + 20.502185563950906, + 17.769525852236615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5506054105193703, + 0.9497771644590788, + 0.14995976329223223 + ], + "xyz": [ + 15.035405323568927, + 9.578000954620942, + 20.512960496241856 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5504111873395253, + 0.949606816301636, + 0.349666066228779 + ], + "xyz": [ + 17.763424980836977, + 12.305694196880212, + 20.5079761425413 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5504813515488193, + 0.9496780948673169, + 0.5502260203541529 + ], + "xyz": [ + 20.506419080567195, + 15.048673061330492, + 20.50990992270106 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497307068332249, + 0.9506303049825446, + 0.7498160218283128 + ], + "xyz": [ + 23.248196099819214, + 17.76716895584938, + 20.51266568856307 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502300350253433, + 0.9494142701988573, + 0.9499832488782836 + ], + "xyz": [ + 25.96822098926923, + 20.51064597913928, + 20.502867005050327 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503830238263989, + 0.1498350541673517, + 0.1494802916260643 + ], + "xyz": [ + 4.092185530925341, + 12.302769273469293, + 12.307619523076518 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.749381972462253, + 0.15018236175866892, + 0.35010630738681026 + ], + "xyz": [ + 6.839856632596544, + 15.032005854206018, + 12.298681655888283 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7497432417804133, + 0.14988649184291852, + 0.5506253800393119 + ], + "xyz": [ + 9.577272220236916, + 17.778405731167354, + 12.299575784746139 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7504552018732191, + 0.14981591616443582, + 0.7495058716291517 + ], + "xyz": [ + 12.295365604792124, + 20.50719780393118, + 12.30834467700957 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7502552455868761, + 0.14944607480835576, + 0.9499060253157866 + ], + "xyz": [ + 15.030144029519251, + 23.244298866752438, + 12.300554506205938 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7501661540239376, + 0.34938452721205343, + 0.1503422061200874 + ], + "xyz": [ + 6.832173947305029, + 12.311588208384283, + 15.032858994735845 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7494650068310825, + 0.35046391046109515, + 0.3499109719413161 + ], + "xyz": [ + 9.575399324726932, + 15.030470494100053, + 15.038030170013538 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7501674379042896, + 0.3504175821139314, + 0.549423361872817 + ], + "xyz": [ + 12.302463414816906, + 17.76777148820864, + 15.047000288385513 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7496477522204014, + 0.35017374729595757, + 0.7505163299926119 + ], + "xyz": [ + 15.048436612475408, + 20.509973302481516, + 15.036561573517744 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7494196843733278, + 0.3499709987503982, + 0.950381311006887 + ], + "xyz": [ + 17.778182715585846, + 23.239373244659127, + 15.03067152934462 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7504520801422705, + 0.5494310571566712, + 0.15005167857233215 + ], + "xyz": [ + 9.563202055994502, + 12.311525298469478, + 17.771768274186414 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7496064917806805, + 0.5500107716126108, + 0.3497997156140245 + ], + "xyz": [ + 12.302047015474855, + 15.030883774383074, + 17.768133294005665 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7498672127612339, + 0.5498380587909178, + 0.5496742351588042 + ], + "xyz": [ + 15.032334170667689, + 17.767096758502134, + 17.769336525712138 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7496737766672685, + 0.5503140525750956, + 0.7495999651299553 + ], + "xyz": [ + 17.772190465540266, + 20.49780072857812, + 17.77319960359234 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7497826764341772, + 0.5496457387022854, + 0.9499704300750634 + ], + "xyz": [ + 20.50248232861353, + 23.238718516635164, + 17.76555139463099 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7505616929553238, + 0.7495822991440914, + 0.15005963262508 + ], + "xyz": [ + 12.29974255560039, + 12.313132651496675, + 20.509698634064623 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7497646229584464, + 0.7498859880399692, + 0.3506250025306742 + ], + "xyz": [ + 15.04598817110353, + 15.044328889554667, + 20.502953216460355 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500125074466053, + 0.7500239909907651, + 0.5504982747341297 + ], + "xyz": [ + 17.78050632298293, + 17.780349322034215, + 20.508229000066006 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7502805587727536, + 0.7495655167221776, + 0.7504344931876857 + ], + "xyz": [ + 20.507730135485865, + 20.51750606169377, + 20.505625571873107 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7495854121350437, + 0.7502173792513237, + 0.9504835780748617 + ], + "xyz": [ + 23.251677362391284, + 23.243037221731587, + 20.505033799331965 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7497332549652487, + 0.9501568532417347, + 0.1505203479288383 + ], + "xyz": [ + 15.048260572507862, + 12.308105213119434, + 23.240591579186397 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503031492601452, + 0.9497095597701021, + 0.3495701739399693 + ], + "xyz": [ + 17.763518648932024, + 15.037270097593789, + 23.242267755573913 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499917652119588, + 0.9503127652477081, + 0.550289737455196 + ], + "xyz": [ + 20.515967308503615, + 17.777214653794857, + 23.24625748562908 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.749629186669248, + 0.9497724836158393, + 0.7505878918948878 + ], + "xyz": [ + 23.247020989115068, + 20.510697859054723, + 23.23391374383706 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7501565746989015, + 0.9499963040550211, + 0.9494241725943271 + ], + "xyz": [ + 25.96853486106409, + 23.236362052458507, + 23.24418413080545 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.950087544689142, + 0.1498571052155727, + 0.14952499361226382 + ], + "xyz": [ + 4.093098166396391, + 15.033704693399924, + 15.038245263460274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499027559141917, + 0.1499483221063097, + 0.34956860717461274 + ], + "xyz": [ + 6.8293055440815005, + 17.766138571304776, + 15.036965965502251 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9498285606309016, + 0.15007216668736426, + 0.5505473636953371 + ], + "xyz": [ + 9.578744107876823, + 20.512869569721953, + 15.037644761764412 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9505607988553477, + 0.15008136905106786, + 0.7497409078641584 + ], + "xyz": [ + 12.302208201975127, + 23.246218879961877, + 15.047781604026289 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9497010563328833, + 0.14978773601295942, + 0.949888246977171 + ], + "xyz": [ + 15.034572097764123, + 25.970843028780465, + 15.032012860969738 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499650865540646, + 0.3497524255778734, + 0.15060631399245622 + ], + "xyz": [ + 6.840814622832423, + 15.046814085419934, + 17.76950387671567 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494470418944783, + 0.3501617822145749, + 0.3499440460809233 + ], + "xyz": [ + 9.571720865406956, + 17.765041064403853, + 17.768017913630633 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9504000966725064, + 0.3494065508990719, + 0.5500517301579033 + ], + "xyz": [ + 12.297231716120374, + 20.51390729509653, + 17.770722520402053 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.949415129551158, + 0.35028558311616936, + 0.7503320915322709 + ], + "xyz": [ + 15.047446736612036, + 23.23863805215284, + 17.769274197459417 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499317785348487, + 0.35060145714708923, + 0.9498483104957219 + ], + "xyz": [ + 17.779515142254336, + 25.973451416809933, + 17.78065630226103 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95051326129256, + 0.5497972986859964, + 0.1495428563558982 + ], + "xyz": [ + 9.561252718504875, + 15.039769230388542, + 20.511975920126023 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9498848650274694, + 0.5497302790634522, + 0.3497594559123715 + ], + "xyz": [ + 12.297661748437164, + 17.768503219911732, + 20.502468319285143 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9498047431767288, + 0.5495075743228096, + 0.5502491571064272 + ], + "xyz": [ + 15.035676075888867, + 20.508466914969254, + 20.498328128636537 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95060382260144, + 0.5499434790573153, + 0.7498196930393999 + ], + "xyz": [ + 17.770128131535312, + 23.247884229608747, + 20.515212609764202 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501456853846788, + 0.5505324553422146, + 0.9496736125776393 + ], + "xyz": [ + 20.510547323508014, + 25.973987474267176, + 20.517001417952756 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9495900362538815, + 0.7498116130698234, + 0.15057523727411698 + ], + "xyz": [ + 12.30992694826929, + 15.04126158992556, + 23.23391345725681 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9495138493611717, + 0.7500593314510657, + 0.34989400226362244 + ], + "xyz": [ + 15.038363986947147, + 17.765270254000892, + 23.23625860489236 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501391213608726, + 0.7501329594755108, + 0.5493838840182018 + ], + "xyz": [ + 17.766760371214207, + 20.501208615401733, + 23.24581384022048 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9503482385820997, + 0.750381092626035, + 0.7495997791275049 + ], + "xyz": [ + 20.50746848205748, + 23.241383307482526, + 23.252065284998 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494300140091391, + 0.7503864064826684, + 0.9502400249421362 + ], + "xyz": [ + 23.25065845768227, + 25.971946831934822, + 23.2395841340083 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500604203088545, + 0.949595423623524, + 0.1497793709534562 + ], + "xyz": [ + 15.030454303993448, + 15.036811654975883, + 25.971752760191567 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494970854523178, + 0.9503717498587122, + 0.3503256486552092 + ], + "xyz": [ + 17.7829007069506, + 17.77094245262597, + 25.974664739982043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9498865287382269, + 0.9494594583427363, + 0.5504166295588485 + ], + "xyz": [ + 20.50603589609464, + 20.511874725669117, + 25.96751645309325 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499679418167245, + 0.9498402806685534, + 0.7505908962118291 + ], + "xyz": [ + 23.24798897269675, + 23.249734332935535, + 25.97383605233867 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500626102245209, + 0.9504897585934476, + 0.9494605164418677 + ], + "xyz": [ + 25.975778169233323, + 25.969938273620063, + 25.984009887052874 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10052830177693867, + 0.09881302875637897, + 0.09998652137006833 + ], + "xyz": [ + 2.7179516654097644, + 2.741402569397713, + 2.7253587896120224 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10077043629691967, + 0.09991593668529435, + 0.30046420919073036 + ], + "xyz": [ + 5.4739252859907515, + 5.485607850870963, + 2.743747967865693 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.098817289903781, + 0.10035523644109169, + 0.5007829358336594 + ], + "xyz": [ + 8.218652886469387, + 8.197626358241651, + 2.723050929132357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09987314393270684, + 0.10085043081882797, + 0.7003928194715365 + ], + "xyz": [ + 10.95445349418481, + 10.9410922037894, + 2.7442565837595283 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09938618538148614, + 0.09940949421014564, + 0.9000150874058076 + ], + "xyz": [ + 13.66395298342862, + 13.663634309318777, + 2.7178987481544628 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10030544516989624, + 0.3003084006368565, + 0.10063200126717377 + ], + "xyz": [ + 5.481585005559558, + 2.747180598947262, + 5.477120389377678 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10098243473957959, + 0.30027119074256275, + 0.2997703379713944 + ], + "xyz": [ + 8.203659773102054, + 5.479019773005348, + 5.4858673419392625 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10048071003399955, + 0.30052354510738116, + 0.49874603387376687 + ], + "xyz": [ + 10.927469815306038, + 8.192520181893078, + 5.482457995527032 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10066275530917572, + 0.2993845319682931, + 0.6991637049302243 + ], + "xyz": [ + 13.651971756193888, + 10.935083395630233, + 5.469374503145843 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09982638599932875, + 0.2989614833766074, + 0.90022091643513 + ], + "xyz": [ + 16.395005917394105, + 13.67246671036948, + 5.4521559682913106 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1006401591428181, + 0.4998209914524267, + 0.10066155432131249 + ], + "xyz": [ + 8.209689278960322, + 2.7521607921731697, + 8.209396767931079 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09885065361846945, + 0.5007965938548298, + 0.3004235525072634 + ], + "xyz": [ + 10.95413762143619, + 5.458805076793916, + 8.198269230950402 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10050230239356801, + 0.5003018463297237, + 0.5004561860160976 + ], + "xyz": [ + 13.682183681786245, + 8.216196281009035, + 8.214086176598073 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09986414544378752, + 0.4989813184750829, + 0.700120473257878 + ], + "xyz": [ + 16.39390385825053, + 10.937245709657804, + 8.18730739051529 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10093036877233559, + 0.49939952601370907, + 0.8991795383461616 + ], + "xyz": [ + 19.121121223696566, + 13.673322630340811, + 8.20760226213374 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10052148083094348, + 0.7008785824359245, + 0.09954083171846301 + ], + "xyz": [ + 10.943190154824237, + 2.7352159259592264, + 10.95659741297323 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10107862096578954, + 0.7002186540501839, + 0.29914246751491985 + ], + "xyz": [ + 13.663085369036216, + 5.471750681912332, + 10.955192110508884 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10001634249218543, + 0.7002209433223564, + 0.5008969192351682 + ], + "xyz": [ + 16.421467215671214, + 8.215577949949267, + 10.940700128944968 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09913148238012733, + 0.6995517325863734, + 0.7010569776993478 + ], + "xyz": [ + 19.148870177458527, + 10.94003259228377, + 10.919453152043303 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10012954240203811, + 0.7008180439943087, + 0.8988173235116703 + ], + "xyz": [ + 21.869926810175592, + 13.657421740336355, + 10.950411230645301 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09992719036077297, + 0.9006683104828712, + 0.09883313581534925 + ], + "xyz": [ + 13.665003863528936, + 2.717415402621231, + 13.67996158034415 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10008224859763504, + 0.8989545260072725, + 0.30101840220740483 + ], + "xyz": [ + 16.405813879423988, + 5.48377589968936, + 13.658650955778866 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09966542445991518, + 0.8999826710495628, + 0.4991845369013776 + ], + "xyz": [ + 19.129162217007824, + 8.18736887873855, + 13.66700882514839 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09893476716495084, + 0.900341796085397, + 0.7009215140141953 + ], + "xyz": [ + 21.892183748285806, + 10.935491102150673, + 13.661929302977368 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10123399460352701, + 0.8994001329823215, + 0.8995151175252382 + ], + "xyz": [ + 24.59444550019426, + 13.682061726184292, + 13.680489678210753 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30081487061324164, + 0.0998015916093993, + 0.10048125460615312 + ], + "xyz": [ + 2.7382310225467137, + 5.486448390697024, + 5.477156160544746 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2992541959857871, + 0.1001046828765001, + 0.3011473821787236 + ], + "xyz": [ + 5.485846008063308, + 8.20858230438112, + 5.459962707206994 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3006983733999176, + 0.10070284644174093, + 0.49959649375571935 + ], + "xyz": [ + 8.207184525298441, + 10.94148737067578, + 5.487885225455583 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30051590517722426, + 0.09982405494298464, + 0.700774759846247 + ], + "xyz": [ + 10.945642888011712, + 13.689465739881195, + 5.473375873570674 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2989333555829914, + 0.10082949906753927, + 0.9004967593113142 + ], + "xyz": [ + 13.689952365829175, + 16.398392633414264, + 5.465485791468217 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2989110125309208, + 0.3008471946362217, + 0.09979910153495816 + ], + "xyz": [ + 5.47756404491906, + 5.451092911688164, + 8.199786251911881 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2987840584367269, + 0.30022982929081093, + 0.30024564540203963 + ], + "xyz": [ + 8.209592604415208, + 8.189826285536924, + 8.189610050511105 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2990921066459992, + 0.29979169343535955, + 0.4999882951060385 + ], + "xyz": [ + 10.934448042940055, + 10.924883418281542, + 8.187831515628321 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29955307867059916, + 0.2996130134809082, + 0.6995676101047525 + ], + "xyz": [ + 13.660617633150906, + 13.659798215212628, + 8.191690961998821 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30071395980796733, + 0.29951144482014047, + 0.9007137781284249 + ], + "xyz": [ + 16.409263207612653, + 16.425703776073522, + 8.206173691502656 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3007575872690739, + 0.4998070300269481, + 0.10054515615840091 + ], + "xyz": [ + 8.207907026132577, + 5.486538873646618, + 10.945175346040099 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3000719831170561, + 0.5007299823194648, + 0.3003991229626929 + ], + "xyz": [ + 10.952892924178707, + 8.209532877523232, + 10.948420327094333 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.299458019486551, + 0.49913640612509724, + 0.5004654990785623 + ], + "xyz": [ + 13.666377319601494, + 10.936410359588885, + 10.918239239965843 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30035687663271676, + 0.49965196551778485, + 0.700968060342141 + ], + "xyz": [ + 16.41466088195225, + 13.689934299831599, + 10.937576888290069 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2988475154937022, + 0.5001289060808708, + 0.9008800788585798 + ], + "xyz": [ + 19.154342660474878, + 16.402459719017415, + 10.923461820011678 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2987790548362602, + 0.7003319125911039, + 0.10071275658842617 + ], + "xyz": [ + 10.951738528982082, + 5.461780137272255, + 13.659665306692784 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30090354515377904, + 0.6988877517640998, + 0.2999244908080997 + ], + "xyz": [ + 13.655581194243446, + 8.214412758624333, + 13.668966649027793 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30093185595880917, + 0.6994228454376024, + 0.49916098519487423 + ], + "xyz": [ + 16.386822387317704, + 10.938725307541752, + 13.676669413645486 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3003922990021061, + 0.6987744722468388, + 0.7001548736819658 + ], + "xyz": [ + 19.125910210256347, + 13.679300846445546, + 13.660428246496748 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3012321130162959, + 0.6998575770990445, + 0.899392428566024 + ], + "xyz": [ + 21.864658212451793, + 16.41472262009599, + 13.686718047112711 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3011812225838559, + 0.899749165244155, + 0.09918199408553202 + ], + "xyz": [ + 13.657207002746802, + 5.47369383292487, + 16.418904094914755 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30073593007194727, + 0.8988955235946346, + 0.30057835046699644 + ], + "xyz": [ + 16.398990900873287, + 8.22106060695794, + 16.401145300867846 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29950313473470647, + 0.899066895610956, + 0.5007138145549109 + ], + "xyz": [ + 19.1375499088599, + 10.940422091636776, + 16.38663371228043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2999666324313198, + 0.9009838025171638, + 0.6989250641940057 + ], + "xyz": [ + 21.873666042079098, + 13.656667475756056, + 16.419178175537375 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3001075240598181, + 0.900372164286136, + 0.8987919486942231 + ], + "xyz": [ + 24.59784790312713, + 16.391137789588154, + 16.41274221272198 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5006277300560018, + 0.09983167717161844, + 0.09887250377656635 + ], + "xyz": [ + 2.7166477951710117, + 8.196259286916781, + 8.209372932922722 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5009320742065669, + 0.09912698115256997, + 0.3004741092113113 + ], + "xyz": [ + 5.463274179258718, + 10.956681086576214, + 8.203899394240155 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5010627572240084, + 0.09921301343653194, + 0.4994419107067084 + ], + "xyz": [ + 8.184702365000035, + 13.678719729108531, + 8.206862286832187 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49961689321964503, + 0.09994079579412847, + 0.6992485628778495 + ], + "xyz": [ + 10.92637305767872, + 16.390672719982845, + 8.197044803812288 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5006202646503626, + 0.09878048278647673, + 0.9000893099125666 + ], + "xyz": [ + 13.656368009218633, + 19.150249175700946, + 8.194899126821928 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49916363148563975, + 0.3007516360333171, + 0.09938209757441627 + ], + "xyz": [ + 5.47055638181288, + 8.183209469477854, + 10.936297552771023 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49998387223668833, + 0.300787886694624, + 0.300395509287015 + ], + "xyz": [ + 8.21927117684969, + 10.942642835903396, + 10.948007349192293 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49975262975431195, + 0.299876926592273, + 0.4991864688828753 + ], + "xyz": [ + 10.92465091152504, + 13.657315547529867, + 10.932391361050366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4995690408175911, + 0.3012489045079986, + 0.6997641785328665 + ], + "xyz": [ + 13.68567068897976, + 16.397067894979973, + 10.948638801261303 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49963041915537476, + 0.300826421924488, + 0.8989918188705821 + ], + "xyz": [ + 16.403699020866853, + 19.121711486288035, + 10.943701849012488 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5009562992118315, + 0.5001801053326759, + 0.0989086751416587 + ], + "xyz": [ + 8.190633970664615, + 8.201245953665534, + 13.687356718379686 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5007379979155997, + 0.500068284817161, + 0.29880136552375386 + ], + "xyz": [ + 10.922002062923927, + 10.93115825985742, + 13.68284335239141 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5011269299286538, + 0.4992353406364413, + 0.5001502808081949 + ], + "xyz": [ + 13.663420326979205, + 13.689281795296262, + 13.676772897957278 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5007311687616451, + 0.49969464597841845, + 0.6989440444981817 + ], + "xyz": [ + 16.387572421231788, + 16.401743574149965, + 13.677641662479495 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4994221799471725, + 0.5002377422041491, + 0.8992503258176364 + ], + "xyz": [ + 19.133548958141606, + 19.122398737765426, + 13.66717051686688 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003378961331093, + 0.7005999819557714, + 0.09874811509564227 + ], + "xyz": [ + 10.928543300229457, + 8.19059611003747, + 16.41900650041312 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4988940897976621, + 0.7009294250309738, + 0.30022522153708564 + ], + "xyz": [ + 13.687606120042124, + 10.92541538309263, + 16.403771126504438 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5004708495301587, + 0.6987502811615831, + 0.5002264115221384 + ], + "xyz": [ + 16.392193526567155, + 13.681352827600016, + 16.39553543901397 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49944050661502204, + 0.6991628123386849, + 0.7009728339086014 + ], + "xyz": [ + 19.142402531076574, + 16.411835117237683, + 16.387088828137667 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4992443558402678, + 0.7002071834651412, + 0.899444881028002 + ], + "xyz": [ + 21.87015508837864, + 19.122627482400347, + 16.398685544106474 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500202616356544, + 0.8988400019926642, + 0.10009461423124563 + ], + "xyz": [ + 13.657254264782374, + 8.207155683094753, + 19.12745885039907 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003751221693832, + 0.9009735468587945, + 0.2995921275244205 + ], + "xyz": [ + 16.413917798345924, + 10.937008243708737, + 19.158986760192818 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4996759699559824, + 0.9001239410455342, + 0.5010999428896038 + ], + "xyz": [ + 19.157280720862094, + 13.68242814076054, + 19.13781241922875 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5001086550099517, + 0.8988412877985364, + 0.7008672553540725 + ], + "xyz": [ + 21.870927254444698, + 16.41952647083307, + 19.12619180708794 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5004543309681019, + 0.9009464834944826, + 0.8994677891193669 + ], + "xyz": [ + 24.614939860607475, + 19.139483239854254, + 19.15969968318585 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998323443492892, + 0.100077259987353, + 0.1010703331952062 + ], + "xyz": [ + 2.750053687425176, + 10.949797244906382, + 10.93622012676179 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998590733108581, + 0.09889634090653707, + 0.3008748276676397 + ], + "xyz": [ + 5.4655994579358005, + 13.681853762075843, + 10.920440247205667 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7008773200528693, + 0.10047586418003662, + 0.4989855637916603 + ], + "xyz": [ + 8.195728740172004, + 16.404309372603315, + 10.955956491259126 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6991055639317901, + 0.10038601462383534, + 0.6995256165671645 + ], + "xyz": [ + 10.936247837549734, + 19.121833746169216, + 10.930504953528372 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7011091497739558, + 0.09999555208503977, + 0.8998346582010787 + ], + "xyz": [ + 13.669498665593958, + 21.887815572749233, + 10.952559284969851 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6996941555360534, + 0.3011067668633055, + 0.10009991674108691 + ], + "xyz": [ + 5.485225561036204, + 10.93464059324005, + 13.682770066878001 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6992781215737248, + 0.2993765664261445, + 0.3010759289633093 + ], + "xyz": [ + 8.209278435515442, + 13.676660515213232, + 13.653427136490373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.700653041770924, + 0.29897510166491387, + 0.5007308821489165 + ], + "xyz": [ + 10.933436263625602, + 16.42510475872575, + 13.666736043988957 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6994353902690021, + 0.3003221114606961, + 0.6992025474450069 + ], + "xyz": [ + 13.665321222120166, + 19.121926129597142, + 13.668504607298122 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7004474202147437, + 0.3009038685644314, + 0.8996482493624792 + ], + "xyz": [ + 16.413732456915493, + 21.876219977239266, + 13.690294576956902 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6988147021736075, + 0.5000921899659061, + 0.10029249103099049 + ], + "xyz": [ + 8.20835128934699, + 10.925249706198485, + 16.391239226090843 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.700055504910029, + 0.5007841948260816, + 0.29881550050818095 + ], + "xyz": [ + 10.931983106664877, + 13.65638458929679, + 16.41766422364615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6988812754444798, + 0.5001870185248158, + 0.5000079176408874 + ], + "xyz": [ + 13.674485132168984, + 16.390997247808382, + 16.393445882855293 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6988484753395199, + 0.5002695412059057, + 0.7008607293390757 + ], + "xyz": [ + 16.421636855442287, + 19.136572298708913, + 16.394125680966077 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7012212951428777, + 0.4998712968277244, + 0.8995859222022987 + ], + "xyz": [ + 19.133127196279048, + 21.885948130244127, + 16.421121720755515 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6997428643016567, + 0.6997053823869122, + 0.09931805775991526 + ], + "xyz": [ + 10.924104649468196, + 10.924617095459839, + 19.133004528041706 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7002545309569358, + 0.7010737721237644, + 0.2991944251252313 + ], + "xyz": [ + 13.675486744512764, + 13.664286226743291, + 19.158708320624775 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7007982161233667, + 0.7006372613738724, + 0.49946449650753977 + ], + "xyz": [ + 16.407575215438246, + 16.409775759801477, + 19.1601735899563 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6990389716647892, + 0.7000858208320035, + 0.6997949399690442 + ], + "xyz": [ + 19.13891778313498, + 19.124605449753673, + 19.1285823205535 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7001758721085025, + 0.7010931888284038, + 0.8995986192624708 + ], + "xyz": [ + 21.884370275692977, + 21.871828886615496, + 19.157898372698412 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6999340578864784, + 0.90064355717294, + 0.09882953651065154 + ], + "xyz": [ + 13.6646162316852, + 10.920552085150568, + 21.882809049121654 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6992784516553446, + 0.8993770928456928, + 0.3010769144227479 + ], + "xyz": [ + 16.412391105652812, + 13.676678501053786, + 21.85653084642017 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7011164156895897, + 0.8991115741482274, + 0.49968814898589475 + ], + "xyz": [ + 19.12413803073955, + 16.41718386342158, + 21.87802903602446 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000327569299424, + 0.9008916967853737, + 0.7002147017680332 + ], + "xyz": [ + 21.890038481870437, + 19.143931210776156, + 21.88755096479413 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.700210890239246, + 0.9011049717389888, + 0.8994083435463059 + ], + "xyz": [ + 24.616293954183796, + 21.869706232853982, + 21.892902228111268 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9003452896260656, + 0.09886902784357048, + 0.09992754739341937 + ], + "xyz": [ + 2.717910993256582, + 13.675550178619734, + 13.661078289867719 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9005072384837209, + 0.10003927665826048, + 0.2987962062119583 + ], + "xyz": [ + 5.452806931414714, + 16.396660821259278, + 13.679291856648444 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9011725319731576, + 0.09915693402497781, + 0.4998424381119473 + ], + "xyz": [ + 8.189411595969055, + 19.154424488308937, + 13.676324399822626 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8991038417888237, + 0.10021485931770574, + 0.7010681864151984 + ], + "xyz": [ + 10.954997570312033, + 21.87726393864031, + 13.662505404162271 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9007195681102569, + 0.09918833430656022, + 0.8993535360507967 + ], + "xyz": [ + 13.651884713989118, + 24.610275466931174, + 13.670560858420288 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8989922621033151, + 0.2999384012481598, + 0.10001078965063494 + ], + "xyz": [ + 5.468033347113959, + 13.658189903030689, + 16.39156422182196 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9011552513832214, + 0.29945825146233496, + 0.29929095631362684 + ], + "xyz": [ + 8.185991393855549, + 16.41228447131392, + 16.41457170047393 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9012008971806611, + 0.29921927689482025, + 0.49978741240110636 + ], + "xyz": [ + 10.923875634849834, + 19.154059990706198, + 16.411928544328646 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9002089458779601, + 0.3003139630955039, + 0.6987739160156303 + ], + "xyz": [ + 13.659349647389186, + 21.861005870894026, + 16.41333311736158 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9002229271040155, + 0.3001156427513369, + 0.8988258310678668 + ], + "xyz": [ + 16.391712020590866, + 24.5962707929495, + 16.4108128661198 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9002196199986793, + 0.498750569333939, + 0.10052910567710449 + ], + "xyz": [ + 8.193243846409484, + 13.682056442668692, + 19.126468613921475 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994392991437054, + 0.5002310858579622, + 0.29923802297987845 + ], + "xyz": [ + 10.930197751591365, + 16.388100586155655, + 19.136041563073494 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.901062222669154, + 0.49975052796185865, + 0.49903723761277 + ], + "xyz": [ + 13.655246549138518, + 19.141907803071614, + 19.15165978033209 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8999704817303971, + 0.5006106297540525, + 0.7006031396573642 + ], + "xyz": [ + 16.422778436914392, + 21.88275444836162, + 19.148492851615323 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994186341080408, + 0.5006277526607059, + 0.9008155058073611 + ], + "xyz": [ + 19.160279969988885, + 24.612477118778187, + 19.141182191552684 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8996568382501865, + 0.7011057490779655, + 0.09911434658759893 + ], + "xyz": [ + 10.940465108322377, + 13.655019860288931, + 21.885337956684772 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9011130536004559, + 0.6999217818447739, + 0.2990586013572365 + ], + "xyz": [ + 13.65787998266891, + 16.408530835683674, + 21.889060083936798 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9010993069517653, + 0.6999287110576913, + 0.49903989692639844 + ], + "xyz": [ + 16.392082994009037, + 19.142451170365554, + 21.888966877182046 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8998415173632286, + 0.7009408222164581, + 0.7002884173788984 + ], + "xyz": [ + 19.157353942484583, + 21.876688444406103, + 21.88560800591235 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8995293681623985, + 0.7005770029040753, + 0.90083560132484 + ], + "xyz": [ + 21.894224870748964, + 24.614265797135012, + 21.876366286074035 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9001749233917333, + 0.8997734413070685, + 0.10103989558189017 + ], + "xyz": [ + 13.682939795545202, + 13.688428786339964, + 24.60857005145637 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8989286649932531, + 0.90099430017828, + 0.3000559747098348 + ], + "xyz": [ + 16.420543169220824, + 16.392302176785467, + 24.608222793691464 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8990755210921838, + 0.9011226373929164, + 0.4998491574578692 + ], + "xyz": [ + 19.153834204276865, + 19.125846398694183, + 24.611985187139762 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9007721442834558, + 0.9004130957444253, + 0.6999864811808282 + ], + "xyz": [ + 21.880374943798216, + 21.885283790795103, + 24.625480388317982 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9001928957934806, + 0.899322331676215, + 0.8993688810016668 + ], + "xyz": [ + 24.591382495313717, + 24.60328469122343, + 24.60264827722473 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1489411038291813, + 0.14986265834924187, + 0.15097518120368816 + ], + "xyz": [ + 4.11300079155654, + 4.100401464038085, + 4.085191251826209 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14889481318857764, + 0.14980974236244735, + 0.35050067763776727 + ], + "xyz": [ + 6.840154006367333, + 6.827645259389438, + 4.083834916673614 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14885918713252208, + 0.15071786132534123, + 0.5498696093107183 + ], + "xyz": [ + 9.57830579279149, + 9.552894333788622, + 4.095763482647184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1491745427633825, + 0.1509054962816511, + 0.7493963041749775 + ], + "xyz": [ + 12.308764161518942, + 12.285098876588807, + 4.10264027941667 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15122815896412065, + 0.14976624144098655, + 0.9492996561905497 + ], + "xyz": [ + 15.026231120556789, + 15.046218193787924, + 4.115141263346552 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15004013752582473, + 0.3488060804861529, + 0.15073068789495456 + ], + "xyz": [ + 6.829576780688192, + 4.112084586404318, + 6.820135700340515 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14952952006681217, + 0.3505981562994975, + 0.3490550615715472 + ], + "xyz": [ + 9.565532857153705, + 6.816558654934954, + 6.837655568298439 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1491800735549051, + 0.3496486868319824, + 0.551159364874028 + ], + "xyz": [ + 12.315685537475265, + 9.574914741101454, + 6.819897022832655 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15065166867558968, + 0.349026773520192, + 0.7495622696359008 + ], + "xyz": [ + 15.01971165200233, + 12.3075629260858, + 6.831513719581131 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1492532352919045, + 0.34941823367517455, + 0.9510893309815786 + ], + "xyz": [ + 17.78030533262549, + 15.04368550442913, + 6.817746562853491 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.150805940900316, + 0.5495649275270172, + 0.15059953959201125 + ], + "xyz": [ + 9.572522564847276, + 4.120761476304609, + 9.575344446382182 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1508580463145069, + 0.54930328135477, + 0.3505921268389962 + ], + "xyz": [ + 12.303208039651695, + 6.855736506323526, + 9.572479642855372 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1488855306391048, + 0.5499960536110498, + 0.5509283174879347 + ], + "xyz": [ + 15.051639835278516, + 9.56772896510022, + 9.554983221182948 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14905582448314547, + 0.550885194848459, + 0.7505107343221907 + ], + "xyz": [ + 17.79245089235387, + 12.29871207000597, + 9.569467626918215 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14896921200246815, + 0.5500267070123175, + 0.949966950890228 + ], + "xyz": [ + 20.507643291985175, + 15.02445741055962, + 9.556546385504726 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14912888052763365, + 0.7511539621287853, + 0.14978969280968765 + ], + "xyz": [ + 12.317539480460912, + 4.086760929324655, + 12.30850497388688 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1507858697419265, + 0.7501142686653888, + 0.3488068981313068 + ], + "xyz": [ + 15.024252386634396, + 6.830342395664628, + 12.3169445302799 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15077428249014846, + 0.7506567412507483, + 0.5494909237362883 + ], + "xyz": [ + 17.775384849123064, + 9.57389985179072, + 12.324202699001265 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15016653432056, + 0.7487859707390122, + 0.7507355784008828 + ], + "xyz": [ + 20.501188705961795, + 12.316971522747275, + 12.290316837723559 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1498212384024219, + 0.7496502635641483, + 0.9512249888017104 + ], + "xyz": [ + 23.25406029280059, + 15.053305830013999, + 12.297412470016592 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14981486342301853, + 0.9509189322494224, + 0.14892881949242692 + ], + "xyz": [ + 15.036920489219249, + 4.084369858957045, + 15.049034322350389 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15019543810967867, + 0.9491493613969761, + 0.3510903394901357 + ], + "xyz": [ + 17.776643147382433, + 6.853488919904693, + 15.030044216791072 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14907540762237517, + 0.9507052237913944, + 0.5507276225137019 + ], + "xyz": [ + 20.527319616770942, + 9.56758106347502, + 15.036002832175402 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1492181986209997, + 0.9495006428539764, + 0.750161667110164 + ], + "xyz": [ + 23.23747716261393, + 12.296159635900636, + 15.021486231254405 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1510663628942233, + 0.9490708321013442, + 0.9496763787793262 + ], + "xyz": [ + 25.959330092662565, + 15.049156630467266, + 15.040877705284299 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3494899979139699, + 0.14977592702150191, + 0.14948379795255848 + ], + "xyz": [ + 4.091425093094858, + 6.8218799218039194, + 6.825873857851282 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3497323142441092, + 0.15010285984455787, + 0.34907143604299895 + ], + "xyz": [ + 6.824621122001417, + 9.55391908925029, + 6.83365652980892 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.349735511342578, + 0.15031139229964802, + 0.5489835857304698 + ], + "xyz": [ + 9.560635066531724, + 12.287125725745236, + 6.836551258153858 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34992608198074043, + 0.15121602946042667, + 0.7493867101479145 + ], + "xyz": [ + 12.31287854743211, + 15.029606617680384, + 6.851524742043576 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3509703650475244, + 0.15037546689098943, + 0.94960254067243 + ], + "xyz": [ + 15.038701323365707, + 17.781198663880186, + 6.854309972013612 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35021614718383814, + 0.3507583320974821, + 0.15023504012782735 + ], + "xyz": [ + 6.849491206257429, + 6.842078551711374, + 9.583596905327939 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3510843183183038, + 0.34955521864533484, + 0.3491501901022754 + ], + "xyz": [ + 9.552574581423752, + 9.573480156914641, + 9.579017634250214 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34931372169439845, + 0.3493814110424292, + 0.5511188019085571 + ], + "xyz": [ + 12.311476821427553, + 12.31055138484536, + 9.552434089654014 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3497989297570113, + 0.3505830110980682, + 0.7488906893178514 + ], + "xyz": [ + 15.031806526820377, + 15.02108670786009, + 9.575495826621292 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34971886326915314, + 0.350192630879522, + 0.9510492173722751 + ], + "xyz": [ + 17.790344325765883, + 17.78386706027509, + 9.56906396393174 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3496625048889536, + 0.5494960218588079, + 0.14957870553879238 + ], + "xyz": [ + 9.557623839529057, + 6.825535965550265, + 12.29313352916058 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3503138072593579, + 0.5508556753598877, + 0.34997448499610867 + ], + "xyz": [ + 12.315987802958317, + 9.574215479824131, + 12.320626955863453 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3498946309336321, + 0.548950963588858, + 0.5510026802367765 + ], + "xyz": [ + 15.038368226728183, + 12.316905876805814, + 12.28885517610447 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34890421782612346, + 0.550340638594797, + 0.7498588839737091 + ], + "xyz": [ + 17.776093836642552, + 15.022091350448987, + 12.294313812912668 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35082330866502787, + 0.5498437338637187, + 0.9488869791823523 + ], + "xyz": [ + 20.49037653723753, + 17.769405107597567, + 12.313757685385367 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3497941419564404, + 0.7499214660720824, + 0.14912953026367295 + ], + "xyz": [ + 12.291663392723107, + 6.821194640332389, + 15.035113844156518 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35048045830190827, + 0.748831506524618, + 0.3507358433490948 + ], + "xyz": [ + 15.033086885350423, + 9.586903057238215, + 15.029595306954597 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3510042546764125, + 0.7491720759863405, + 0.550375750802824 + ], + "xyz": [ + 17.767183969252635, + 12.323505186511134, + 15.041412761081638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.351151763035178, + 0.7501089219313422, + 0.7493109937749051 + ], + "xyz": [ + 20.499799191950984, + 15.045328727811228, + 15.056237857938967 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34986389102755283, + 0.7494388719075673, + 0.9512327870930462 + ], + "xyz": [ + 23.251276800957765, + 17.788359585862764, + 15.029469500351633 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3509411787492812, + 0.9490616455865998, + 0.15043081335552136 + ], + "xyz": [ + 15.032062990014069, + 6.854667629098281, + 17.77340461381178 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3508957578944552, + 0.9492845981657255, + 0.3505460303059768 + ], + "xyz": [ + 17.771050382951987, + 9.58998586875443, + 17.775831795590697 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3502029117813454, + 0.9511113644095001, + 0.5493415884597945 + ], + "xyz": [ + 20.513922690097477, + 12.29841048928682, + 17.79133454751152 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35014955760662375, + 0.9506363432775585, + 0.7487692405422395 + ], + "xyz": [ + 23.233967248979187, + 15.02422000290759, + 17.784110695426378 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3510794437259265, + 0.9497757794601419, + 0.9490438095192796 + ], + "xyz": [ + 25.960319633000633, + 17.77505109618287, + 17.78505845745975 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5499105216315048, + 0.14925226948916023, + 0.14963681112015828 + ], + "xyz": [ + 4.086357710056093, + 9.56408521486084, + 9.558827830899329 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.550022126338541, + 0.14984758513822394, + 0.35109173103908853 + ], + "xyz": [ + 6.848752161699303, + 12.31986645757262, + 9.568492718762263 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.549656588341975, + 0.15062974216235986, + 0.5489667592170017 + ], + "xyz": [ + 9.564757439488382, + 15.020180655623767, + 9.574188659115773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497049786159434, + 0.14893689857733144, + 0.7506948285676969 + ], + "xyz": [ + 12.29960303981594, + 17.778832091849434, + 9.551705989448557 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5507938209983141, + 0.1488069883067137, + 0.9501410165339622 + ], + "xyz": [ + 15.024619311540848, + 20.52051093047052, + 9.564816336672664 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5493158971543131, + 0.34931491663228853, + 0.15104880243543356 + ], + "xyz": [ + 6.840882701624463, + 9.57526010714509, + 12.285918732543934 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5509427568316273, + 0.34937867055029587, + 0.3492015286245017 + ], + "xyz": [ + 9.55086273868198, + 12.306610644784811, + 12.309032497308724 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497731511362655, + 0.3489014038547146, + 0.5507026731275613 + ], + "xyz": [ + 12.299225011767817, + 15.04550738368667, + 12.28651675441678 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5492289821261823, + 0.3505472917653638, + 0.7508931903588709 + ], + "xyz": [ + 15.058696012315753, + 17.775036320224597, + 12.301579256915916 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5488789051450772, + 0.3508926092465511, + 0.9502878234202798 + ], + "xyz": [ + 17.78950466294303, + 20.49633766293442, + 12.301514185889749 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502951554634226, + 0.5490569157667181, + 0.14963347985436898 + ], + "xyz": [ + 9.55236932466029, + 9.569298314910487, + 15.03014363448566 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5489645398344856, + 0.5499727860051664, + 0.3500301326824836 + ], + "xyz": [ + 12.304677903772186, + 12.290893343610948, + 15.024473310161069 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5487400321992589, + 0.5502991698332727, + 0.5504541271094582 + ], + "xyz": [ + 15.049300940207564, + 15.027984691120103, + 15.025866143132404 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5492220568222254, + 0.5495666441509439, + 0.7511594331769469 + ], + "xyz": [ + 17.783292798533, + 17.77858166260048, + 15.022441337738993 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5488516442566646, + 0.5499210335726418, + 0.9504378035112899 + ], + "xyz": [ + 20.512635956020837, + 20.498015457782873, + 15.022222272200265 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5499002044621001, + 0.7512107182021127, + 0.14959799214733324 + ], + "xyz": [ + 12.31569454232976, + 9.563413434368782, + 17.788554334699036 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5488788276969243, + 0.7502891303587711, + 0.34993999700119205 + ], + "xyz": [ + 15.04213458802249, + 12.2884891838842, + 17.761990472305015 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5490766512454162, + 0.7495141191079882, + 0.5505338064866886 + ], + "xyz": [ + 17.774021230103813, + 15.033676248230943, + 17.75409926593308 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5501008081381777, + 0.7488183041354571, + 0.7502672756893033 + ], + "xyz": [ + 20.495228211959756, + 17.77839837583423, + 17.758588297564923 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5493863860603546, + 0.7492480765563556, + 0.9503182751160254 + ], + "xyz": [ + 23.23616523812149, + 20.503692180764453, + 17.75469661869239 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5499810372075163, + 0.9511447937613196, + 0.149749581083001 + ], + "xyz": [ + 15.051229731884076, + 9.56659106175666, + 20.523122158356347 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5506992329857212, + 0.9504649231842197, + 0.3500332503266911 + ], + "xyz": [ + 17.780176938569937, + 12.314652380000304, + 20.52364613360732 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508123662729029, + 0.9495242219838437, + 0.5490580720019412 + ], + "xyz": [ + 20.488347378560732, + 15.037230655414778, + 20.51233177406035 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5511297001990336, + 0.950156348054084, + 0.7494355281794566 + ], + "xyz": [ + 23.236514205327243, + 17.78109370064961, + 20.525312620227936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5507150309207131, + 0.949267211510418, + 0.9507476488380645 + ], + "xyz": [ + 25.97666116800959, + 20.527727494379647, + 20.507487221714786 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503616140635082, + 0.1506034652553439, + 0.14874955925749928 + ], + "xyz": [ + 4.09270066759518, + 12.292486121633615, + 12.317832390733068 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7493372536648728, + 0.15100668670923728, + 0.34926759698369825 + ], + "xyz": [ + 6.839659957278749, + 15.019927769194146, + 12.309340290885565 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7491720976744193, + 0.15109985392942055, + 0.550186428039378 + ], + "xyz": [ + 9.587859815546658, + 17.764595879024405, + 12.308356073376409 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7487978372168246, + 0.15036312084078032, + 0.7507442673685112 + ], + "xyz": [ + 12.319778012267555, + 20.501469736311883, + 12.293166769591123 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7496732413544285, + 0.14938140127213426, + 0.9512484629214186 + ], + "xyz": [ + 15.047613389878698, + 23.254695374952608, + 12.29171324415469 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7510768815597401, + 0.3498814714098116, + 0.15002432381831424 + ], + "xyz": [ + 6.8346220493157945, + 12.31969348171179, + 15.052104429296174 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7504739179658306, + 0.3502855201266685, + 0.3487412260212499 + ], + "xyz": [ + 9.556967848520033, + 15.028271589865446, + 15.049384900901789 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7511883505491761, + 0.3494725247036372, + 0.549329574894371 + ], + "xyz": [ + 12.288260521326038, + 17.780446983437592, + 15.048037367498917 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.749184833743653, + 0.3497599281175616, + 0.7511837722294661 + ], + "xyz": [ + 15.051904101278499, + 20.51276951451541, + 15.02457497410939 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7495917683301067, + 0.3490074166347159, + 0.9506414498072641 + ], + "xyz": [ + 17.76856536519879, + 23.245282516394866, + 15.01985030898576 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7501044868580005, + 0.5497592439848318, + 0.14905280147215694 + ], + "xyz": [ + 9.554032499319767, + 12.293116597738011, + 17.771502952611648 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7492851765199185, + 0.5511676617648273, + 0.34948807220875194 + ], + "xyz": [ + 12.31360307685466, + 15.02223007743361, + 17.779557123518153 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503239067723092, + 0.5487666412062885, + 0.5502307536495086 + ], + "xyz": [ + 15.02529456293738, + 17.780949217448214, + 17.76093213566475 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503936279061308, + 0.5497574901070028, + 0.750902908145236 + ], + "xyz": [ + 17.782394846032922, + 20.525456007517796, + 17.77543205827432 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499044149056842, + 0.5488742908416886, + 0.9508533720661473 + ], + "xyz": [ + 20.504006656296607, + 23.252454327077224, + 17.756668684811043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500994838734975, + 0.750924906469314, + 0.15010014927115073 + ], + "xyz": [ + 12.3186523775736, + 12.307367348419662, + 20.521735280376653 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499619177356929, + 0.7489898932479977, + 0.3510574106534642 + ], + "xyz": [ + 15.039648730426084, + 15.052938074257444, + 20.493399348443038 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7491154428926433, + 0.7497772370542066, + 0.5499642430342438 + ], + "xyz": [ + 17.769831562302876, + 17.760783631648934, + 20.492590919550942 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7501502512450607, + 0.7495973705649535, + 0.7491455171406813 + ], + "xyz": [ + 20.49054298699165, + 20.498101872131553, + 20.504279530814586 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503198032308889, + 0.7496259355857746, + 0.9510008599707728 + ], + "xyz": [ + 23.250663436025913, + 23.26014986957374, + 20.506988150868434 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503916015770703, + 0.9509938877931948, + 0.14916758946406286 + ], + "xyz": [ + 15.04120968799532, + 12.298611339259983, + 23.261036161282174 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7498545233678987, + 0.9488630957838947, + 0.35068593006501503 + ], + "xyz": [ + 17.76720036258164, + 15.046390982053177, + 23.22456151987187 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7497541191951334, + 0.9511056338148851, + 0.550063832476077 + ], + "xyz": [ + 20.5237187326261, + 17.770877068017484, + 23.253848388397426 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7492540535886753, + 0.951207734994562, + 0.7498647195789335 + ], + "xyz": [ + 23.256756405887007, + 20.495682025368374, + 23.24840749038807 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7509058650412354, + 0.9504051006431541, + 0.949729195413694 + ], + "xyz": [ + 25.978294071515936, + 23.25077643222891, + 23.260017286863146 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9490206131634863, + 0.15038517318683325, + 0.14964294081081114 + ], + "xyz": [ + 4.101930369515274, + 15.020730350496878, + 15.030878017940026 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9508751643165149, + 0.14954489136585142, + 0.3505243795389626 + ], + "xyz": [ + 6.836857059341853, + 17.792500311674193, + 15.044744925679288 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501743284004927, + 0.1503508685387865, + 0.5487760084778831 + ], + "xyz": [ + 9.558336819734043, + 20.493379194740513, + 15.046182398018374 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9508416710676865, + 0.14964086685280603, + 0.7505288479178951 + ], + "xyz": [ + 12.306958309796366, + 23.26083148887745, + 15.045599171592146 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9488885256932937, + 0.15088148833643683, + 0.9498901323138917 + ], + "xyz": [ + 15.049551458639574, + 25.959760032115796, + 15.03585767321195 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9504475114180063, + 0.3488890772030638, + 0.15082439980303922 + ], + "xyz": [ + 6.831992709201578, + 15.056391341270112, + 17.764295959041316 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95020298081406, + 0.349224001664013, + 0.3494702921630564 + ], + "xyz": [ + 9.552422620230804, + 17.768899046953997, + 17.765531807583365 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9505960004061099, + 0.3498388277357935, + 0.5488703804975205 + ], + "xyz": [ + 12.286990527308385, + 20.50043445576587, + 17.779310892087036 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9502873003214685, + 0.3507229237966793, + 0.7502106153900934 + ], + "xyz": [ + 15.051765179724502, + 23.248901413983642, + 17.78717760230297 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9495804821058033, + 0.3490238316011495, + 0.950561648217873 + ], + "xyz": [ + 17.767698754699307, + 25.978401180201843, + 17.754284428224988 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9493414303667449, + 0.5491991746269225, + 0.15073253525594074 + ], + "xyz": [ + 9.569340349810727, + 15.040013244679544, + 20.48777741416452 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9509076359628172, + 0.5500257776434081, + 0.34887001714956456 + ], + "xyz": [ + 12.289541505166458, + 17.77032611337492, + 20.52049146280986 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9493580383627621, + 0.5510049839653662, + 0.5503894389731012 + ], + "xyz": [ + 15.058066299418597, + 20.50427755559, + 20.51269317592615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.950631719608556, + 0.549239262179287, + 0.7508240661127327 + ], + "xyz": [ + 17.774231813009397, + 23.261997240340026, + 20.505966086226664 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9503697566224714, + 0.5494810782898102, + 0.9491464544748189 + ], + "xyz": [ + 20.48896587500211, + 25.969843725204154, + 20.50569064177043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.949460007362671, + 0.7511964441447889, + 0.1493544153743646 + ], + "xyz": [ + 12.312169252191152, + 15.022793001064656, + 23.251068886848717 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.949723512868785, + 0.7491119399773489, + 0.3500360193029916 + ], + "xyz": [ + 15.027353052648143, + 17.770078367136737, + 23.226172520930827 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494641687318541, + 0.7510729502904973, + 0.5492035284023653 + ], + "xyz": [ + 17.77714596692265, + 20.489514995033563, + 23.24943739459216 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501547105609971, + 0.7506671042431758, + 0.7487726016234317 + ], + "xyz": [ + 20.5000697594612, + 23.227428405269315, + 23.253329704075984 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494331743402543, + 0.7491914489796034, + 0.9510186654168274 + ], + "xyz": [ + 23.24496664620741, + 25.982635471827663, + 23.223290097596895 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9488532427489341, + 0.9498857889242219, + 0.15053869278421847 + ], + "xyz": [ + 15.044805437511089, + 15.030688652060865, + 25.959218268009685 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494088227069686, + 0.9511150733652007, + 0.3501907414210236 + ], + "xyz": [ + 17.791218864710594, + 17.767891312836362, + 25.983620612797402 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.949909927260061, + 0.9512207726492259, + 0.549400531605051 + ], + "xyz": [ + 20.516224359929705, + 20.498302717721213, + 25.991916725633782 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.951073402653144, + 0.9498722667258059, + 0.7490151526614176 + ], + "xyz": [ + 23.226882998126626, + 23.243304712320725, + 25.98938702152851 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499701500279393, + 0.9488662294695464, + 0.9508789930775221 + ], + "xyz": [ + 25.972974728523457, + 25.988067331692104, + 25.96054918994131 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09871111253340094, + 0.1014856000676176, + 0.10058257767177382 + ], + "xyz": [ + 2.762639753780966, + 2.724707459620912, + 2.7370534192728573 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09850977202500469, + 0.0998206845802195, + 0.3000704721734347 + ], + "xyz": [ + 5.4672399147277435, + 5.449317354237107, + 2.711538303224436 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1017710482541046, + 0.09918370919724723, + 0.49899526700682567 + ], + "xyz": [ + 8.178195290446368, + 8.21356892431069, + 2.7474172720185406 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.100355845998428, + 0.09972319676685333, + 0.698442493398141 + ], + "xyz": [ + 10.912377646111572, + 10.9210271125288, + 2.7354446584592287 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09941324690185249, + 0.09864408526771652, + 0.9015817294534834 + ], + "xyz": [ + 13.674907298221594, + 13.685423137634407, + 2.7078041951025567 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10049574296414632, + 0.2981194453378534, + 0.1008845384751968 + ], + "xyz": [ + 5.455110645974935, + 2.7532349593880396, + 5.449795103731045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1011556835228626, + 0.2983655945880713, + 0.30082819698125557 + ], + "xyz": [ + 8.192069663453355, + 5.495851257153812, + 5.462183000502628 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10116935730907996, + 0.3008758748620629, + 0.49952001082499825 + ], + "xyz": [ + 10.942868477854075, + 8.212516917042853, + 5.496690046102074 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09814920548726441, + 0.3009502568609566, + 0.7006515349110564 + ], + "xyz": [ + 13.69371940878444, + 10.921059938592569, + 5.456416011321655 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10137506250108122, + 0.2990799624465906, + 0.9007660011653041 + ], + "xyz": [ + 16.404078042228374, + 13.70109223705536, + 5.474949019180078 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10101950970007423, + 0.5004515605306162, + 0.10038017044218617 + ], + "xyz": [ + 8.214463276148578, + 2.753500174962558, + 8.223204207401357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10039374674748466, + 0.5003054690844349, + 0.30112044808346283 + ], + "xyz": [ + 10.956950882854406, + 5.489429799173644, + 8.212651552995153 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09997727114808745, + 0.4997778659459883, + 0.49858374865989374 + ], + "xyz": [ + 13.649420289800988, + 8.183418521831152, + 8.199744278425525 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09919924194965854, + 0.4989455612204773, + 0.700108758900234 + ], + "xyz": [ + 16.393254834912742, + 10.927995112179577, + 8.177728082877525 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09849239144753114, + 0.4995394261155246, + 0.9005407822786269 + ], + "xyz": [ + 19.141644594727325, + 13.65860172521276, + 8.176183363994936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09967925949378685, + 0.6985791652997607, + 0.10010373456797252 + ], + "xyz": [ + 10.91944884406967, + 2.731397133873443, + 10.913645497260918 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10032421625573679, + 0.7001356106981778, + 0.298255870276983 + ], + "xyz": [ + 13.649828617425822, + 5.449315198659769, + 10.943742671345067 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10132913586114996, + 0.6986226852663283, + 0.49926574587278977 + ], + "xyz": [ + 16.377315010616417, + 8.21122511598771, + 10.936797307127078 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10180753150678055, + 0.6993788963287786, + 0.6998854211793851 + ], + "xyz": [ + 19.13048988139446, + 10.960601744393772, + 10.953676627810752 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1003147068590424, + 0.7016004108258022, + 0.8986419817691843 + ], + "xyz": [ + 21.878225947927984, + 13.65755603472116, + 10.96363914426601 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09827175666244015, + 0.8998365767710426, + 0.10086774631137357 + ], + "xyz": [ + 13.681449378404638, + 2.7225994395474458, + 13.645957475202556 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10030464859072255, + 0.8988780703229179, + 0.30165952370802224 + ], + "xyz": [ + 16.413533888824087, + 5.495581810117424, + 13.660646280097886 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09860734275989826, + 0.9008515490184236, + 0.5012715285266985 + ], + "xyz": [ + 19.16957433404295, + 8.201435950033519, + 13.664422065792694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09977049946868548, + 0.9016684811653686, + 0.6999672032134968 + ], + "xyz": [ + 21.897274782404658, + 10.933869918284312, + 13.691493484212272 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10044789259424784, + 0.9009084701736856, + 0.8981240826844101 + ], + "xyz": [ + 24.596049236816366, + 13.65229630305426, + 13.690363947617886 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30068730085180245, + 0.09989204117727453, + 0.09826757599659629 + ], + "xyz": [ + 2.70920261727007, + 5.454439264393475, + 5.476648659939975 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29907155512471784, + 0.10149631359385294, + 0.3005971805131993 + ], + "xyz": [ + 5.497349874602678, + 8.198563013269187, + 5.47649179890393 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30020579022317506, + 0.10063705624087742, + 0.5009948294262945 + ], + "xyz": [ + 8.225402847102153, + 10.95387065573601, + 5.480251245144161 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2985890483217069, + 0.10162245754386702, + 0.699603207508335 + ], + "xyz": [ + 10.954213071973996, + 13.647104847102282, + 5.47161967012307 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30028727850849346, + 0.0999175975052131, + 0.9014312865988524 + ], + "xyz": [ + 13.690261700671643, + 16.429679912805913, + 5.471529027981713 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29835082400010987, + 0.301426481415774, + 0.10024457902311355 + ], + "xyz": [ + 5.491574437529591, + 5.449524602960966, + 8.200047359730988 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30052285451060556, + 0.2984303446437442, + 0.2996488040149119 + ], + "xyz": [ + 8.176830466214387, + 8.205438884462339, + 8.188780327262421 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30038970891419725, + 0.2981547130075169, + 0.5004126560180597 + ], + "xyz": [ + 10.917869327191259, + 10.948425788928128, + 8.183191598517729 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29844508751295995, + 0.30123032977365666, + 0.6995177809331271 + ], + "xyz": [ + 13.68204803492322, + 13.643968704078581, + 8.19865436356751 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.299354516832192, + 0.29938549368301715, + 0.9019002063883333 + ], + "xyz": [ + 16.42376185994949, + 16.423338350020842, + 8.185865650562047 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29821757909827873, + 0.5002737348838509, + 0.1012152696449586 + ], + "xyz": [ + 8.223449401897067, + 5.460974010104766, + 10.916829516327157 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29880442092376813, + 0.5009352712418301, + 0.2990172956989771 + ], + "xyz": [ + 10.936807503752666, + 8.17331090175718, + 10.933897118143468 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3001410475330758, + 0.500217754722867, + 0.49829036237396257 + ], + "xyz": [ + 13.651423245486775, + 10.916010518595245, + 10.942361479858842 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3008621882140377, + 0.5011691285014334, + 0.6984179606897183 + ], + "xyz": [ + 16.40053875774537, + 13.661978325385348, + 10.96522779649691 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2988872891379231, + 0.5014308274001893, + 0.9007008652617745 + ], + "xyz": [ + 19.16969211836969, + 16.40055332108487, + 10.941805232048095 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29911159752799965, + 0.7010725465140787, + 0.09871244501292903 + ], + "xyz": [ + 10.934516442858774, + 5.438978701291918, + 13.674337584197366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30002598076642467, + 0.6986755886046261, + 0.3017021224665689 + ], + "xyz": [ + 13.676983997777382, + 8.226718316342906, + 13.654068090158518 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29837115109031287, + 0.7006887123568348, + 0.5012592218373159 + ], + "xyz": [ + 16.432815805674274, + 10.932402525199413, + 13.658966622273981 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30103924709015156, + 0.7009214018331044, + 0.6997138803290541 + ], + "xyz": [ + 19.14923346337024, + 13.682116622512444, + 13.698625639161948 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3006655356976918, + 0.698533867521103, + 0.9013754826608211 + ], + "xyz": [ + 21.87367265200423, + 16.43408843561428, + 13.66087438491478 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3012829021552822, + 0.8983692716414117, + 0.09969992782656811 + ], + "xyz": [ + 13.645422442670313, + 5.48216507460246, + 16.401428582757113 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3004811047487977, + 0.899272403593904, + 0.3015416412525952 + ], + "xyz": [ + 16.417313474613263, + 8.230746619236761, + 16.402814010429914 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3007598477029664, + 0.899712292640151, + 0.49834207782718287 + ], + "xyz": [ + 19.1139477032427, + 10.925177687501604, + 16.412639017785835 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2984916389537561, + 0.901574507554113, + 0.69979588030304 + ], + "xyz": [ + 21.893647696113177, + 13.648407271525448, + 16.407088343149212 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30070649124689425, + 0.8998953121628593, + 0.8982631743002334 + ], + "xyz": [ + 24.584099158395837, + 16.39209745282053, + 16.414411747893535 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49875204321726707, + 0.10128326511417637, + 0.10087960268474352 + ], + "xyz": [ + 2.763934339230629, + 8.198055929076025, + 8.203574729151994 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4989673052236999, + 0.09938197283094602, + 0.2998243437444897 + ], + "xyz": [ + 5.457876903082373, + 10.920935642196273, + 8.180523626693068 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5015639688741245, + 0.09854418314731309, + 0.4995968690095778 + ], + "xyz": [ + 8.177676799699624, + 13.687690766595157, + 8.20457063496973 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003820943308891, + 0.1015346158517683, + 0.6985532814768745 + ], + "xyz": [ + 10.938657716455683, + 16.391628649676097, + 8.229296916609458 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500472147729878, + 0.09875547517229273, + 0.9015577003540505 + ], + "xyz": [ + 13.676101679424567, + 19.168299717630813, + 8.192532199346354 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4989556067467447, + 0.299165099078932, + 0.10014553172302626 + ], + "xyz": [ + 5.459303068410828, + 8.190802926953783, + 10.911762628321602 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5015224172836773, + 0.29842411578977374, + 0.3001052629150181 + ], + "xyz": [ + 8.182985930363746, + 10.959709350694126, + 10.936725009804269 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49891027174634256, + 0.29891318918985993, + 0.5008912898585762 + ], + "xyz": [ + 10.93478287274399, + 13.66910698598136, + 10.90769874969679 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5001745195144434, + 0.29905675509860485, + 0.6990428539961172 + ], + "xyz": [ + 13.6458381976134, + 16.39548407150915, + 10.926946124880164 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5018353256845718, + 0.2997614616204418, + 0.8994411295819433 + ], + "xyz": [ + 16.39528197045259, + 19.157999466641844, + 10.95928698861243 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4990194502910644, + 0.499941544907171, + 0.10180602257498839 + ], + "xyz": [ + 8.226984428053935, + 8.214377716439557, + 13.657614913371138 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5006925117553427, + 0.5014179681272182, + 0.2987237852559266 + ], + "xyz": [ + 10.939394026738745, + 10.92947571780461, + 13.70067410106799 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4999432088103731, + 0.49991527016667, + 0.49852245336308465 + ], + "xyz": [ + 13.650460837308568, + 13.650842809416321, + 13.669885150047914 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49854605769702326, + 0.5007794924337358, + 0.7013031262100322 + ], + "xyz": [ + 16.43465718722624, + 16.404122069524156, + 13.662599042788713 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5007799728449579, + 0.49885125741772846, + 0.8989971684148025 + ], + "xyz": [ + 19.11113206526571, + 19.137501115418015, + 13.666778246529999 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5005520188537896, + 0.6989719684802227, + 0.10153030290996352 + ], + "xyz": [ + 10.944322964037774, + 8.231561128336114, + 16.399676040512894 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5008690236706191, + 0.6981478872804809, + 0.3007618895174176 + ], + "xyz": [ + 13.656914664621045, + 10.959753551542464, + 16.392743383479466 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500484623643413, + 0.6981641658562718, + 0.500290315392865 + ], + "xyz": [ + 16.385053945831572, + 13.682414827014965, + 16.38771049325758 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4997570596342914, + 0.7018106567889247, + 0.6988636058930573 + ], + "xyz": [ + 19.149766398020773, + 16.387325987370115, + 16.427617536749253 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5005751674388701, + 0.7010124391987032, + 0.9002547267007502 + ], + "xyz": [ + 21.892236464087464, + 19.151894163295943, + 16.427889472179704 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4981949485319173, + 0.9011184032550277, + 0.10015604222292747 + ], + "xyz": [ + 13.689243989174416, + 8.180547042421901, + 19.131160269227788 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49947327559031884, + 0.9016558740859727, + 0.3001963724160374 + ], + "xyz": [ + 16.43150758077111, + 10.93293948700626, + 19.155985531127314 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500259460868998, + 0.8993192709888608, + 0.49876227583112454 + ], + "xyz": [ + 19.11431925344441, + 13.658445360251468, + 19.134788497788907 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4992372420700969, + 0.8999558490639089, + 0.7018008857571741 + ], + "xyz": [ + 21.898929762261577, + 16.420377096791437, + 19.12951608722772 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5007951076761004, + 0.900782777633321, + 0.8981328341608987 + ], + "xyz": [ + 24.594450439640447, + 19.12589101376592, + 19.16212056393105 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6992133090753357, + 0.09880279363869555, + 0.10162235273253555 + ], + "xyz": [ + 2.7401765246611243, + 10.948881017818088, + 10.910332513407745 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7006147405361733, + 0.09873219302530928, + 0.30147030771559363 + ], + "xyz": [ + 5.471496553679491, + 13.700326404389472, + 10.928527393204549 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.699977979245414, + 0.09829648600345503, + 0.5013230654293537 + ], + "xyz": [ + 8.197890575670101, + 16.42397164860538, + 10.913864799478791 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7007536439823215, + 0.09810667788925759, + 0.700649987520414 + ], + "xyz": [ + 10.920457353281254, + 19.159738197251727, + 10.921874525770292 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6994835830795251, + 0.10174214381976877, + 0.8987698951895217 + ], + "xyz": [ + 13.678820505167996, + 21.851033869268317, + 10.954213917536302 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6999946455136248, + 0.2989043901758192, + 0.09932400798688838 + ], + "xyz": [ + 5.444506978568868, + 10.928140753301385, + 13.656767814119652 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6994548803870342, + 0.29962582288504436, + 0.3018659220557789 + ], + "xyz": [ + 8.223486868316845, + 13.689877773253698, + 13.659251540609267 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000033120402935, + 0.3015792458580592, + 0.49993969825113577 + ], + "xyz": [ + 10.958222730450974, + 16.40540484696257, + 13.693456446725854 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7006752220294588, + 0.2981795791441345, + 0.7010138088180453 + ], + "xyz": [ + 13.660792145409088, + 19.16364012572152, + 13.656163047781154 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7001152384857698, + 0.30008302061355896, + 0.9014460408081391 + ], + "xyz": [ + 16.427089052526398, + 21.89625752947605, + 13.674530562719385 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7009268539842967, + 0.4992144748044514, + 0.10121945836743343 + ], + "xyz": [ + 8.209024656218038, + 10.96679999613663, + 16.40811622176058 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7006895336918773, + 0.5014314863678332, + 0.29908259055541153 + ], + "xyz": [ + 10.944484367160754, + 13.668704523726566, + 16.43518220447275 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.700679932971545, + 0.498884557020209, + 0.49899024285249705 + ], + "xyz": [ + 13.642764646395658, + 16.401674703234654, + 16.40022978555906 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6995901760493921, + 0.5015379116916483, + 0.7003430144291047 + ], + "xyz": [ + 16.43189968335623, + 19.13963459224772, + 16.42160701253971 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6996314383064873, + 0.5012688652124413, + 0.9007039276730306 + ], + "xyz": [ + 19.167519669227453, + 21.87949706330609, + 16.418492787656156 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7008544432785505, + 0.6984456875734824, + 0.09950611596558662 + ], + "xyz": [ + 10.909453426661512, + 10.942385501085178, + 19.130979514985437 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7013463005639801, + 0.6985535812164133, + 0.30072283849427695 + ], + "xyz": [ + 13.661927340529008, + 13.700108896759458, + 19.139179201722815 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6989397250178379, + 0.7018327150477193, + 0.49974333540710214 + ], + "xyz": [ + 16.427731478129235, + 16.3881790391789, + 19.151108661537084 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7017712636452531, + 0.7000245459535142, + 0.6989225331319066 + ], + "xyz": [ + 19.126152654781635, + 19.150033464653905, + 19.165099985588615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6994131136619653, + 0.6987387652604888, + 0.9016895682574878 + ], + "xyz": [ + 21.88076809875774, + 21.889987668720014, + 19.115280821289584 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6989281814155757, + 0.8991287717961833, + 0.10025759781547461 + ], + "xyz": [ + 13.663430555784055, + 10.926324120206656, + 21.848347014059588 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6993705972164713, + 0.9010940603709318, + 0.2985199013478196 + ], + "xyz": [ + 16.40090615410566, + 13.642979276081242, + 21.881264714896606 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6981256366335498, + 0.9004159998822158, + 0.5009097677019958 + ], + "xyz": [ + 19.15867365577317, + 16.392996221702795, + 21.85497351694897 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6990693732869265, + 0.9007736232939842, + 0.7013704081338834 + ], + "xyz": [ + 21.904224811756148, + 19.146560612424658, + 21.872765477514825 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.700183549976252, + 0.9014854169542547, + 0.8983967353220316 + ], + "xyz": [ + 24.607664807133972, + 21.855501916146775, + 21.897729815459837 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8991926932000079, + 0.09902097105922601, + 0.09999617597804962 + ], + "xyz": [ + 2.7209266112071653, + 13.660730365405948, + 13.647397539292678 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9018162934868018, + 0.09931482863171341, + 0.29898342448545057 + ], + "xyz": [ + 5.445462022932304, + 16.417117600167398, + 13.687284498002356 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9006001787390605, + 0.0983122250519279, + 0.49983151410767196 + ], + "xyz": [ + 8.177713535917, + 19.146450026895813, + 13.656950580397709 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8995224698701539, + 0.09982539980822498, + 0.6988523332813104 + ], + "xyz": [ + 10.91937820480817, + 21.85269260122225, + 13.662904191626254 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9011934898915291, + 0.09839067360260197, + 0.9008054627956377 + ], + "xyz": [ + 13.66082972153218, + 24.63660532132746, + 13.666134758142329 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9001160017945122, + 0.29850432446642194, + 0.09979187333904545 + ], + "xyz": [ + 5.445433923080744, + 13.670560485408474, + 16.387321348980763 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9011795260640262, + 0.2992419315540229, + 0.3009640404808726 + ], + "xyz": [ + 8.205908012586125, + 16.435490455959876, + 16.411946092691593 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.898404358691015, + 0.30009992462854546, + 0.5015029372178801 + ], + "xyz": [ + 10.959370038649196, + 19.139280566353147, + 16.38573483077403 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9010793818868817, + 0.2981658825763607, + 0.7003543060172401 + ], + "xyz": [ + 13.651588284817763, + 21.894513122961328, + 16.395865391593844 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8998035469687958, + 0.29839179708905916, + 0.9014322461743792 + ], + "xyz": [ + 16.40377835116994, + 24.62617154141072, + 16.38151106879706 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8986008577950201, + 0.5011857916414786, + 0.09926155145143051 + ], + "xyz": [ + 8.209207994244496, + 13.642595243983807, + 19.13763110949891 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9004502200706751, + 0.5014871068495362, + 0.29954325735580045 + ], + "xyz": [ + 10.951542953949804, + 16.406094824548838, + 19.167034784934284 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.899330959209692, + 0.4998459818796307, + 0.4989964537701439 + ], + "xyz": [ + 13.6559939885653, + 19.11768069132598, + 19.12929528672382 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9003055034627755, + 0.5000916082123573, + 0.6982792163109316 + ], + "xyz": [ + 16.38391020613399, + 21.85556254349656, + 19.14597723934231 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9017252285271791, + 0.4991102470754124, + 0.8989915655522298 + ], + "xyz": [ + 19.11459632391885, + 24.619075879630742, + 19.15197047205302 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994303481672786, + 0.7000827352720157, + 0.10172079309871274 + ], + "xyz": [ + 10.962113515249492, + 13.687558196183204, + 21.86825496442701 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8995390530423197, + 0.6991872379040766, + 0.3018879953734693 + ], + "xyz": [ + 13.686520395828616, + 16.42569434907195, + 21.857498079086756 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8990344839021631, + 0.7002336740369015, + 0.5017001450078417 + ], + "xyz": [ + 16.4326228258923, + 19.15059171422438, + 21.86490638707446 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8998441367950543, + 0.7015167052481229, + 0.6984351879863159 + ], + "xyz": [ + 19.139890292960462, + 21.85138723813243, + 21.89351718746275 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8988890924314785, + 0.7008795492395616, + 0.901294755647703 + ], + "xyz": [ + 21.904638705043798, + 24.61178953784591, + 21.871748910570957 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9003315684341459, + 0.900515131429011, + 0.10100514231386218 + ], + "xyz": [ + 13.692604908963286, + 13.69009526873883, + 24.620851928123102 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8987045979810157, + 0.8992219741116726, + 0.30147374153761003 + ], + "xyz": [ + 16.415695699128175, + 16.408622225797536, + 24.580928466868254 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8992187576621372, + 0.900135251096457, + 0.5017332515804195 + ], + "xyz": [ + 19.16609383226777, + 19.153563699002568, + 24.60044412402592 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9017796927408034, + 0.8999736939221794, + 0.6988890547965647 + ], + "xyz": [ + 21.8593637051879, + 21.884054995956337, + 24.633247986846698 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8986692185844886, + 0.9007726604511646, + 0.9013493865262587 + ], + "xyz": [ + 24.63828824430687, + 24.609530365725213, + 24.60164547063722 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15061193715756174, + 0.14926551109507608, + 0.1486660199771288 + ], + "xyz": [ + 4.073266265143592, + 4.091674359913204, + 4.0998704945693785 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15108459305432007, + 0.14866901351046677, + 0.349164889213691 + ], + "xyz": [ + 6.806295507942194, + 6.8393208766614375, + 4.0981773533045835 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14948187437582394, + 0.15126401193326106, + 0.548471510435207 + ], + "xyz": [ + 9.566658109427669, + 9.542293045527149, + 4.111743623358274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14964026530272936, + 0.1485203065182813, + 0.750285569519902 + ], + "xyz": [ + 12.288312152136355, + 12.303624027044746, + 4.07639766903393 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1512577600486335, + 0.15068853656676826, + 0.9496844421172986 + ], + "xyz": [ + 15.044101297432398, + 15.051883618416232, + 4.1281554169923815 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1493419569448206, + 0.3502851928151957, + 0.15164091201926994 + ], + "xyz": [ + 6.862243358597944, + 4.1149836075606325, + 6.830812458631986 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14864372361842557, + 0.3515823612377696, + 0.3503591962002816 + ], + "xyz": [ + 9.596818623812696, + 6.822278099235796, + 6.839000991458625 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15148196442005935, + 0.34987307378070936, + 0.5484047294449333 + ], + "xyz": [ + 12.281092435696406, + 9.568724898917283, + 6.854435838374033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14974129083014276, + 0.350152983834748, + 0.7485167954288124 + ], + "xyz": [ + 15.02081546153113, + 12.280822868876907, + 6.834464542248946 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14879265361356234, + 0.3495269113417924, + 0.9499124515522704 + ], + "xyz": [ + 17.765701070402304, + 15.021298430908335, + 6.812935394547917 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14899946275560616, + 0.549859541510501, + 0.15182413049620977 + ], + "xyz": [ + 9.593292860614786, + 4.112806018692042, + 9.554674511705448 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14893261163857527, + 0.5502431143797343, + 0.3491321385101441 + ], + "xyz": [ + 12.296096569964895, + 6.809451612378263, + 9.559004674491643 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14915388711401345, + 0.5503242448575821, + 0.5488721011098644 + ], + "xyz": [ + 15.028014586724654, + 9.543285666318976, + 9.563139114251898 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1483320200886, + 0.5509785606455101, + 0.7509918344862442 + ], + "xyz": [ + 17.800304887570217, + 12.295393861453444, + 9.56084838389222 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15033644006116442, + 0.5505836902581633, + 0.9481367736947663 + ], + "xyz": [ + 20.49023641348094, + 15.018128053292608, + 9.58285385610239 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15147496450858908, + 0.7498947951996413, + 0.15023441861608336 + ], + "xyz": [ + 12.3064045880301, + 4.124916378391559, + 12.323365108174176 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14950278722743568, + 0.7518912218862535, + 0.3494013749801834 + ], + "xyz": [ + 15.056674151690489, + 6.82092790295337, + 12.323696641680716 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1516764106204357, + 0.7486979642613293, + 0.5501586453411424 + ], + "xyz": [ + 17.757733772295264, + 9.595362554796623, + 12.30975638599601 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15052199381075343, + 0.7503893473171249, + 0.7481344378909623 + ], + "xyz": [ + 20.48754745708363, + 12.28626897606815, + 12.317097691858947 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14875598689971004, + 0.7517424041417091, + 0.9495192975317073 + ], + "xyz": [ + 23.259343758172644, + 15.015421999195139, + 12.311451912607893 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1511296399515015, + 0.9509359247516266, + 0.14845262644989057 + ], + "xyz": [ + 15.030642382087924, + 4.09583482143188, + 15.06724202881952 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1483607002151499, + 0.9496405410789707, + 0.35097821508237176 + ], + "xyz": [ + 17.781825522861762, + 6.826871768942962, + 15.011675330749782 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15125369521140392, + 0.9483917972853368, + 0.5496322660931007 + ], + "xyz": [ + 20.48071535017859, + 9.58238670348215, + 15.03415523722679 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15071248901563714, + 0.9481673912418086, + 0.7509609956258227 + ], + "xyz": [ + 23.230177462144617, + 12.327517580790802, + 15.02368792450135 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14869528116204322, + 0.9491341003429481, + 0.9511447346113667 + ], + "xyz": [ + 25.980270181305098, + 15.03681472445122, + 15.009325694647568 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35012424155771077, + 0.15047762011776356, + 0.14821747325655468 + ], + "xyz": [ + 4.083705551496871, + 6.81323822343197, + 6.844138544491983 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35116994858828615, + 0.1485746333708046, + 0.35095893089838864 + ], + "xyz": [ + 6.829532974646841, + 9.59937965714351, + 6.832417970519936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34904008847647877, + 0.15183708745170932, + 0.5498201486709877 + ], + "xyz": [ + 9.59293143396701, + 12.289055367437474, + 6.84790259139852 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35081702519116204, + 0.15081085294985946, + 0.7502264748483419 + ], + "xyz": [ + 12.318820158938005, + 15.05326854471009, + 6.858166056925979 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3486202232080915, + 0.15095523474250594, + 0.9511891418326245 + ], + "xyz": [ + 15.068319530547399, + 17.77075967315096, + 6.830105737518136 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3514971115651169, + 0.3502621706765534, + 0.14842850808947092 + ], + "xyz": [ + 6.818009195766906, + 6.834893085305986, + 9.594326590137312 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3509773738421521, + 0.3499397401511375, + 0.3482308155543203 + ], + "xyz": [ + 9.54526216690499, + 9.559448507954478, + 9.582812617435735 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35112048628984427, + 0.34940441445126486, + 0.550975886512079 + ], + "xyz": [ + 12.309837406316662, + 12.333299231600789, + 9.57745034845031 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3485626148428824, + 0.34967952084075316, + 0.7501369408925358 + ], + "xyz": [ + 15.036492697854413, + 15.021222560094603, + 9.546240795482241 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34895347899446993, + 0.3488705007490559, + 0.9508925341908592 + ], + "xyz": [ + 17.770126256352228, + 17.771260719987445, + 9.54052384273713 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34979188368182174, + 0.5496261726491285, + 0.14879722821056296 + ], + "xyz": [ + 9.548719020341546, + 6.816620591752542, + 12.296681770906611 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3512722695977353, + 0.5507812948080734, + 0.34946172247697843 + ], + "xyz": [ + 12.307960488578114, + 9.58030900752691, + 12.332713962914621 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500291073591538, + 0.5497795069932364, + 0.5485550517400456 + ], + "xyz": [ + 15.016232386780858, + 12.285280878055616, + 12.302021409875294 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3499391477322087, + 0.5515671424956592, + 0.748465562748035 + ], + "xyz": [ + 17.77381314020484, + 15.017191488838003, + 12.325231728863168 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35135123489121817, + 0.5506515624626973, + 0.9484699423871897 + ], + "xyz": [ + 20.49571937243678, + 17.770921167938482, + 12.332019884919207 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.348572075147019, + 0.7500364446600679, + 0.15164614063642307 + ], + "xyz": [ + 12.32764200330827, + 6.838893406912378, + 15.019977933268926 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34842368514847777, + 0.750312526700396, + 0.349785163055603 + ], + "xyz": [ + 15.04033759675986, + 9.545785695053514, + 15.021723715879668 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3493491482644273, + 0.7513312180093341, + 0.5485671755605707 + ], + "xyz": [ + 17.771976855176895, + 12.276150354397084, + 15.048303845228936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35120193871309713, + 0.7505918074744659, + 0.7499431486576654 + ], + "xyz": [ + 20.515043823946392, + 15.054657428417338, + 15.063525775002045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3504628153393065, + 0.7508345036063053, + 0.9505888412352397 + ], + "xyz": [ + 23.26155371447153, + 17.78774405938901, + 15.056738711106993 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34980407277627285, + 0.9510354680403648, + 0.15087482076351216 + ], + "xyz": [ + 15.06511912467462, + 6.8451917102751025, + 17.78484405092772 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34927217122674503, + 0.9510394899105971, + 0.35110037168528824 + ], + "xyz": [ + 17.802621802563856, + 9.575367339635594, + 17.777626974970733 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3491461182019065, + 0.9493643275599337, + 0.5496106807728656 + ], + "xyz": [ + 20.49371649842453, + 12.287641179359268, + 17.75300108257564 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3506670472402009, + 0.9484065961586035, + 0.7513004274978665 + ], + "xyz": [ + 23.238088480166997, + 15.065900960473403, + 17.76070101929264 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500488921739487, + 0.9512666756023078, + 0.9504245080600684 + ], + "xyz": [ + 25.999579558618947, + 17.779838242787438, + 17.791352205834777 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5492747162675281, + 0.14973093013729222, + 0.149132969350819 + ], + "xyz": [ + 4.086013438299548, + 9.548504164390629, + 9.556679376630349 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508629075934979, + 0.15122599709228204, + 0.34939457428332044 + ], + "xyz": [ + 6.8443943401443885, + 12.308158245873122, + 9.59883312886114 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5496441539787774, + 0.1491981721707882, + 0.5492797468773626 + ], + "xyz": [ + 9.549464383200888, + 15.02428976620299, + 9.554446491498153 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508660822103126, + 0.15122840186656378, + 0.7485270660421895 + ], + "xyz": [ + 12.30129480126425, + 17.76506923214152, + 9.598909409291918 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5498067063490862, + 0.1484745588045134, + 0.9515570674027376 + ], + "xyz": [ + 15.039434387812816, + 20.52637526925566, + 9.546775766552285 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508187898657045, + 0.3506071933245673, + 0.14811246297612757 + ], + "xyz": [ + 6.818405371404966, + 9.555662281228015, + 12.32413378550042 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5511084936607272, + 0.35053859240433344, + 0.3481916619866125 + ], + "xyz": [ + 9.552914266587221, + 12.295069853982412, + 12.327156664206017 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502275697479808, + 0.3481670827107908, + 0.5510424490738017 + ], + "xyz": [ + 12.293830860843226, + 15.056365468728021, + 12.282689977378881 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5484135349154021, + 0.35005865471835185, + 0.7500130675052126 + ], + "xyz": [ + 15.03998257333057, + 17.751854791506208, + 12.283750051678549 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5516892905963571, + 0.3498053374447726, + 0.9486177151866556 + ], + "xyz": [ + 17.75180625942741, + 20.511927327804308, + 12.325072285545277 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5503364311865805, + 0.5510056325268935, + 0.15051004356579506 + ], + "xyz": [ + 9.590996050717541, + 9.581846850449022, + 15.057350453519147 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5506044250493792, + 0.5511005709183799, + 0.3482028229903023 + ], + "xyz": [ + 12.295114126908599, + 12.288330909893878, + 15.062312397971928 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5513866727670784, + 0.5498527016242365, + 0.548355045541626 + ], + "xyz": [ + 15.01449864185718, + 15.035470819207308, + 15.055946503590665 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5489788898598991, + 0.5490703637300682, + 0.7502663833444889 + ], + "xyz": [ + 17.76429812538887, + 17.763047511101213, + 15.012331746216384 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5506100344607523, + 0.5503593415641718, + 0.9509016408073867 + ], + "xyz": [ + 20.524969924007117, + 20.528397352164447, + 15.052255134525076 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5491034790601523, + 0.7514114298208244, + 0.14877134037448955 + ], + "xyz": [ + 12.307136801211696, + 9.541218913842924, + 17.780405741537113 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5494570416478674, + 0.7487356302838127, + 0.35170624630743463 + ], + "xyz": [ + 15.045043257217747, + 12.320542263533056, + 17.74865653596898 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5491868120107755, + 0.7486640439010607, + 0.5512470031541266 + ], + "xyz": [ + 17.772149851350047, + 15.04493304284781, + 17.743983288872556 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5517690465440706, + 0.7488877668646776, + 0.7493305372987377 + ], + "xyz": [ + 20.483370975227462, + 17.78839931237378, + 17.78234583469799 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5514154865247739, + 0.7504376278040698, + 0.9497453029329148 + ], + "xyz": [ + 23.244594996108518, + 20.523600104523414, + 17.79870144554337 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5511039565507482, + 0.9482339191178709, + 0.15069020174309386 + ], + "xyz": [ + 15.024292774069353, + 9.594803409244914, + 20.498677555323738 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5496793790311248, + 0.9503068449765015, + 0.3484873680060075 + ], + "xyz": [ + 17.756880696938524, + 12.279574095477205, + 20.507541657111943 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508245620200174, + 0.9499527744900199, + 0.5509952879828759 + ], + "xyz": [ + 20.520691739478185, + 15.063882661666556, + 20.518357604844656 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5507211584781325, + 0.948720049762352, + 0.7513975332279156 + ], + "xyz": [ + 23.243701573478, + 17.80233237164058, + 20.50009029964642 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5504565351093916, + 0.9505486847421689, + 0.9508758340897674 + ], + "xyz": [ + 25.99593376505684, + 20.525945911864444, + 20.52147318487096 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7487820712608524, + 0.14943051909609795, + 0.1517333038346837 + ], + "xyz": [ + 4.1174575776215185, + 12.31168411553865, + 12.28020085709396 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7507816687210441, + 0.15054840181997492, + 0.34810642206280656 + ], + "xyz": [ + 6.817518994257089, + 15.023800177340464, + 12.322822485024114 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7493618569566787, + 0.1487051003636961, + 0.55030978321738 + ], + "xyz": [ + 9.556805665641427, + 17.768876723564496, + 12.278209788431845 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7512237099467994, + 0.14835928526863978, + 0.7496895750483258 + ], + "xyz": [ + 12.277962369458695, + 20.52021626806205, + 12.298936785646344 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7511300442938684, + 0.14836923056597462, + 0.9508640223493258 + ], + "xyz": [ + 15.02851917187246, + 23.26935652021375, + 12.297792176014298 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7507578097117572, + 0.3492635535428513, + 0.1513491108931887 + ], + "xyz": [ + 6.84428623788994, + 12.33344343926511, + 15.03929407457162 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499971681161481, + 0.35002300734429603, + 0.3484384310979104 + ], + "xyz": [ + 9.549239063322926, + 15.01761379404675, + 15.039277835263608 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7485212142032479, + 0.3500677851886512, + 0.5516077377763583 + ], + "xyz": [ + 12.327545448383475, + 17.775129008253817, + 15.019711053666153 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.749094407246677, + 0.34950740872112596, + 0.749521228518375 + ], + "xyz": [ + 15.025721703183752, + 20.48880322136535, + 15.019886279584926 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7506772201377764, + 0.3481431538233821, + 0.9509158995884419 + ], + "xyz": [ + 17.760501547616844, + 23.263874846135305, + 15.022874365129645 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7511784406632085, + 0.5484817022621895, + 0.14944081033616452 + ], + "xyz": [ + 9.541870966192429, + 12.313104288198247, + 17.768719535250312 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7518980247956678, + 0.5492887811261699, + 0.34937236272980055 + ], + "xyz": [ + 12.286333399792932, + 15.056370509578448, + 17.789591796938296 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499498468104642, + 0.5482262617018494, + 0.5508733739717535 + ], + "xyz": [ + 15.026692380995076, + 17.784620926354737, + 17.748430083880816 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7498593548775331, + 0.5488504546744287, + 0.7517943117687268 + ], + "xyz": [ + 17.78218113075286, + 20.530338632727666, + 17.7557267484287 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7495215949541154, + 0.5487847659425913, + 0.9517619852817368 + ], + "xyz": [ + 20.515205084323792, + 23.259642877940127, + 17.75021087103481 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7515970803286103, + 0.7493393056890625, + 0.14869833935538113 + ], + "xyz": [ + 12.277809036271524, + 12.308676924743986, + 20.520532101084136 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7486658002022759, + 0.7509401812866231, + 0.3512151628023871 + ], + "xyz": [ + 15.068469476423012, + 15.037374547626412, + 20.502343049839556 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7485276616658475, + 0.7494110264386161, + 0.5513270974629243 + ], + "xyz": [ + 17.783457497119556, + 17.77138029295192, + 20.479548114800366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.751335112969693, + 0.7501571059699442, + 0.7482806585624989 + ], + "xyz": [ + 20.486371397889947, + 20.50247689754925, + 20.528131348743308 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7510853693625872, + 0.7481986640503709, + 0.9500974198637873 + ], + "xyz": [ + 23.218798365979264, + 23.25826488140093, + 20.497941433695946 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7493724256256694, + 0.9486116050790229, + 0.15148828267162295 + ], + "xyz": [ + 15.040367647347034, + 12.316405448913088, + 23.214532030669023 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7497938566904016, + 0.9497818032905855, + 0.3517344694940727 + ], + "xyz": [ + 17.794096208582744, + 15.059897000495418, + 23.236292499641255 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7481878591277564, + 0.9511359415059168, + 0.5502603562006425 + ], + "xyz": [ + 20.52681993091049, + 17.752150279291108, + 23.232849123979463 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7481717793419598, + 0.9508631172406838, + 0.7501207132871196 + ], + "xyz": [ + 23.255544753886632, + 20.484385266576098, + 23.22889927979652 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7511048254129966, + 0.9492374855368366, + 0.9486134695536331 + ], + "xyz": [ + 25.947076644824982, + 23.238242579490663, + 23.246774013690146 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9518960759114445, + 0.14936775292883028, + 0.1492645079624386 + ], + "xyz": [ + 4.082846517098467, + 15.054869293818632, + 15.056280840415043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9485631279093109, + 0.1514355013280147, + 0.34941346220053165 + ], + "xyz": [ + 6.84751687654885, + 17.745702304195543, + 15.03898325917945 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9512822237091748, + 0.15085442177093417, + 0.5492128954835097 + ], + "xyz": [ + 9.57119434938565, + 20.514499180480925, + 15.068213832407862 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9495861502429793, + 0.15048159470583553, + 0.7484812994607548 + ], + "xyz": [ + 12.290458875724672, + 23.215672520208503, + 15.039928196746104 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9496988870825247, + 0.15186936397017092, + 0.9492198876516701 + ], + "xyz": [ + 15.053894052108516, + 25.961675682786456, + 15.060442846107263 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500417397532256, + 0.34974402618442024, + 0.1485701206718156 + ], + "xyz": [ + 6.812861319272022, + 15.020023605596286, + 17.770437030461625 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.949217465485007, + 0.3511317707800462, + 0.35102135013319863 + ], + "xyz": [ + 9.599711081564118, + 17.776631044145294, + 17.778140695353276 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9488775702560367, + 0.34960635688667274, + 0.5518189055653134 + ], + "xyz": [ + 12.324123931696313, + 20.51725209206385, + 17.752638524788235 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.949910518918925, + 0.35147176574092565, + 0.7483908511791071 + ], + "xyz": [ + 15.03712372325964, + 23.218870637733676, + 17.79226434705824 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9486809060850432, + 0.35102443956901097, + 0.9491518291175867 + ], + "xyz": [ + 17.775775913754796, + 25.946827545798016, + 17.769337538820007 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.951362677262306, + 0.5482973526193525, + 0.1501450725054517 + ], + "xyz": [ + 9.5489791166698, + 15.059615683429824, + 20.503081989736653 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9491813711584673, + 0.5489264356297803, + 0.3501708426723539 + ], + "xyz": [ + 12.292296151436682, + 17.764509584096498, + 20.481860275003697 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9497902942509666, + 0.5495137013745088, + 0.5488830355261455 + ], + "xyz": [ + 15.017082475493103, + 20.489592003513312, + 20.498214353472285 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9515454119703919, + 0.5499958028317864, + 0.7500164571539829 + ], + "xyz": [ + 17.773533616318637, + 23.263447593532007, + 20.528801211356715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9491676916795285, + 0.5488209994096493, + 0.9504100592759355 + ], + "xyz": [ + 20.49721717275875, + 25.970685087067928, + 20.48023174660684 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9517519704405313, + 0.7495963078757143, + 0.1487455016554053 + ], + "xyz": [ + 12.28196751838375, + 15.045803348950667, + 23.260527418449612 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9486328333448716, + 0.7516189869551946, + 0.3494913638516131 + ], + "xyz": [ + 15.05418251636753, + 17.74772036171484, + 23.245536841814847 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9497556339058332, + 0.7483358803314851, + 0.5512412625000815 + ], + "xyz": [ + 17.76758477290747, + 20.52135938822031, + 23.21600152618005 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.950186022395775, + 0.7509248685642965, + 0.7507306149734118 + ], + "xyz": [ + 20.530363472940508, + 23.25462610111679, + 23.257281901245722 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.948734190186134, + 0.7503789001786992, + 0.9492867819263547 + ], + "xyz": [ + 23.237523265917517, + 25.949401086946963, + 23.22996833111173 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9505012953148178, + 0.949852264559717, + 0.14832667345638118 + ], + "xyz": [ + 15.01410476834725, + 15.022978200005452, + 25.98129180696386 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9481051638920219, + 0.950503371411322, + 0.35073481482858637 + ], + "xyz": [ + 17.790294259398504, + 17.757506397871985, + 25.95743414513096 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9513408481403577, + 0.9508189898648397, + 0.549003328510344 + ], + "xyz": [ + 20.5053007688082, + 20.512435521216595, + 26.005986916436214 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9493211053533004, + 0.9487459223168618, + 0.7516421816380272 + ], + "xyz": [ + 23.24740008741253, + 23.25526388635377, + 25.950030750241474 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494541158572519, + 0.9504756681125204, + 0.9485708311049367 + ], + "xyz": [ + 25.96342190893121, + 25.949455430376588, + 25.975498019073612 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09793541679331759, + 0.09959251629986078, + 0.10196943947080185 + ], + "xyz": [ + 2.7557187781444603, + 2.733063211968913, + 2.7005663462219776 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10082048087758234, + 0.09871645045607946, + 0.29848053913689687 + ], + "xyz": [ + 5.430405746257045, + 5.4591716714543566, + 2.7280330085461837 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10230054970217371, + 0.09999058802294034, + 0.49942126418013816 + ], + "xyz": [ + 8.195050949187092, + 8.226632329472467, + 2.7656880225729683 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09828724929591012, + 0.10232619727240633, + 0.6995770745618479 + ], + "xyz": [ + 10.963477189928993, + 10.908257420204972, + 2.74275093106164 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09889803286058407, + 0.0982420129917466, + 0.9017175133244714 + ], + "xyz": [ + 13.671266651080593, + 13.680235636643763, + 2.695263221684811 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09957787651475973, + 0.29797065934732414, + 0.10201902363598978 + ], + "xyz": [ + 5.46858694760493, + 2.75619653141902, + 5.435212023569955 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09813115463082675, + 0.29906556728026384, + 0.30176560429575805 + ], + "xyz": [ + 8.214455628176486, + 5.46731650662766, + 5.430402086558486 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10000684950350397, + 0.2996780220460047, + 0.5022077475418145 + ], + "xyz": [ + 10.963237902366137, + 8.233369572176125, + 5.464419620548003 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09818504562733582, + 0.3022718051268547, + 0.6997849674704124 + ], + "xyz": [ + 13.699939824730768, + 10.909702384470055, + 5.474973981278157 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10025247442701316, + 0.29934340099136897, + 0.90219997983398 + ], + "xyz": [ + 16.42728482483562, + 13.70534951321453, + 5.463202881462545 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09861459250548205, + 0.4987786130609116, + 0.10036770379441456 + ], + "xyz": [ + 8.191420597708984, + 2.7204501381988524, + 8.16745237572673 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10215042320636016, + 0.5001338466565906, + 0.298048947997849 + ], + "xyz": [ + 10.912611495612458, + 5.47145376721713, + 8.234322126397686 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10101690351245056, + 0.49849124846709947, + 0.5018472502999786 + ], + "xyz": [ + 13.676447894213712, + 8.242250195375844, + 8.19636754239705 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09807543695868944, + 0.4991016294782659, + 0.7015908873862544 + ], + "xyz": [ + 16.415651965918684, + 10.93289404650569, + 8.164497360454094 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10166161197569805, + 0.5012408870020646, + 0.8987018319994734 + ], + "xyz": [ + 19.139764864499604, + 13.676788940608628, + 8.242774443574154 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09896474516029401, + 0.6998832914795701, + 0.09873058338994707 + ], + "xyz": [ + 10.91850514671856, + 2.7028549467797567, + 10.921706564293626 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0976474600448203, + 0.7013290014477388, + 0.3011181389119611 + ], + "xyz": [ + 13.705276862512552, + 5.451851491129302, + 10.923462365763198 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10222427882568157, + 0.6981191972325584, + 0.4999178435150255 + ], + "xyz": [ + 16.379346774433632, + 8.232378711060125, + 10.942151942842566 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09756612856027315, + 0.7002919940338546, + 0.7007124259137861 + ], + "xyz": [ + 19.15428024872855, + 10.913920706629533, + 10.908172637644846 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09763528081560102, + 0.7002411685844936, + 0.9016340865218401 + ], + "xyz": [ + 21.900550150267872, + 13.661830921751372, + 10.9084231984372 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10241118349404338, + 0.8999041600484701, + 0.09867428961175162 + ], + "xyz": [ + 13.65238481963361, + 2.74920439291727, + 13.703474960151405 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09989877609564404, + 0.9024201991830197, + 0.29888198172259767 + ], + "xyz": [ + 16.423987182949038, + 5.452058740354593, + 13.70352461259434 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10008118741238403, + 0.9019186398958551, + 0.4978016607381558 + ], + "xyz": [ + 19.13672400061408, + 8.174146681001513, + 13.699161278989328 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09915000808337925, + 0.9015315736912163, + 0.6980375753895532 + ], + "xyz": [ + 21.869021483785446, + 10.899005147476906, + 13.681138463337549 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10151878718532233, + 0.9004903964215974, + 0.897582209625211 + ], + "xyz": [ + 24.582925016802875, + 13.659528990214184, + 13.699289196620757 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.299118484438048, + 0.10237979607907263, + 0.09854483154304344 + ], + "xyz": [ + 2.7470053424165988, + 5.436781276696606, + 5.48921222153958 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29842278942619405, + 0.10209387047606848, + 0.3006232928309605 + ], + "xyz": [ + 5.505876567644305, + 8.19005020832501, + 5.47579168118495 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30105015285831016, + 0.10136361298872712, + 0.4999516676279858 + ], + "xyz": [ + 8.221074279841186, + 10.951152709360949, + 5.501728572182841 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3013613514969049, + 0.10053108698491851, + 0.7005759305487557 + ], + "xyz": [ + 10.952590944457237, + 13.698306171417501, + 5.494601078284563 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30108005636490254, + 0.09749623648347568, + 0.9009474893402358 + ], + "xyz": [ + 13.650542899591134, + 16.433904239922423, + 5.449263332090314 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2999763492159296, + 0.30201388158793613, + 0.09788170046008199 + ], + "xyz": [ + 5.467300416555735, + 5.439443640721488, + 8.230302077308906 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29930921561115986, + 0.30252506751876906, + 0.29919337224686077 + ], + "xyz": [ + 8.226586199156532, + 8.182619650729043, + 8.228169988781424 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30241011029566484, + 0.2995194789481201, + 0.49960908842732205 + ], + "xyz": [ + 10.925541930014916, + 10.965062121484905, + 8.229472996814962 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3016023650137426, + 0.29904267299785964, + 0.6981173868772808 + ], + "xyz": [ + 13.632992849802141, + 13.66798849829873, + 8.211910843587782 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2998214014268075, + 0.2977442226935668, + 0.9017052203585973 + ], + "xyz": [ + 16.39865688450944, + 16.427055698258133, + 8.169809651161415 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2995419462474146, + 0.500683036037911, + 0.09790531146957693 + ], + "xyz": [ + 8.183792141219822, + 5.433827367000319, + 10.940531917308158 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3009246063327592, + 0.49749820800216993, + 0.30110659878354 + ], + "xyz": [ + 10.918381169509004, + 8.230862270733121, + 10.915893001480569 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2999640504888495, + 0.4992314976014217, + 0.4984471795090887 + ], + "xyz": [ + 13.640083291293017, + 10.91573462251041, + 10.92645767829153 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30252669447238417, + 0.4992855213854221, + 0.6992014679668141 + ], + "xyz": [ + 16.38549839076569, + 13.695447125799479, + 10.962232289009071 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3008134995887919, + 0.4982783180746786, + 0.8989505112500944 + ], + "xyz": [ + 19.102661053339016, + 16.4029575986673, + 10.925039494567788 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3000906555802715, + 0.7006972143260348, + 0.10157522441146076 + ], + "xyz": [ + 10.968524373380065, + 5.491503611388564, + 13.682591615542435 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29860927258878195, + 0.6985062897459707, + 0.3017847020980046 + ], + "xyz": [ + 13.675798388112296, + 8.2084783510023, + 13.632384487439516 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2980453108334251, + 0.6994154005691847, + 0.5020355794881642 + ], + "xyz": [ + 16.426021538167664, + 10.93856191791651, + 13.637103303368429 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30104154493841245, + 0.7013642973082582, + 0.6999632074051299 + ], + "xyz": [ + 19.158697405490592, + 13.685556793185487, + 13.704712242144875 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29847881537748144, + 0.702336555288144, + 0.8991158878521024 + ], + "xyz": [ + 21.89476954117368, + 16.373299215508286, + 13.68296760097371 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29970336189150354, + 0.9024712940710543, + 0.09891584384802103 + ], + "xyz": [ + 13.690784699944771, + 5.449850029413747, + 16.435915504882015 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3004165226688715, + 0.8977579166851035, + 0.29999269652492516 + ], + "xyz": [ + 16.375430788697134, + 8.208686771158131, + 16.38122526344846 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30082322899209885, + 0.8975863762216243, + 0.5001659480599226 + ], + "xyz": [ + 19.109818182158936, + 10.950979850603368, + 16.384440408753083 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29952887418288526, + 0.9023619685748309, + 0.6997514913490148 + ], + "xyz": [ + 21.90380684365603, + 13.661981287086341, + 16.432035261831796 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29857236253717456, + 0.9018442711320747, + 0.8985600995484935 + ], + "xyz": [ + 24.614804483158004, + 16.366979537792076, + 16.411880140531913 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49866153962855597, + 0.09978845491624096, + 0.10243668666382673 + ], + "xyz": [ + 2.7647857351572007, + 8.218106752188723, + 8.181900604417445 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4987130948942111, + 0.10186067473100555, + 0.300993160490197 + ], + "xyz": [ + 5.50774512145394, + 10.933439976489657, + 8.210936475037428 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5005680135606133, + 0.0975836634650213, + 0.5003366232383475 + ], + "xyz": [ + 8.174658534156851, + 13.684188031480767, + 8.17782206099261 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49768589115455153, + 0.10164814692435344, + 0.6999678561334182 + ], + "xyz": [ + 10.959549702925301, + 16.374106455246608, + 8.193987088487933 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5015765441318678, + 0.10082216097606374, + 0.8976778073451985 + ], + "xyz": [ + 13.651311836894, + 19.130353627611182, + 8.235886664468719 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.497799306492656, + 0.30013875881848723, + 0.10191747163044636 + ], + "xyz": [ + 5.496840412576338, + 8.199219841478993, + 10.909265600082193 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5017574347744778, + 0.29790632406669204, + 0.2994500370212259 + ], + "xyz": [ + 8.166948644649018, + 10.953964337045937, + 10.932858971399881 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4976837371640509, + 0.2999820752628563, + 0.5016519970331816 + ], + "xyz": [ + 10.959796742298415, + 13.662738277512407, + 10.905543407654438 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4984444587622499, + 0.29900538869175297, + 0.7003005831352536 + ], + "xyz": [ + 13.662331371743903, + 16.389026438715124, + 10.902590773418584 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4976458199568358, + 0.30125957287812877, + 0.9011923241317883 + ], + "xyz": [ + 16.439705894578122, + 19.124663315113732, + 10.922490727868924 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5023524646247082, + 0.5000081894463193, + 0.09847371613717801 + ], + "xyz": [ + 8.18233688639457, + 8.21438739466397, + 13.704094437541354 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5016148741566279, + 0.4993786319642165, + 0.30109579661981883 + ], + "xyz": [ + 10.943942302203785, + 10.974515802934839, + 13.685403036853081 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5018563121556274, + 0.4998892617987255, + 0.5004647856317641 + ], + "xyz": [ + 13.676660472741116, + 13.703553631151614, + 13.6956851729006 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49936453098950245, + 0.4996059961072025, + 0.6985820044744151 + ], + "xyz": [ + 16.38141067011177, + 16.378109402486295, + 13.65774523177127 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.497646790092744, + 0.501667930550957, + 0.900394984034471 + ], + "xyz": [ + 19.168751796887346, + 19.11377548834794, + 13.662450983990963 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4975075801571757, + 0.7005920987526174, + 0.10125961589171047 + ], + "xyz": [ + 10.962772309308614, + 8.186237326285083, + 16.380203152112486 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5022766203334921, + 0.6982066846468212, + 0.2999068416191069 + ], + "xyz": [ + 13.64602847067304, + 10.96730789879278, + 16.412791658695944 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49966430362498265, + 0.6995537836611528, + 0.49839817210763687 + ], + "xyz": [ + 16.378183507918852, + 13.645330516970741, + 16.39549383012033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4976813943089304, + 0.6998096436415877, + 0.7012430842035378 + ], + "xyz": [ + 19.15494070560754, + 16.39147966381633, + 16.37188192247265 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5006090833621442, + 0.6998092521148908, + 0.9017989412436346 + ], + "xyz": [ + 21.89689893012295, + 19.173470078965774, + 16.411903407341633 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500086954132474, + 0.8990469749091483, + 0.10233947399830859 + ], + "xyz": [ + 13.690775279901947, + 8.236265688646995, + 19.12870723374983 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4995278932775281, + 0.9021713370605275, + 0.29810669146290886 + ], + "xyz": [ + 16.409985155927288, + 10.905116468346, + 19.163779571320436 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500115784193788, + 0.9022238482183592, + 0.4981729067739526 + ], + "xyz": [ + 19.145972362838986, + 13.648423290946573, + 19.17253503320504 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5009024017862104, + 0.9018931120601572, + 0.6989587692771871 + ], + "xyz": [ + 21.88655876830553, + 16.40428595576798, + 19.178767762115044 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4992204641941219, + 0.9025296756183254, + 0.8990213842980311 + ], + "xyz": [ + 24.63048181198564, + 19.116510869051986, + 19.16447559649061 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.699910881080612, + 0.10036851788999582, + 0.09781370658301866 + ], + "xyz": [ + 2.7095117001946485, + 10.906346972111377, + 10.941275892434334 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7014128903143169, + 0.10087822251588142, + 0.30011296258033676 + ], + "xyz": [ + 5.482279304222177, + 13.692681186122183, + 10.96877968221416 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6996845470198962, + 0.1018857509803479, + 0.5005697287996189 + ], + "xyz": [ + 8.236662877565346, + 16.40966041323476, + 10.958924831605696 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.701582162364767, + 0.099970048803539, + 0.6976664833632304 + ], + "xyz": [ + 10.905143093208281, + 19.130275619636947, + 10.958677551695068 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6979961803891057, + 0.09923662050992592, + 0.9016416075355502 + ], + "xyz": [ + 13.6838269757567, + 21.869959901704068, + 10.899623351987398 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7013997488619513, + 0.29969023048028004, + 0.10117410768457137 + ], + "xyz": [ + 5.480545075808978, + 10.972645303409879, + 13.686722001370704 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998232004908146, + 0.3010532446726126, + 0.29768624916167397 + ], + "xyz": [ + 8.185858586593474, + 13.637769643947886, + 13.683802600514246 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6979393324146782, + 0.302041894084351, + 0.4997410451950817 + ], + "xyz": [ + 10.961832024899332, + 16.374470540212666, + 13.671563332073957 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000137984924424, + 0.30128559162005564, + 0.7010913864191003 + ], + "xyz": [ + 13.704317615895292, + 19.155657889177327, + 13.689585027727851 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6987170989908137, + 0.2990486979750368, + 0.8997917278318799 + ], + "xyz": [ + 16.39033051035552, + 21.854524948731036, + 13.641274378273653 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6980661051160004, + 0.49910367286212676, + 0.10133947092635605 + ], + "xyz": [ + 8.209150582110254, + 10.929329142647408, + 16.367489713956918 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7002530485114227, + 0.5018286963742985, + 0.30018078178167856 + ], + "xyz": [ + 10.96492922364245, + 13.677751249677828, + 16.434645241363498 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6984217185750813, + 0.5011393691374292, + 0.4986906630468607 + ], + "xyz": [ + 13.669496230617817, + 16.3667050013065, + 16.400183270209652 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7007219285538666, + 0.5020185329475336, + 0.6989531515573293 + ], + "xyz": [ + 16.41946869564727, + 19.136105753765847, + 16.44365109636407 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6977757647108229, + 0.49978176574495803, + 0.901760769480388 + ], + "xyz": [ + 19.161637263944588, + 21.86857557888608, + 16.372790996035953 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6978799145163085, + 0.6995220755938046, + 0.10177956246575318 + ], + "xyz": [ + 10.955251761255422, + 10.93280043059289, + 19.105028476427247 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6986975180112953, + 0.6988961461293711, + 0.3023757066538089 + ], + "xyz": [ + 13.689208542318134, + 13.686492934440864, + 19.107649009271643 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6980963109451018, + 0.6999078335606373, + 0.499786394275757 + ], + "xyz": [ + 16.40200353801817, + 16.37723672689264, + 19.113261022936452 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7003833083461871, + 0.7021252528060822, + 0.6981334251129199 + ], + "xyz": [ + 19.14408459794657, + 19.120269046840885, + 19.174844596532814 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7021048773264966, + 0.7006281624870857, + 0.8986368690968897 + ], + "xyz": [ + 21.86486364411042, + 21.885053023586178, + 19.17791362838413 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7013824755328357, + 0.901480605302701, + 0.09899144087916034 + ], + "xyz": [ + 13.678273730430094, + 10.942568117879855, + 21.914055525828907 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6980443268053383, + 0.9020492104976514, + 0.30046877816027845 + ], + "xyz": [ + 16.44060948769326, + 13.651491438731018, + 21.87619082516976 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6988677660491158, + 0.9007753107801943, + 0.4983600673278369 + ], + "xyz": [ + 19.12872704512494, + 16.368283436919686, + 21.870032210656497 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6995819947160631, + 0.8979034700545538, + 0.7019007981160394 + ], + "xyz": [ + 21.872235989660076, + 19.160820476697793, + 21.840533726960214 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7023715157774658, + 0.8996218322439293, + 0.8996381711870025 + ], + "xyz": [ + 24.59915890010708, + 21.902388078434555, + 21.902164695345867 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9019259140404885, + 0.09834365449293402, + 0.10088278981524852 + ], + "xyz": [ + 2.723788085821496, + 13.71022009354894, + 13.675505492466614 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.898378212832132, + 0.09923550526039092, + 0.30007554163912303 + ], + "xyz": [ + 5.459308757221712, + 16.385044009455193, + 13.639195183291715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.897917044746893, + 0.10198501080164446, + 0.5004205270163801 + ], + "xyz": [ + 8.235980080051224, + 19.11781958038455, + 13.670480921089604 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8984045697652201, + 0.10238757555727812, + 0.6996142027960739 + ], + "xyz": [ + 10.964823953326924, + 21.847825015078946, + 13.682650068263035 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9001618577876864, + 0.09972546928948686, + 0.8980006175721235 + ], + "xyz": [ + 13.6407314688763, + 24.584153693873752, + 13.670279556080237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9006605789569757, + 0.3018349883061302, + 0.09784601596913936 + ], + "xyz": [ + 5.464366747870716, + 13.651402434642756, + 16.440302946419074 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8996529904110171, + 0.3005996961743561, + 0.29786767857430846 + ], + "xyz": [ + 8.182138223436286, + 16.372287032646952, + 16.409638685511634 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8984468015302591, + 0.3008686543118629, + 0.49873625420858075 + ], + "xyz": [ + 10.93205438040797, + 19.102035245111384, + 16.39682503549144 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9006811873025588, + 0.29958051722333356, + 0.701854802085281 + ], + "xyz": [ + 13.6914434272299, + 21.90958359043245, + 16.409761977171183 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8995125418987276, + 0.29894839541511903, + 0.9025061988950848 + ], + "xyz": [ + 16.42607095158213, + 24.63687586075966, + 16.385142211986192 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9004639759039101, + 0.5000477610335938, + 0.10177038186739173 + ], + "xyz": [ + 8.227949322476551, + 13.70236773726484, + 19.147544375296903 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994582605901857, + 0.4978639591241759, + 0.3015822695907718 + ], + "xyz": [ + 10.929884938669595, + 16.42040994133862, + 19.1039378699352 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.898392874512405, + 0.4987520015657388, + 0.5010130416222163 + ], + "xyz": [ + 13.668607712757947, + 19.132425792327638, + 19.101513259662685 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9001476774937656, + 0.4975823129006704, + 0.7008937771150273 + ], + "xyz": [ + 16.385349376998413, + 21.889150579949582, + 19.109512837274455 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8999293248176169, + 0.4977239854084725, + 0.9017306415323996 + ], + "xyz": [ + 19.13309175770275, + 24.631970761143478, + 19.10846447981525 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8982389970981964, + 0.7022860449920053, + 0.09995531539343941 + ], + "xyz": [ + 10.96809947574493, + 13.647132965409394, + 21.882090280949658 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8992326314505924, + 0.7004115288210503, + 0.2982108978085738 + ], + "xyz": [ + 13.652986064843427, + 16.371232392196053, + 21.870047023285046 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.901518209303456, + 0.699806391411712, + 0.5009717353901763 + ], + "xyz": [ + 16.41682240957259, + 19.174590075661293, + 21.893021702549646 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9022109985534944, + 0.6984706385710009, + 0.7004008341135306 + ], + "xyz": [ + 19.12511897767783, + 21.910620506093682, + 21.884231220071417 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9016463477120789, + 0.6994870016238642, + 0.9010055855633771 + ], + "xyz": [ + 21.881646563358267, + 24.64553275439404, + 21.89040694811813 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9017121917890192, + 0.9007037019503922, + 0.09984438494924512 + ], + "xyz": [ + 13.679313345436197, + 13.693101236981734, + 24.642305664344356 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9018474734730316, + 0.9010176317036083, + 0.29850945345752256 + ], + "xyz": [ + 16.39971839344765, + 16.411063840747687, + 24.648447202256087 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000317392648961, + 0.8995391518861444, + 0.49818300115362063 + ], + "xyz": [ + 19.109405686372117, + 19.116140252348682, + 24.603409301056615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8989764871800934, + 0.9021501031980415, + 0.7004984834500549 + ], + "xyz": [ + 21.911122999907175, + 21.867733892960672, + 24.624678540863588 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.900418705194513, + 0.8998115080006153, + 0.9019248113689773 + ], + "xyz": [ + 24.63301464588358, + 24.641316136623054, + 24.612423433365414 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14870087180062933, + 0.14927108673062078, + 0.15247763752500434 + ], + "xyz": [ + 4.12545424325254, + 4.117658367368385, + 4.073818982086715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15012124378404518, + 0.15064915931004386, + 0.3515930558456006 + ], + "xyz": [ + 6.866565162009242, + 6.859347595962583, + 4.112078812429828 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14863286414156268, + 0.1502144586213939, + 0.5523055707587609 + ], + "xyz": [ + 9.604727388080185, + 9.58310411303894, + 4.085786804297045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15127086190919736, + 0.14756711835302788, + 0.7501622468596121 + ], + "xyz": [ + 12.273594289901474, + 12.324231205127584, + 4.085659075308696 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.148936410834623, + 0.15251660692948188, + 0.9491325828318891 + ], + "xyz": [ + 15.061549425563305, + 15.01260162898969, + 4.121411397327644 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14988261496555758, + 0.3503003829441301, + 0.147854344323424 + ], + "xyz": [ + 6.8106817633510905, + 4.070606114746283, + 6.838411914481625 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15087536400868837, + 0.35193143265662025, + 0.34834747826737406 + ], + "xyz": [ + 9.574087219948883, + 6.825284839486716, + 6.874284018784699 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14937415499825918, + 0.3488417814678906, + 0.5492741196137084 + ], + "xyz": [ + 12.278878938725425, + 9.55179345380539, + 6.8115186044966345 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1482969487372981, + 0.34912767968937236, + 0.7521771455254123 + ], + "xyz": [ + 15.056841335467995, + 12.311119731422806, + 6.800699983416321 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15230049998297077, + 0.3500223575728911, + 0.9493720687884464 + ], + "xyz": [ + 17.76508670621546, + 15.061869059180435, + 6.867667690389382 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15009775994238383, + 0.5501563461109592, + 0.15193372193628132 + ], + "xyz": [ + 9.598849034129623, + 4.129320054578371, + 9.573748092222216 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14994228291100836, + 0.549511505569311, + 0.35229408836348824 + ], + "xyz": [ + 12.329323755242322, + 6.8664852655180875, + 9.562806294421 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14868462968231155, + 0.5517017024594046, + 0.5511959445001416 + ], + "xyz": [ + 15.078618107654462, + 9.568641231719146, + 9.575555863501757 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15031720112408029, + 0.5482350766802838, + 0.7521895268674127 + ], + "xyz": [ + 17.779171103275466, + 12.338909533888652, + 9.55048100273126 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15047153161147678, + 0.5494831631113484, + 0.9480139983331354 + ], + "xyz": [ + 20.47351164177992, + 15.018296438007345, + 9.569654594405414 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15177746620444688, + 0.749737930940339, + 0.15068860575218607 + ], + "xyz": [ + 12.310469532883598, + 4.135261691898133, + 12.325356236992025 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15200287967480247, + 0.7491424924093826, + 0.3506837151849183 + ], + "xyz": [ + 15.036625941511915, + 6.872640641335027, + 12.320297320968 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14861917453681592, + 0.7488752595663503, + 0.550192305999768 + ], + "xyz": [ + 17.760617924258163, + 9.554024775829678, + 12.270382354060349 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15164705142427765, + 0.7492586082486402, + 0.7479839486330133 + ], + "xyz": [ + 20.470030734025727, + 12.299593099203271, + 12.31702001602939 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15017205366339037, + 0.7510607584022957, + 0.951206387058269 + ], + "xyz": [ + 23.273090004650655, + 15.057847793427195, + 12.321492784655886 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1512176611677065, + 0.9510909787051316, + 0.14757642227531112 + ], + "xyz": [ + 15.020782946072435, + 4.085058925897917, + 15.070565308786264 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15159639082782372, + 0.9495096878840535, + 0.3510530892577081 + ], + "xyz": [ + 17.781060187782277, + 6.872133214822975, + 15.054124109054616 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14789789675309026, + 0.9493835345278869, + 0.5511780424317124 + ], + "xyz": [ + 20.515407779107786, + 9.557640406865568, + 15.001834217815889 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14794559894483317, + 0.9515786176136978, + 0.7511690444322839 + ], + "xyz": [ + 23.279659540913492, + 12.292533563616136, + 15.032497174429253 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14893897917303392, + 0.9498146535499453, + 0.9524429416932212 + ], + "xyz": [ + 26.007323435797428, + 15.057895373337683, + 15.02196189093468 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34926524015374855, + 0.14942932630096847, + 0.14880308788029842 + ], + "xyz": [ + 4.077379884851728, + 6.8095005285824435, + 6.818062347546928 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3513597940968455, + 0.14818226491715183, + 0.3515138473667178 + ], + "xyz": [ + 6.831755301844854, + 9.609561908834372, + 6.829649113268748 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35023627680328645, + 0.14949302597425665, + 0.5521614760835406 + ], + "xyz": [ + 9.592894054323832, + 12.33741964587318, + 6.832209076300069 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3509488642551998, + 0.15174678488716475, + 0.7493503910064152 + ], + "xyz": [ + 12.319638391325363, + 15.04309336407085, + 6.872764429857561 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3507289828052196, + 0.15134205215582452, + 0.9503932512424692 + ], + "xyz": [ + 15.062726755706858, + 17.78870898189787, + 6.864224817201101 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3490164934676514, + 0.35252262004055335, + 0.14908121056173684 + ], + "xyz": [ + 6.857837283305002, + 6.80990215190307, + 9.591316482843743 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34974495801507843, + 0.35028596985959226, + 0.3520354589659454 + ], + "xyz": [ + 9.60201215704556, + 9.5946155404895, + 9.57069684033548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3524728044776056, + 0.349658760841969, + 0.5487655735609915 + ], + "xyz": [ + 12.283095783577082, + 12.32156888163565, + 9.599416377367465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3523809194590023, + 0.3498941692604171, + 0.7492444772335783 + ], + "xyz": [ + 15.027225729909535, + 15.061224131009556, + 9.601378603455931 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34801344086245883, + 0.35032873919251833, + 0.9520801499181418 + ], + "xyz": [ + 17.806299898320905, + 17.77464555630603, + 9.547608584119237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3493910440558186, + 0.5481752007605561, + 0.15219093385267374 + ], + "xyz": [ + 9.575279726527848, + 6.857538517208883, + 12.271364137205406 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35251130967652683, + 0.5492054604130538, + 0.3488693524578795 + ], + "xyz": [ + 12.278317188105083, + 9.589150164182417, + 12.328109371646129 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34824440521630795, + 0.5515114890648479, + 0.5513797028332065 + ], + "xyz": [ + 15.078529855215656, + 12.299498872913512, + 12.301300630550992 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3491654733245347, + 0.5499369410401292, + 0.7485179080773325 + ], + "xyz": [ + 17.752240975261095, + 15.007329607517674, + 12.292366370759098 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35126571389929484, + 0.548387926700395, + 0.9516393104133809 + ], + "xyz": [ + 20.508102380916863, + 17.813082969498524, + 12.299902636623651 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34813380871949196, + 0.7516103399703851, + 0.1512350115346745 + ], + "xyz": [ + 12.343539133613902, + 6.827280624127317, + 15.035504046941233 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35066027777741116, + 0.7479745388123724, + 0.3519254815461826 + ], + "xyz": [ + 15.037635096338498, + 9.605626036035494, + 15.020337458148534 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.352291377078123, + 0.7501858149842621, + 0.5490828822513487 + ], + "xyz": [ + 17.763367760239767, + 12.323426626185856, + 15.072869723982356 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34878268654796096, + 0.7515333230600459, + 0.7483127780321143 + ], + "xyz": [ + 20.505625921833815, + 14.999291714555163, + 15.04332242647894 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3523745166615678, + 0.7492200512286784, + 0.9499244847545091 + ], + "xyz": [ + 23.23039824994566, + 17.804797533540345, + 15.060802645173224 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34750834739252945, + 0.9511115043512832, + 0.1504039852362952 + ], + "xyz": [ + 15.059721500853245, + 6.807367787481416, + 17.75449686146809 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.350697273145455, + 0.9508738004188205, + 0.3509574520113288 + ], + "xyz": [ + 17.798402553599562, + 9.59289710449302, + 17.794845434977532 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.352389368313074, + 0.9499620446301162, + 0.548618405219532 + ], + "xyz": [ + 20.488322165863416, + 12.31841609833855, + 17.805514094504964 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35185373827300676, + 0.9491136201150658, + 0.748125283973045 + ], + "xyz": [ + 23.204344793689913, + 15.038715195924013, + 17.786591549757215 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35046578946809015, + 0.951230942533036, + 0.9475102559409536 + ], + "xyz": [ + 25.959247892120658, + 17.745694857144272, + 17.796563414507634 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5513356348159041, + 0.14792384332106748, + 0.15141700343090062 + ], + "xyz": [ + 4.092534175440492, + 9.607907574635428, + 9.56014971838261 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5511639389768067, + 0.14869013654811067, + 0.35172806491883457 + ], + "xyz": [ + 6.84162757517981, + 12.344176956700505, + 9.568278946843074 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5494806985252773, + 0.15155256104097203, + 0.5511182923065437 + ], + "xyz": [ + 9.606789426213632, + 15.047191294834304, + 9.584400538803036 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5476846061870843, + 0.15058093180839377, + 0.7500434702802281 + ], + "xyz": [ + 12.313174712963262, + 17.74230467040733, + 9.546560747677335 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5513139374119407, + 0.14943802709125664, + 0.9513896483116981 + ], + "xyz": [ + 15.050317829127623, + 20.544692937368158, + 9.580554723334101 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5510937840943546, + 0.34852926225311287, + 0.1485870098802251 + ], + "xyz": [ + 6.796484191678012, + 9.565909872677537, + 12.299484357514231 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5490768871975623, + 0.3508272020163073, + 0.3519213044116055 + ], + "xyz": [ + 9.607851085151266, + 12.31828509600605, + 12.303326724995966 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508237390224056, + 0.35124796301653355, + 0.5504094760395463 + ], + "xyz": [ + 12.327298208435693, + 15.055862294348293, + 12.332961937370007 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5481557799046105, + 0.34984873085620505, + 0.7522517091696959 + ], + "xyz": [ + 15.06771883795491, + 17.77893711727588, + 12.277356030309932 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5515064424251831, + 0.3510182848766515, + 0.9477211531699147 + ], + "xyz": [ + 17.7561318238738, + 20.497169826008967, + 12.339155617219767 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.549637115425117, + 0.5477875404888001, + 0.15161707458366397 + ], + "xyz": [ + 9.562134004440015, + 9.58742106004585, + 15.003792359217007 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5492908798649228, + 0.5482583023249893, + 0.3502203574572183 + ], + "xyz": [ + 12.28383851038358, + 12.297955724645593, + 15.005494860047682 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5521146065318223, + 0.5505576866118934, + 0.5483423549932304 + ], + "xyz": [ + 15.023963566817763, + 15.045249495717444, + 15.075537110848114 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497282087534804, + 0.551393165481233, + 0.7511592478123521 + ], + "xyz": [ + 17.8082621351155, + 17.785499146425877, + 15.054333226689637 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5482526642657547, + 0.5521013464360897, + 0.9491059269567926 + ], + "xyz": [ + 20.524235624518273, + 20.471617134648245, + 15.043841970593688 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5474699029239021, + 0.7509716436619829, + 0.15077827553635784 + ], + "xyz": [ + 12.328562580294257, + 9.54632341123655, + 17.75205910544383 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5489311451796057, + 0.7523958137571353, + 0.3499678242445637 + ], + "xyz": [ + 15.071317233304386, + 12.289584908152747, + 17.79150794373051 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.550419360150109, + 0.7475079027819115, + 0.551148934060227 + ], + "xyz": [ + 17.755002515075084, + 15.060443436150754, + 17.745027911899253 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500124511562655, + 0.7477164814251781, + 0.7517545600532743 + ], + "xyz": [ + 20.500498174305935, + 17.79752425919481, + 17.74231637504563 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5525180705959521, + 0.7489216367197262, + 0.9491802777186227 + ], + "xyz": [ + 23.216143715856507, + 20.530949512454168, + 17.793049419272638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5501114328163943, + 0.9516997636855089, + 0.1505118012531383 + ], + "xyz": [ + 15.069238117759493, + 9.578794744016516, + 20.53249235255865 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5504925139053457, + 0.9480861781093903, + 0.34936074092480845 + ], + "xyz": [ + 17.738460736590138, + 12.302631726451997, + 20.488298133060905 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5511825005815444, + 0.9482019100522132, + 0.551675084471752 + ], + "xyz": [ + 20.506048291272634, + 15.078070388483356, + 20.499313772990817 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5513785527651206, + 0.9509898317875612, + 0.7476168340869167 + ], + "xyz": [ + 23.223044586636, + 17.759631109871417, + 20.540110127295044 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5491421814666737, + 0.9491207899962553, + 0.9492038257067194 + ], + "xyz": [ + 25.95355244746024, + 20.485116907793337, + 20.4839816585063 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.751158460052416, + 0.14749422915107765, + 0.15054849046657934 + ], + "xyz": [ + 4.074786414923075, + 12.32797512024461, + 12.286217809306107 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7475164917757473, + 0.15101766584171625, + 0.350357375494157 + ], + "xyz": [ + 6.854709317636618, + 15.009933896018023, + 12.28459726679759 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7524518098086957, + 0.14939715529980552, + 0.5495632386237763 + ], + "xyz": [ + 9.556060692852304, + 17.800915379460037, + 12.329916718149708 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7507864434839924, + 0.14879402842974815, + 0.7519984800997522 + ], + "xyz": [ + 12.315473033963793, + 20.54580497395071, + 12.298902287519715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499929236238783, + 0.15233732813078196, + 0.9483980197615294 + ], + "xyz": [ + 15.049055544021058, + 23.220095267595482, + 12.336496782544398 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503760274749206, + 0.3483523756357544, + 0.1490712967796326 + ], + "xyz": [ + 6.800686913002135, + 12.297081916689883, + 15.021616956216587 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.750209747911165, + 0.3477411637247939, + 0.3502139407384257 + ], + "xyz": [ + 9.542316556302335, + 15.044794594953247, + 15.010987232722735 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7521767480032204, + 0.3481503572135216, + 0.5494199358472032 + ], + "xyz": [ + 12.271419484073476, + 17.795195574199898, + 15.043474123644357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7511725281342189, + 0.35118817802593116, + 0.7500416978430995 + ], + "xyz": [ + 15.055816641503728, + 20.52433067900122, + 15.071277149694462 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7475828061206498, + 0.35015188707009204, + 0.951385803112628 + ], + "xyz": [ + 17.794389023393915, + 23.227993011087708, + 15.008031133059045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7501529832359419, + 0.5523314691118173, + 0.148672717586475 + ], + "xyz": [ + 9.584003059785445, + 12.288583193017935, + 17.80733298529714 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7477438064853329, + 0.5517701858576187, + 0.34991300073437853 + ], + "xyz": [ + 12.3276502241122, + 15.006966290082595, + 17.76672139079421 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7507373851968833, + 0.5505767000149187, + 0.5474963194837256 + ], + "xyz": [ + 15.012656669441952, + 17.74921752832644, + 17.791331936480415 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7504323096690834, + 0.5476991291404202, + 0.751750740676338 + ], + "xyz": [ + 17.76584471915815, + 20.537576271373535, + 17.747819367744544 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7516738950995081, + 0.548840579347166, + 0.9482796582145638 + ], + "xyz": [ + 20.468358406301206, + 23.24145898927039, + 17.780399802029525 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7513103053481113, + 0.7510817472554775, + 0.1476182591683554 + ], + "xyz": [ + 12.286864721825486, + 12.289989526927517, + 20.540433712626793 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7490116616649739, + 0.7482997994816606, + 0.35207852343644874 + ], + "xyz": [ + 15.044174362838264, + 15.053906814473331, + 20.470972780733778 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7517035023849548, + 0.7511262570310258, + 0.5481459571673399 + ], + "xyz": [ + 17.7634158435215, + 17.771307838096252, + 20.546417961378587 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503145514253795, + 0.7486366975771277, + 0.7522639727982671 + ], + "xyz": [ + 20.520043803251728, + 20.542983119051335, + 20.493391665137455 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7494725236513539, + 0.7516099747936223, + 0.9510562052174913 + ], + "xyz": [ + 23.27854553319954, + 23.24932268592365, + 20.522529723889992 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7508840380779801, + 0.9519360820672432, + 0.1484265431088464 + ], + "xyz": [ + 15.043959746134965, + 12.295212390081677, + 23.280650175003863 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7475161528909215, + 0.9507319602423654, + 0.3512759789925407 + ], + "xyz": [ + 17.80081818379057, + 15.022488244526956, + 23.218142518097935 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7496499618462895, + 0.9491452279012337, + 0.5524706833482478 + ], + "xyz": [ + 20.529822447738884, + 17.802359079383578, + 23.22562205109398 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7475148883768903, + 0.9507794683354932, + 0.750451627941129 + ], + "xyz": [ + 23.258925326696644, + 20.47992857712702, + 23.218774751987496 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7514865694175409, + 0.9480900005050037, + 0.9490688590258185 + ], + "xyz": [ + 25.937614438910682, + 23.249687717700485, + 23.23630494019844 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9502585402504504, + 0.1501819825450283, + 0.1518245958194424 + ], + "xyz": [ + 4.128979578214937, + 15.06748226138308, + 15.04502474836568 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9506807880311713, + 0.15198746405688843, + 0.34920744695578676 + ], + "xyz": [ + 6.852246608281312, + 17.77183796885939, + 15.075481862262574 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.950492407693655, + 0.15181687416717105, + 0.5477613884705134 + ], + "xyz": [ + 9.564508082695145, + 20.483856215473196, + 15.070574085930476 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9521552759068632, + 0.14995973333975507, + 0.74985802944392 + ], + "xyz": [ + 12.302146485581103, + 23.269619548360943, + 15.067918025718098 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9516167113757316, + 0.1478360833688624, + 0.9510198818305089 + ], + "xyz": [ + 15.023360962132067, + 26.01250502772894, + 15.031520708245033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9509302244578823, + 0.34800662862757686, + 0.14927541158466034 + ], + "xyz": [ + 6.798750543014468, + 15.041813418959155, + 17.75883084675084 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9517449536833121, + 0.3478251800281499, + 0.3508034801567972 + ], + "xyz": [ + 9.551525288889762, + 17.80820772874388, + 17.767488945479037 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9486328221004782, + 0.3509083650176468, + 0.5519265092526839 + ], + "xyz": [ + 12.343395890746592, + 20.515377077580787, + 17.76709319286532 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.952443413266393, + 0.34858462572680604, + 0.7493158509315855 + ], + "xyz": [ + 15.01029769478773, + 23.266146343447204, + 17.787421164067997 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499589415852969, + 0.3476561193955655, + 0.9515244663529434 + ], + "xyz": [ + 17.76216311584818, + 25.99673888631819, + 17.740759543019372 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9498662244855809, + 0.5503146143419828, + 0.15196221834512394 + ], + "xyz": [ + 9.601402446668239, + 15.064000141261685, + 20.51020239589946 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494934491507093, + 0.5508829388807939, + 0.3517422028536154 + ], + "xyz": [ + 12.34052846526733, + 17.790259611785764, + 20.512875909416863 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.947637046203092, + 0.550644969922441, + 0.5515954027628414 + ], + "xyz": [ + 15.069631972086096, + 20.497236180421424, + 20.48424203370538 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9480471155744672, + 0.5501340527548876, + 0.7496696434957105 + ], + "xyz": [ + 17.77068217047285, + 23.210877940990834, + 20.482863260788637 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.95080249839945, + 0.5474668377860293, + 0.9508392565459819 + ], + "xyz": [ + 20.484571226610274, + 25.99890377809805, + 20.484068675847357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9518353126421938, + 0.7479065069105794, + 0.15075176934245138 + ], + "xyz": [ + 12.286294194441709, + 15.074372119219309, + 23.238564203397992 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9489735995040243, + 0.7482890623025559, + 0.3507234726241017 + ], + "xyz": [ + 15.025501555260973, + 17.769224424662752, + 23.204669604940435 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499367193061787, + 0.7490370676593248, + 0.5523975259526146 + ], + "xyz": [ + 17.792979505635582, + 20.539643381014073, + 23.228063800110707 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9494852851872091, + 0.7494061264396173, + 0.7486401662236501 + ], + "xyz": [ + 20.481019264959514, + 23.216465509108012, + 23.226937579307876 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9520275041493471, + 0.7504032630040464, + 0.9479684778478376 + ], + "xyz": [ + 23.2198327340136, + 25.976403066588745, + 23.275327010983105 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9476693089409884, + 0.9515731420813184, + 0.14995096851389283 + ], + "xyz": [ + 15.059839365717819, + 15.006466861713193, + 25.96610092673579 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9484262985496065, + 0.9510628832919098, + 0.3487024847074397 + ], + "xyz": [ + 17.770158153520864, + 17.734111241509346, + 25.969474186084476 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9492565763913525, + 0.9519050414428478, + 0.5507799506859448 + ], + "xyz": [ + 20.544438729086266, + 20.50822939162593, + 25.992339429937974 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9480746534421983, + 0.9512512216139488, + 0.7491001033301251 + ], + "xyz": [ + 23.246897251396884, + 23.203467783134982, + 25.96724148511013 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.949539756618862, + 0.9514320093515538, + 0.9512207560581075 + ], + "xyz": [ + 26.012726131183115, + 25.986855592427244, + 25.989743809429648 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1030347040890365, + 0.09919137455707751, + 0.09816800852176609 + ], + "xyz": [ + 2.698261960764995, + 2.750807270326623, + 2.764798546555514 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09848215362714016, + 0.09839868947809258, + 0.30290905586862926 + ], + "xyz": [ + 5.4866072589862185, + 5.48774836580845, + 2.6917194483829827 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10030328930701554, + 0.10274799941627583, + 0.49774082484311755 + ], + "xyz": [ + 8.209775117286059, + 8.176351480720072, + 2.776080670192869 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09935750441881606, + 0.10192254593827944, + 0.7014150360823617 + ], + "xyz": [ + 10.98308682062144, + 10.94801803467481, + 2.7518646180731454 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09950890967137965, + 0.10298555667895595, + 0.8994973814589097 + ], + "xyz": [ + 13.705766283292032, + 13.658234191200911, + 2.768467894937845 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09992717203186952, + 0.3025854936210187, + 0.1000718192673114 + ], + "xyz": [ + 5.5050583034929295, + 2.734350209223967, + 5.50308071252647 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10108355740340445, + 0.29974491960774574, + 0.30201397603963903 + ], + "xyz": [ + 8.227139304689826, + 5.51107691967727, + 5.480054788570583 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09775972631367462, + 0.2986675412017076, + 0.5014714693186535 + ], + "xyz": [ + 10.939356526812482, + 8.192581045069975, + 5.419882244562152 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10240271246550711, + 0.29980469066124005, + 0.7004974408842978 + ], + "xyz": [ + 13.675950688106912, + 10.977106374570928, + 5.498907218216324 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10137038501911098, + 0.29777136717355646, + 0.8986738821166091 + ], + "xyz": [ + 16.35758408815027, + 13.67242521231148, + 5.456994190462754 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10058334571173402, + 0.5022186144070876, + 0.09715216660892476 + ], + "xyz": [ + 8.194489431310338, + 2.703404332055829, + 8.241399894391707 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09979851718729571, + 0.4975607334810577, + 0.3027163342813964 + ], + "xyz": [ + 10.941244020576073, + 5.503110596606693, + 8.166988150472607 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10297178490296895, + 0.5000308794226049, + 0.4986297134645245 + ], + "xyz": [ + 13.653507867046113, + 8.224987397410663, + 8.244143886179666 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09742422944329224, + 0.4994181763910033, + 0.7007372246389323 + ], + "xyz": [ + 16.408308614909092, + 10.912319731150438, + 8.159921940933437 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10296144547867823, + 0.4980570681106524, + 0.8998850608891332 + ], + "xyz": [ + 19.112413158101848, + 13.71073692268957, + 8.217016934460881 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09776000388014272, + 0.7028576406399447, + 0.09967764137171964 + ], + "xyz": [ + 10.97211791931271, + 2.6993319471073165, + 10.94590032470262 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09836608822574738, + 0.700367868269088, + 0.2984230021079596 + ], + "xyz": [ + 13.655288997438324, + 5.424829021006181, + 10.92014688108522 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09757561350630758, + 0.7013337269272157, + 0.4989447744179022 + ], + "xyz": [ + 16.409991620260207, + 8.15551937002997, + 10.922544698725853 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09816157979135974, + 0.7019131699708325, + 0.6981832994709603 + ], + "xyz": [ + 19.14186691284369, + 10.88748384719617, + 10.938477965293734 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09815723496758653, + 0.6981981367360801, + 0.9020352103569151 + ], + "xyz": [ + 21.878102279452953, + 13.674451077836427, + 10.887627297965622 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1014154652914301, + 0.8999403326055565, + 0.0970364277011319 + ], + "xyz": [ + 13.630486811096187, + 2.7131985596535686, + 13.690356224803978 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10274019933897281, + 0.8978815632433312, + 0.30045887205358773 + ], + "xyz": [ + 16.38349473010112, + 5.5124651282462365, + 13.680320626107994 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09864665972148302, + 0.8981899501861832, + 0.5003043006648045 + ], + "xyz": [ + 19.11996166866955, + 8.188749719228452, + 13.628570700067828 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09853026897037333, + 0.902487540482367, + 0.6979896182516179 + ], + "xyz": [ + 21.881435628322468, + 10.889876524519362, + 13.685735307632163 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10063061640572385, + 0.9026694724873661, + 0.8978995403427629 + ], + "xyz": [ + 24.617055440991212, + 13.651724567637094, + 13.716938221330324 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3018657821252262, + 0.09757820081520548, + 0.09888625248585706 + ], + "xyz": [ + 2.6860266419305328, + 5.4790096818365, + 5.461126234844651 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30018985696690986, + 0.10032698443236568, + 0.3023007075195288 + ], + "xyz": [ + 5.50465333138175, + 8.237142549356982, + 5.475794162579443 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2994679498381023, + 0.10275837184183638, + 0.4976611037107446 + ], + "xyz": [ + 8.208826994249288, + 10.898204936890195, + 5.499165869270219 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2989114916344944, + 0.09872116434488962, + 0.6992148688793888 + ], + "xyz": [ + 10.909237817756352, + 13.646203938200916, + 5.4363620986720615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3019400830714324, + 0.09719377401637987, + 0.8996081856701221 + ], + "xyz": [ + 13.62809696848111, + 16.427351651546157, + 5.456886250010292 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30005463430276114, + 0.29736503067985975, + 0.10253509498872417 + ], + "xyz": [ + 5.467362536118259, + 5.504134312721914, + 8.167814124102694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30261751875035053, + 0.2974762002517561, + 0.299679790646363 + ], + "xyz": [ + 8.164209219480723, + 8.234500400556175, + 8.20437330932738 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2971954194309925, + 0.3009893735515001, + 0.49970702426595065 + ], + "xyz": [ + 10.946977025608577, + 10.895106767784739, + 8.1782748163939 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30194710387249324, + 0.2979118085421364, + 0.7016850238295423 + ], + "xyz": [ + 13.666307964755763, + 13.721477796159244, + 8.201163075928582 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29902613890909907, + 0.30292146318396046, + 0.8980274817835183 + ], + "xyz": [ + 16.419157804785275, + 16.36590163245774, + 8.229719265247931 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3016208916420294, + 0.5017782978576736, + 0.09734963612099229 + ], + "xyz": [ + 8.191169270328203, + 5.454653240881035, + 10.983929106985828 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3003759103681959, + 0.5004001968199029, + 0.2970848765410796 + ], + "xyz": [ + 10.903072375678146, + 8.16837633568197, + 10.948066797776391 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3027476204397969, + 0.49782443868344095, + 0.5003953992841268 + ], + "xyz": [ + 13.64748194512175, + 10.980426799921934, + 10.945277089362264 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29930872010144605, + 0.49792585103061576, + 0.7029272275012514 + ], + "xyz": [ + 16.41784713613355, + 13.70238947315351, + 10.899647554294745 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29696248434602457, + 0.5011058304009404, + 0.9016937627131275 + ], + "xyz": [ + 19.178823533128774, + 16.387812451668257, + 10.911046346923849 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2987055159920293, + 0.6988955183616828, + 0.09924990403980911 + ], + "xyz": [ + 10.912100548897165, + 5.440774870699689, + 13.639021773497767 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30222121052725265, + 0.6972676265369394, + 0.3009053955819699 + ], + "xyz": [ + 13.646841887265746, + 8.24583839593619, + 13.664831472350961 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2992923102742999, + 0.6976109071092129, + 0.500459543152713 + ], + "xyz": [ + 16.379803543300003, + 10.934063384720503, + 13.629481345488257 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29928183367876654, + 0.7030931723865785, + 0.6992977784855762 + ], + "xyz": [ + 19.17323664995294, + 13.652400713180702, + 13.704290655424305 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2986871495939717, + 0.6978145517256473, + 0.9023639640724916 + ], + "xyz": [ + 21.87735263585931, + 16.420554636847424, + 13.623991890135592 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3004825900224281, + 0.8982636518086279, + 0.09846573950746171 + ], + "xyz": [ + 13.627104826783139, + 5.454349750633338, + 16.389042843990666 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3023637344414196, + 0.8982226113234563, + 0.30119956785059526 + ], + "xyz": [ + 16.39828413767538, + 8.251808827542014, + 16.414200413755143 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2989583732501227, + 0.8986085359227212, + 0.5031392619080401 + ], + "xyz": [ + 19.164443577338556, + 10.966134490308072, + 16.372919220167468 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29863186960824756, + 0.897877695573263, + 0.702418744330577 + ], + "xyz": [ + 21.878964873006115, + 13.686183804661098, + 16.358463403439877 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29805143823065655, + 0.8993779421835274, + 0.8995696597610406 + ], + "xyz": [ + 24.59488780321778, + 16.373660079944845, + 16.371038951734246 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5001300861854068, + 0.09700460727832189, + 0.10180716010455518 + ], + "xyz": [ + 2.718118697540566, + 8.229577682572026, + 8.163918044791274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49854782690196037, + 0.09833554503619273, + 0.3002094442788705 + ], + "xyz": [ + 5.448835355817467, + 10.920465635275505, + 8.160482022131479 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5021882360368695, + 0.0994083331958835, + 0.5010674375319527 + ], + "xyz": [ + 8.209596651752245, + 13.716330983011693, + 8.224920007167736 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49882474603792665, + 0.10316459449679505, + 0.6990149057732594 + ], + "xyz": [ + 10.967253735382135, + 16.376648108425208, + 8.230289905709418 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4981376472474085, + 0.09935979522189556, + 0.8994672966386226 + ], + "xyz": [ + 13.655784211040467, + 19.107803223919916, + 8.16887748390068 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5015310381368634, + 0.30095960472136285, + 0.09688275021144606 + ], + "xyz": [ + 5.439229065017475, + 8.181405599816184, + 10.971507620841953 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5011797004810843, + 0.3013281523198314, + 0.30062682568871985 + ], + "xyz": [ + 8.22982010743687, + 10.96215450061885, + 10.971742912080614 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4979208566523521, + 0.30288051803374133, + 0.49913375944268384 + ], + "xyz": [ + 10.964994839087739, + 13.631551241420434, + 10.948412250460825 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5022245210305427, + 0.2971510352455332, + 0.7000726988803195 + ], + "xyz": [ + 13.633863392696515, + 16.43759117712172, + 10.92891871780638 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5026225432467621, + 0.2981520393572788, + 0.8984332764693753 + ], + "xyz": [ + 16.359499052625164, + 19.15498297711148, + 10.948045953937578 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5017376879596613, + 0.5008937013411908, + 0.09693867722072631 + ], + "xyz": [ + 8.173456669870388, + 8.184995503000527, + 13.707795880871176 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5020121260906376, + 0.5016306081637456, + 0.29830612929401246 + ], + "xyz": [ + 10.936591085909726, + 10.941807130332965, + 13.721622807033759 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5009827127752253, + 0.5011782620549151, + 0.501003483495268 + ], + "xyz": [ + 13.701648432447904, + 13.698974917894855, + 13.70136445890221 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49938620352169727, + 0.4988426247244388, + 0.6986394766686493 + ], + "xyz": [ + 16.371759743468047, + 16.379191454939985, + 13.647604858592087 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49841048603648724, + 0.5031030517869949, + 0.8990509837441457 + ], + "xyz": [ + 19.169997586055356, + 19.10584167177625, + 13.692512816685838 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5005152195062953, + 0.7027569900792887, + 0.0980857960664247 + ], + "xyz": [ + 10.948978420482687, + 8.183965336727423, + 16.450921060456377 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5014267034593091, + 0.6981468245545641, + 0.2982366075103536 + ], + "xyz": [ + 13.62237493417378, + 10.932852848181252, + 16.40035335177063 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4997781522801343, + 0.6971848206941876, + 0.5008905867754204 + ], + "xyz": [ + 16.379871317351135, + 13.680962879994512, + 16.36466231316979 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5001878273342399, + 0.7028920458241058, + 0.6988012261350883 + ], + "xyz": [ + 19.16369810943715, + 16.39236252100303, + 16.44829147144373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4984165315080803, + 0.6993231534713796, + 0.899148391151322 + ], + "xyz": [ + 21.85401523320354, + 19.10725606091327, + 16.375281379895878 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5023751698214147, + 0.8974002456084221, + 0.09942329743912807 + ], + "xyz": [ + 13.628392052308357, + 8.227680320662033, + 19.13747752018195 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49796085643062094, + 0.9008573765657268, + 0.29861815521469365 + ], + "xyz": [ + 16.399013564906188, + 10.890684862992643, + 19.124391094244125 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5010387059297349, + 0.9016135047890392, + 0.5004310774606492 + ], + "xyz": [ + 19.168501160492934, + 13.691914613952319, + 19.176808547549147 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49752208515425006, + 0.8989713695923623, + 0.701633420255352 + ], + "xyz": [ + 21.883180577935775, + 16.394638221969103, + 19.092607144473828 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49992845414130505, + 0.897320824276073, + 0.9024727361840181 + ], + "xyz": [ + 24.60645359576948, + 19.17337664191356, + 19.102940629652274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6975902315611598, + 0.1027309702485078, + 0.09966905567904166 + ], + "xyz": [ + 2.767176722476789, + 10.89998546847633, + 10.94184741332545 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6969857671799474, + 0.10183577354817042, + 0.3002540025891667 + ], + "xyz": [ + 5.497299043189967, + 13.634082629124768, + 10.921344316957494 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7008248286576274, + 0.09949945988461055, + 0.5023269657341134 + ], + "xyz": [ + 8.228062562302581, + 16.449274765600887, + 10.941889614577539 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7010002512865785, + 0.10244904104774535, + 0.6978129211385407 + ], + "xyz": [ + 10.941037499857707, + 19.12432190702519, + 10.984614103922254 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7009484679798607, + 0.10153811757324623, + 0.9006299197651457 + ], + "xyz": [ + 13.701461016243773, + 21.89649143313993, + 10.971452150096676 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7026591613441462, + 0.30049360025356114, + 0.099161883509054 + ], + "xyz": [ + 5.464017836015396, + 10.96235299744488, + 13.714923989066767 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7009740408228349, + 0.3018962871712343, + 0.2970301129774555 + ], + "xyz": [ + 8.18841393608086, + 13.644533150009885, + 13.711062607675874 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6982895157323781, + 0.2994148257951794, + 0.503080650011196 + ], + "xyz": [ + 10.971573696039117, + 16.424916659416308, + 13.640434170583289 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6987179945437381, + 0.2978212176185765, + 0.7024359591542901 + ], + "xyz": [ + 13.675336074546811, + 19.156324647247775, + 13.624504731624974 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6974559591924933, + 0.30257437142653704, + 0.900355516253225 + ], + "xyz": [ + 16.446240896977923, + 21.844990886228278, + 13.672234674763871 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7016655472642539, + 0.49915822423028944, + 0.10177361964206287 + ], + "xyz": [ + 8.215832001690902, + 10.984475670893119, + 16.417446455594526 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7000214398004776, + 0.5027552336516465, + 0.2995935165259801 + ], + "xyz": [ + 10.969567689653479, + 13.66655575220319, + 16.444146179636217 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6968540477588702, + 0.5007041655634207, + 0.5012011987549685 + ], + "xyz": [ + 13.697869797995438, + 16.37959568039283, + 16.37280033206396 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7019347335480338, + 0.500188857916188, + 0.7008540748166628 + ], + "xyz": [ + 16.420442788595643, + 19.178676085976626, + 16.435217360252373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6990532561519832, + 0.49785659063923643, + 0.902792022966254 + ], + "xyz": [ + 19.149415728463815, + 21.900140323954297, + 16.36393598155713 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6983471500032504, + 0.6988025672140017, + 0.10302935258813271 + ], + "xyz": [ + 10.962501677789215, + 10.956275295658923, + 19.10157944684517 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6973788540518635, + 0.699647825425353, + 0.30049669788607075 + ], + "xyz": [ + 13.673795896699588, + 13.642774928496086, + 19.099897297010195 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6983076229190427, + 0.6984106205438508, + 0.5027809596829634 + ], + "xyz": [ + 16.422475070376564, + 16.421066905389758, + 19.095680415340855 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.702590672060267, + 0.697675381205851, + 0.7006492696838831 + ], + "xyz": [ + 19.11764292852728, + 19.184843900336503, + 19.144185432364775 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7017581943450862, + 0.7011275589804005, + 0.8970001424847713 + ], + "xyz": [ + 21.84931427144556, + 21.85793620463718, + 19.180001500030453 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6978402203301317, + 0.9025295811901849, + 0.10087410719185105 + ], + "xyz": [ + 13.718354614895285, + 10.919878517301592, + 21.87996785982149 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7026593440204668, + 0.8989778117225468, + 0.29778183602360897 + ], + "xyz": [ + 16.361882487248845, + 13.677851734150195, + 21.897294898630445 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6989715884894201, + 0.8989660190304325, + 0.49889562567983003 + ], + "xyz": [ + 19.11131279138266, + 16.377024936023435, + 21.846715341242067 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7003829544500614, + 0.897230270845998, + 0.7000296861347052 + ], + "xyz": [ + 21.837450625047914, + 19.146189547799622, + 21.842280445867168 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6994883143273015, + 0.8997706206141172, + 0.8978421164592653 + ], + "xyz": [ + 24.576637770974607, + 21.838414130236398, + 21.864780291910787 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9031040209462046, + 0.09909179742981657, + 0.0983999880466284 + ], + "xyz": [ + 2.7000721425125693, + 13.692382540228392, + 13.701840833589653 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9015332512331732, + 0.09794005957434856, + 0.29844099901524074 + ], + "xyz": [ + 5.4192504844463185, + 16.405831954031267, + 13.66461920016449 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9002791767490564, + 0.10141416839000833, + 0.5013740571207559 + ], + "xyz": [ + 8.241212117302576, + 19.163150715885976, + 13.694971109939166 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8992132071632629, + 0.09793901892600584, + 0.6999317061002847 + ], + "xyz": [ + 10.908344935828937, + 21.863221408054834, + 13.632885747691784 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.89938263550703, + 0.09829101912028619, + 0.8992439142975035 + ], + "xyz": [ + 13.638118053400005, + 24.590498436148614, + 13.640014624806833 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8979437483807462, + 0.29843626228483316, + 0.10208311893653275 + ], + "xyz": [ + 5.475828886569894, + 13.67218732512572, + 16.35669215741788 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.900539737574017, + 0.3023314297496355, + 0.29989221889515877 + ], + "xyz": [ + 8.233493324014871, + 16.412089631094403, + 16.445438082838855 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9007530203409275, + 0.3023002826853168, + 0.4972785406077795 + ], + "xyz": [ + 10.931697747875019, + 19.113635855609747, + 16.447928209380265 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9027484941250211, + 0.299695427998088, + 0.6999488164056937 + ], + "xyz": [ + 13.666956173524511, + 21.911789144060037, + 16.439596863361164 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8983539832770155, + 0.30218002235136393, + 0.9014315777662963 + ], + "xyz": [ + 16.45556114672063, + 24.60634422918317, + 16.41348482883019 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9024189190169676, + 0.4999607870197601, + 0.09727871069368935 + ], + "xyz": [ + 8.165350909628692, + 13.667686047830752, + 19.173082912587052 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9020074011966916, + 0.499054695288066, + 0.30145484153966046 + ], + "xyz": [ + 10.944422295792046, + 16.453519159487712, + 19.155068791962236 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9019566647235815, + 0.5016895476421596, + 0.4983256572257511 + ], + "xyz": [ + 13.672027878217197, + 19.14440785487332, + 19.190398359146183 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.899256802730219, + 0.4988470782157882, + 0.7031498311922003 + ], + "xyz": [ + 16.433485385982323, + 21.90781506579321, + 19.11462460159524 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9026339382990841, + 0.4985877051958485, + 0.9007486611497406 + ], + "xyz": [ + 19.131474920130948, + 24.655522290796426, + 19.157250089966887 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8999163832129508, + 0.6992547860392299, + 0.09791751873322785 + ], + "xyz": [ + 10.898796259834182, + 13.642205497305802, + 21.863580375205345 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8990098615504792, + 0.7005288273342755, + 0.3026809989025384 + ], + "xyz": [ + 13.715704166540997, + 16.429301139758774, + 21.868605037468363 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9015588036558024, + 0.6970580947445073, + 0.5015081416092454 + ], + "xyz": [ + 16.38658184150596, + 19.182478723613585, + 21.85600248388732 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8997976829687505, + 0.6976965971942012, + 0.6996893880017026 + ], + "xyz": [ + 19.10480966012106, + 21.867899326635257, + 21.840654249417444 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8994453306404215, + 0.7003178254346333, + 0.8975749909274907 + ], + "xyz": [ + 21.846102964596014, + 24.56853837281861, + 21.871673912490053 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9028954818182132, + 0.9001290727252365, + 0.09893513845554257 + ], + "xyz": [ + 13.659026063705598, + 13.696847910871139, + 24.65062716529822 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8996338232443406, + 0.9025866789275557, + 0.3003188208592009 + ], + "xyz": [ + 16.445907470094575, + 16.40553655870768, + 24.639634306003774 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9024992845099926, + 0.8976306301072491, + 0.49906727952302127 + ], + "xyz": [ + 19.09540241484132, + 19.16196578147784, + 24.611052169262294 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8970672492186458, + 0.9018838855496429, + 0.6999436183424721 + ], + "xyz": [ + 21.899897304262296, + 21.83404511933944, + 24.59493610334778 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8970474786044585, + 0.9001886632846473, + 0.9020153204164886 + ], + "xyz": [ + 24.63940846844486, + 24.59646275691056, + 24.57148902940231 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1488487268706593, + 0.14760238998787728, + 0.15181658491368902 + ], + "xyz": [ + 4.093602329438732, + 4.110642022959489, + 4.053026308488877 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15241632365817606, + 0.14729355388404294, + 0.3498541614460866 + ], + "xyz": [ + 6.796914077404772, + 6.86695166365816, + 4.09757949797926 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1501874501604139, + 0.14884544361561225, + 0.5480815730688172 + ], + "xyz": [ + 9.528260725246515, + 9.546608397165866, + 4.088323897784949 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14718252857876585, + 0.14991234443417545, + 0.7506750381325263 + ], + "xyz": [ + 12.312668588723083, + 12.275347037714777, + 4.0618276267557905 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15266686390836237, + 0.14886672770289724, + 0.9478543676074251 + ], + "xyz": [ + 14.99417340528557, + 15.046128183462173, + 4.122512988462651 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14943945656481047, + 0.34875101718094065, + 0.14868401529928385 + ], + "xyz": [ + 6.800842225763782, + 4.075890445100962, + 6.811170482766634 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14741268423026418, + 0.35069996230130923, + 0.34945881987003474 + ], + "xyz": [ + 9.572444841265824, + 6.793137767188548, + 6.810106443103296 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15158002058963504, + 0.35030533329239777, + 0.5469350803332569 + ], + "xyz": [ + 12.266909431815495, + 9.549972727099611, + 6.861686218911453 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14858973799166555, + 0.35031727075027697, + 0.7482347877235035 + ], + "xyz": [ + 15.019206004083, + 12.26122348716316, + 6.820966820258264 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15168877648947085, + 0.3513549977291108, + 0.9470542912967184 + ], + "xyz": [ + 17.75161808588911, + 15.021817449020576, + 6.877523933237088 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1485300681251677, + 0.5492821080608334, + 0.1490560887530374 + ], + "xyz": [ + 9.547554125963815, + 4.0685443713305816, + 9.540362466623293 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14898456864169307, + 0.5531664939300444, + 0.34888274497411714 + ], + "xyz": [ + 12.332654825434691, + 6.806752295638906, + 9.59968294028953 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1487781420449678, + 0.5489090097086434, + 0.5531585444122437 + ], + "xyz": [ + 15.067269227781026, + 9.596752028639433, + 9.538653155088056 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15296107653944227, + 0.5496418285604184, + 0.7494371213986896 + ], + "xyz": [ + 17.76077356962993, + 12.337425730534507, + 9.605860450002377 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14975866450159314, + 0.5482617083413863, + 0.9530313128968503 + ], + "xyz": [ + 20.525407953625347, + 15.077146068795585, + 9.543208893842102 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15018181365550085, + 0.7512487881019899, + 0.1516040700342288 + ], + "xyz": [ + 12.343641762923916, + 4.125962280346919, + 12.324196929720095 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1497040497537678, + 0.7486414357193867, + 0.35307145075715174 + ], + "xyz": [ + 15.062420275587666, + 6.873856143395199, + 12.282017775201581 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1504831479867972, + 0.7468909933795858, + 0.5511948603488943 + ], + "xyz": [ + 17.747196136722106, + 9.593215427924074, + 12.26873773341574 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14944648254388618, + 0.7487083101353681, + 0.7531245984580831 + ], + "xyz": [ + 20.532789196366117, + 12.339789356664342, + 12.27941065764808 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1491102332493104, + 0.7504062469551016, + 0.9527217986406007 + ], + "xyz": [ + 23.284860076336233, + 15.064049210233122, + 12.298027404388282 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14776761953207637, + 0.9522846859491666, + 0.15123283914092425 + ], + "xyz": [ + 15.087092969877204, + 4.087880450894703, + 15.039717111124565 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15192599067538676, + 0.9500233743865414, + 0.34705493641817153 + ], + "xyz": [ + 17.73342119122609, + 6.821977418656251, + 15.06565336824097 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15103319360987894, + 0.948212389026403, + 0.5524780640647219 + ], + "xyz": [ + 20.5171697503803, + 9.61827928290076, + 15.028687741598372 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15115753468449025, + 0.9480032738911094, + 0.752381212222129 + ], + "xyz": [ + 23.247350624932693, + 12.353019110732854, + 15.027528725900053 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1518905347550073, + 0.9508484868065368, + 0.9469980630479867 + ], + "xyz": [ + 25.947016417232067, + 15.023807109214928, + 15.076449409765548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.352308927118902, + 0.1505707580468938, + 0.1472238193289638 + ], + "xyz": [ + 4.071393858858797, + 6.829521793540859, + 6.875280537243429 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3513265856931812, + 0.1500735869623363, + 0.3469945595658015 + ], + "xyz": [ + 6.795826227066324, + 9.547321000174664, + 6.855052908515157 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3486586038292034, + 0.15304562849827522, + 0.5484969610537359 + ], + "xyz": [ + 9.591364006688975, + 12.265749395077865, + 6.859209957619468 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34761662470420684, + 0.14887713609241698, + 0.7513745409071153 + ], + "xyz": [ + 12.308078882635744, + 15.025209397828185, + 6.7879733287344965 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.352817568128099, + 0.15042046413118076, + 0.9482890741619243 + ], + "xyz": [ + 15.021359039826438, + 17.788495814193585, + 6.880179794203065 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3515567069995021, + 0.3507778486092323, + 0.14688062826848108 + ], + "xyz": [ + 6.803897117346258, + 6.814545529063517, + 9.602191624062606 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34957172736081377, + 0.34846829366082777, + 0.353092393442786 + ], + "xyz": [ + 9.591611433156928, + 9.60669738008507, + 9.543477520204098 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3498581895802759, + 0.3529265004147818, + 0.5479319933156714 + ], + "xyz": [ + 12.316375171753885, + 12.27442577832047, + 9.608345780368229 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3485508418789297, + 0.34901239229576614, + 0.7531328618765161 + ], + "xyz": [ + 15.06833152889769, + 15.062021294677777, + 9.536958976254288 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35295526676279043, + 0.34799313453790565, + 0.9498121194077898 + ], + "xyz": [ + 17.743359826999836, + 17.81120120559466, + 9.58324037187088 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35039409116919573, + 0.5497997118675585, + 0.1473378890853939 + ], + "xyz": [ + 9.531139795460593, + 6.804902042284303, + 12.307287640233955 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3504733983834476, + 0.5493717649291174, + 0.35260170328737395 + ], + "xyz": [ + 12.33161890223159, + 9.61231623652517, + 12.302521100679991 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34809568954031833, + 0.5519470073451959, + 0.5482528685398783 + ], + "xyz": [ + 15.041734667123073, + 12.254716143331994, + 12.30522174413331 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3483345690204427, + 0.5481878480961121, + 0.7525358031295656 + ], + "xyz": [ + 17.783259629300243, + 15.050901571367925, + 12.257093112782455 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.352948964995445, + 0.5479560576342394, + 0.9493339780669968 + ], + "xyz": [ + 20.470679855900872, + 17.80457798661995, + 12.31701130648897 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34695254139966775, + 0.7502081523099388, + 0.15133706962093335 + ], + "xyz": [ + 12.325763996098935, + 6.8125258697436735, + 15.000183515472871 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3479569376189377, + 0.748471089353299, + 0.35227773552156816 + ], + "xyz": [ + 15.049239798900704, + 9.57348240893583, + 14.990166627719564 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34742406189081393, + 0.7498282468482421, + 0.5525852377154171 + ], + "xyz": [ + 17.806362726527126, + 12.304765142542461, + 15.0014360596648 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35012255579112617, + 0.7512456335218354, + 0.7516474507212098 + ], + "xyz": [ + 20.547283727015746, + 15.063201210435482, + 15.057707638012731 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35195054009264615, + 0.7471123185054528, + 0.9498391370600421 + ], + "xyz": [ + 23.200414849229443, + 17.797834143889663, + 15.02618957143866 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3513924102339148, + 0.9516311416301886, + 0.1499381273875634 + ], + "xyz": [ + 15.06045676354228, + 6.854100870864078, + 17.814703456846683 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3501802368436967, + 0.947812703638165, + 0.35281238393204284 + ], + "xyz": [ + 17.781912084744118, + 9.611188572574171, + 17.745925843538725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3479026664538259, + 0.9514408923460942, + 0.5521563843243333 + ], + "xyz": [ + 20.556911319128282, + 12.305445331609851, + 17.76439125407192 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35309530990319404, + 0.9489722468751057, + 0.7495140290993351 + ], + "xyz": [ + 23.221398637592877, + 15.074676413161555, + 17.80163326411269 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35294968033601554, + 0.950099997455862, + 0.9485585894990348 + ], + "xyz": [ + 25.958118442301696, + 17.793986793696238, + 17.815060645828545 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5527638253620859, + 0.149995476620513, + 0.14960248359176648 + ], + "xyz": [ + 4.096049384389446, + 9.602625750081456, + 9.607998680031734 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5520730914170602, + 0.14711678648874693, + 0.34993814327679024 + ], + "xyz": [ + 6.795645529867065, + 12.332135238712077, + 9.55919815655017 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5474301693445955, + 0.14950248730098448, + 0.5524873370737395 + ], + "xyz": [ + 9.597478520682838, + 15.03787416260032, + 9.528337833780173 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508303538091613, + 0.15253340593705342, + 0.747765974954971 + ], + "xyz": [ + 12.308731081667196, + 17.75417525952404, + 9.616262717773493 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.549174653686318, + 0.1479885083865242, + 0.952938892857813 + ], + "xyz": [ + 15.051681262880352, + 20.536626027912977, + 9.531489262490725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5476896968270257, + 0.35280074797082417, + 0.14994562242045295 + ], + "xyz": [ + 6.873457881642869, + 9.537944510394063, + 12.311343272996139 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5468879811867057, + 0.35159190388619116, + 0.3507774889608334 + ], + "xyz": [ + 9.602667912513805, + 12.272720728072526, + 12.283855262337331 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5509793842636279, + 0.3474051757874943, + 0.5522871915259234 + ], + "xyz": [ + 12.30043210128293, + 15.083662036211102, + 12.282551995798132 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5480988256110387, + 0.3512783134831934, + 0.7483199141694156 + ], + "xyz": [ + 15.03350904078549, + 17.72440365490521, + 12.296122357811303 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5483115141217105, + 0.35164403762448593, + 0.9519995922503964 + ], + "xyz": [ + 17.823181051796013, + 20.511983390320296, + 12.304030311474682 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5484405598934333, + 0.5514696458725906, + 0.15214001734601387 + ], + "xyz": [ + 9.61962466578538, + 9.578211547513819, + 15.03777434939604 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5489546121515828, + 0.5480860790462108, + 0.3529356966434138 + ], + "xyz": [ + 12.318607533308922, + 12.330481961589609, + 14.998542862731815 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5477089908737299, + 0.5511261781726239, + 0.5488246632447479 + ], + "xyz": [ + 15.03832991270685, + 14.991610743050085, + 15.02307664087132 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5527739375972247, + 0.5485881403306246, + 0.7504935026119877 + ], + "xyz": [ + 17.760810387615663, + 17.818037854401112, + 15.057624084255528 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5493560190410544, + 0.5525825559881985, + 0.9475455427968398 + ], + "xyz": [ + 20.50948134353126, + 20.465368711166555, + 15.06550584885644 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5508223925198733, + 0.7515072330405147, + 0.15079900276183097 + ], + "xyz": [ + 12.336168440767224, + 9.59244142444031, + 17.805216221329022 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497727194600374, + 0.7503644295254602, + 0.347364235288142 + ], + "xyz": [ + 15.007948714171903, + 12.265494960665253, + 17.775241076242903 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5501971467506286, + 0.7527255633635632, + 0.5494431121317195 + ], + "xyz": [ + 17.803015741009915, + 15.034083684192863, + 17.813324766593407 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5481508582547484, + 0.7505773901925804, + 0.7527350923984101 + ], + "xyz": [ + 20.553017665737155, + 17.785478557858863, + 17.755978841687156 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.548768290090389, + 0.7506607442066285, + 0.9479129200638979 + ], + "xyz": [ + 23.222593394647067, + 20.46235610261158, + 17.765559859682647 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.552764360342166, + 0.9490318445329036, + 0.15036336741956563 + ], + "xyz": [ + 15.030733446676006, + 9.613035730967397, + 20.53228738973507 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5493454833216173, + 0.9505784582093446, + 0.3475271625455481 + ], + "xyz": [ + 17.747466387949157, + 12.261881377219627, + 20.50669014230183 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5507271434492447, + 0.9510735860933188, + 0.5513437568106396 + ], + "xyz": [ + 20.540779477061193, + 15.06731497559109, + 20.532349250174608 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5525530224248105, + 0.9504785033520126, + 0.7474760609712435 + ], + "xyz": [ + 23.214129171605975, + 17.773763622955837, + 20.549176474746083 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5490693384947104, + 0.9504009387141135, + 0.9527354499569959 + ], + "xyz": [ + 26.01933814136144, + 20.532404742849806, + 20.50048772534914 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7486548308845529, + 0.15060496015896466, + 0.15270734538307443 + ], + "xyz": [ + 4.14683124515576, + 12.323261428739272, + 12.294517996384583 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7520168183701098, + 0.1485485668722762, + 0.34784104023514856 + ], + "xyz": [ + 6.786549358243431, + 15.037058668436542, + 12.312367845264555 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7521796676029873, + 0.14943125169254562, + 0.5473233314512739 + ], + "xyz": [ + 9.525903244917334, + 17.766571092530025, + 12.326662198643051 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7517601822166018, + 0.1475359961470128, + 0.748945219200235 + ], + "xyz": [ + 12.256529809608809, + 20.517374121198735, + 12.295015477275232 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7470301835292725, + 0.1518801034940061, + 0.9500830852877818 + ], + "xyz": [ + 15.065842363650622, + 23.202627130878376, + 12.2897396403306 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7475019743394113, + 0.35258239903141697, + 0.15043860697921255 + ], + "xyz": [ + 6.877212650396244, + 12.276481998483588, + 15.040155537538757 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.749472155027816, + 0.3497485613162399, + 0.34786681422262505 + ], + "xyz": [ + 9.537671843599764, + 15.002620866577562, + 15.028347774126987 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7525563545441515, + 0.347916067792481, + 0.5486716606216845 + ], + "xyz": [ + 12.257986037087356, + 17.79015520230458, + 15.045460873150418 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7468460860458291, + 0.35085527237827957, + 0.751314033975934 + ], + "xyz": [ + 15.068660365999662, + 20.482575492115938, + 15.007575386129895 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7509375197438157, + 0.3485900788352026, + 0.9525161567380168 + ], + "xyz": [ + 17.788490253634652, + 23.289312043197846, + 15.032543412804593 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7504405112471576, + 0.5469574781524762, + 0.15078207247532785 + ], + "xyz": [ + 9.539369543064222, + 12.32135294458875, + 17.7377917794337 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7521775066735752, + 0.5485732203243789, + 0.35140168045351955 + ], + "xyz": [ + 12.304294847953287, + 15.087936002147956, + 17.783629804385168 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7494519864435709, + 0.5500852640874135, + 0.5476857761674718 + ], + "xyz": [ + 15.008528063577545, + 17.734234005620905, + 17.76703937255452 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503497513715628, + 0.5486616326721486, + 0.7528365897296084 + ], + "xyz": [ + 17.79384942699679, + 20.551293081993812, + 17.759849820596493 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7516658319185849, + 0.551778500469886, + 0.9474103579318432 + ], + "xyz": [ + 20.496640218073928, + 23.229463833920878, + 17.820456292435342 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7508719115424456, + 0.7474545821502212, + 0.14929806734444495 + ], + "xyz": [ + 12.260240808414164, + 12.306961920745366, + 20.484850122997273 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.747950923168844, + 0.7484086025125662, + 0.3519124679351183 + ], + "xyz": [ + 15.04339161736806, + 15.037134307762972, + 20.45795809040162 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7528230388317932, + 0.7483049754624149, + 0.5504096295752848 + ], + "xyz": [ + 17.755792311446523, + 17.817562460581257, + 20.52315200838784 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7517399563053293, + 0.7469320419359108, + 0.7508270844838056 + ], + "xyz": [ + 20.477093179767607, + 20.54282611960171, + 20.48957379899455 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7527212628775483, + 0.7490514780034859, + 0.9477910315962061 + ], + "xyz": [ + 23.19892535959526, + 23.249097997832163, + 20.531966594232138 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7475695342223106, + 0.9491022407507372, + 0.15091473777211065 + ], + "xyz": [ + 15.03923412730824, + 12.283915239538768, + 23.196591106512013 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7488144012278904, + 0.9476367695799011, + 0.3515656028357537 + ], + "xyz": [ + 17.762460979239798, + 15.044197347157409, + 23.193575046073377 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7501688121124607, + 0.9489265176745945, + 0.5528797540606087 + ], + "xyz": [ + 20.532425022034783, + 17.815045447976292, + 23.229725511689253 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.750450169052269, + 0.952293523717979, + 0.7471880193749774 + ], + "xyz": [ + 23.23500575048914, + 20.475439737303393, + 23.27960527369013 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.751176422663854, + 0.9468774484177825, + 0.9513894740748735 + ], + "xyz": [ + 25.95276367627354, + 23.277174478350467, + 23.215486875731337 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9523465720409363, + 0.14727633498724974, + 0.14975325894445457 + ], + "xyz": [ + 4.060935142907353, + 15.067710511262685, + 15.033846452766094 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9479355252702704, + 0.14882631818198216, + 0.35273540879250775 + ], + "xyz": [ + 6.85726165008437, + 17.78253888973817, + 14.994730506547373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9529717420151731, + 0.14996105606370472, + 0.5481861948822376 + ], + "xyz": [ + 9.544943548427753, + 20.523561104832755, + 15.079098687430761 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9509338445661215, + 0.14686855955589032, + 0.7507232298779126 + ], + "xyz": [ + 12.271713378616854, + 23.26474922352543, + 15.008956864723404 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9496407716359806, + 0.1506748411882771, + 0.9523661329802533 + ], + "xyz": [ + 15.080577651456796, + 26.003896038670316, + 15.04331700172294 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.952979818826137, + 0.3500181069208907, + 0.14847482646418708 + ], + "xyz": [ + 6.815305656512773, + 15.058889648573158, + 17.81435310118673 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9492698245421137, + 0.3527091414819735, + 0.3503416902404429 + ], + "xyz": [ + 9.611984422159168, + 17.76805470003445, + 17.800422067267434 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501261235723792, + 0.351975720145938, + 0.5470455878297976 + ], + "xyz": [ + 12.29125749880882, + 20.46906214738251, + 17.80210202898496 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9475020552949842, + 0.3503024665222675, + 0.7526198306647192 + ], + "xyz": [ + 15.078955121126986, + 23.24376040290159, + 17.743349817471536 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9496847618921412, + 0.3475036290109487, + 0.9501626260716006 + ], + "xyz": [ + 17.741459459562698, + 25.974371515710445, + 17.73492618651668 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9477758055096825, + 0.5510046164268695, + 0.14878293095501854 + ], + "xyz": [ + 9.567369386046643, + 14.99195366437283, + 20.491056148240588 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9490152269153631, + 0.5530839241236696, + 0.3495383096376595 + ], + "xyz": [ + 12.340488707982812, + 17.753590212116343, + 20.536429215158467 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9481785955632387, + 0.5481758535104717, + 0.5520286348466672 + ], + "xyz": [ + 15.041797728010897, + 20.510563216862757, + 20.457888683934932 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500178904309875, + 0.5529244757290033, + 0.7480322467737075 + ], + "xyz": [ + 17.78644613784701, + 23.21543582683789, + 20.547957500513483 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9480142656380759, + 0.5491680512395254, + 0.9529531622373962 + ], + "xyz": [ + 20.536730848838044, + 25.989684499776434, + 20.469207143533524 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.950280891419836, + 0.7495918737792938, + 0.15262498814069567 + ], + "xyz": [ + 12.33494653713495, + 15.078730662293266, + 23.240354468704762 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9518147427431715, + 0.7502867219990401, + 0.34697553718539914 + ], + "xyz": [ + 15.001572100363, + 17.756826924933026, + 23.27082484769186 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9507422849128907, + 0.7508927692124132, + 0.5468705390355799 + ], + "xyz": [ + 17.742786352971077, + 20.475092958715177, + 23.26444816569141 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9481214270144666, + 0.7495049240931083, + 0.749345145817984 + ], + "xyz": [ + 20.492008362811866, + 23.20745743978215, + 23.20964189959956 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9530874330729064, + 0.7495476320624787, + 0.9489706840372513 + ], + "xyz": [ + 23.221836684418605, + 26.004596206668992, + 23.278120136219258 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9469626184417431, + 0.9518581232707436, + 0.1506137912330023 + ], + "xyz": [ + 15.072797570150602, + 15.005867109319377, + 25.960335392959607 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9519867420192969, + 0.9476603270289532, + 0.3515713324760094 + ], + "xyz": [ + 17.762861387053135, + 17.822011354046417, + 25.971632791555244 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9523254221157065, + 0.9512481108677745, + 0.5483236050188043 + ], + "xyz": [ + 20.501874576692444, + 20.516603382158145, + 26.02531469971421 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9481298446945302, + 0.9529029428301736, + 0.7488065100444301 + ], + "xyz": [ + 23.265465332000062, + 23.20020839344721, + 25.990578085135994 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.948930256353339, + 0.952638257441321, + 0.9477944883878336 + ], + "xyz": [ + 25.98237442308195, + 25.931679299647257, + 25.997902438268106 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09815288751576105, + 0.09774784994105128, + 0.10096019723846612 + ], + "xyz": [ + 2.7167006535898692, + 2.722238254404538, + 2.678319620376796 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09814550960236808, + 0.09994093282277051, + 0.2983123280619464 + ], + "xyz": [ + 5.44484689722889, + 5.420300194135727, + 2.708202185276858 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10243235990660247, + 0.09790125431829821, + 0.49772571136161864 + ], + "xyz": [ + 8.143304661922, + 8.20525312192629, + 2.7389251136322814 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10338838898477706, + 0.0999831247807884, + 0.6972908426773508 + ], + "xyz": [ + 10.900186173773536, + 10.946742333022911, + 2.780458729330333 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10241246740754571, + 0.09928343185915685, + 0.9015487364210973 + ], + "xyz": [ + 13.683197254937344, + 13.725976865728517, + 2.757550029512489 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09855737838767102, + 0.2982244836454141, + 0.09950575104354585 + ], + "xyz": [ + 5.437696177225216, + 2.7078834542202994, + 5.424730196981173 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10075416867091551, + 0.3019967781409809, + 0.3009611873131218 + ], + "xyz": [ + 8.24353277125471, + 5.492180038249681, + 5.506338449641821 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09825432135986494, + 0.2995708573361441, + 0.498473674537847 + ], + "xyz": [ + 10.910721191765468, + 8.158357748874256, + 5.43899423459967 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10342454940894154, + 0.2973292783114376, + 0.6998631830301207 + ], + "xyz": [ + 13.633435836818743, + 10.98240528611502, + 5.479034196904033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10312663957026012, + 0.2970964569161572, + 0.8991713776049962 + ], + "xyz": [ + 16.355158505362994, + 13.703238077177012, + 5.4717781350049295 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09729120502954441, + 0.49923634311479553, + 0.10010680714091641 + ], + "xyz": [ + 8.194111668529047, + 2.6987900907523494, + 8.155617263270749 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10348070627114098, + 0.49879904550771786, + 0.2976144371080653 + ], + "xyz": [ + 10.888421779896115, + 5.483700603154699, + 8.234260355965237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.096667956693012, + 0.5018335073593693, + 0.4993941577731504 + ], + "xyz": [ + 13.688604416712083, + 8.149253937800767, + 8.182604286260625 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10026037308277115, + 0.5001332492902866, + 0.7028932288892343 + ], + "xyz": [ + 16.447561464904336, + 10.980571478512903, + 8.208473534232418 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10287477721466246, + 0.49707102989527746, + 0.8989282252518164 + ], + "xyz": [ + 19.085850536505138, + 13.696470325181252, + 8.202351084561817 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10002003065983157, + 0.6974122891034741, + 0.10343634729966282 + ], + "xyz": [ + 10.949058404149133, + 2.7816189773141744, + 10.902351137986356 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10213880354136594, + 0.7020306593844426, + 0.29694845793711006 + ], + "xyz": [ + 13.657862675779148, + 5.456249203226657, + 10.994460146618326 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09749536591951395, + 0.7025643109915568, + 0.5017602803584139 + ], + "xyz": [ + 16.465309034510355, + 8.192915329895499, + 10.938271891986314 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10264250961667915, + 0.7016433233559225, + 0.6974142724475338 + ], + "xyz": [ + 19.127663619457607, + 10.938232314161148, + 10.996051136951474 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1029794186087137, + 0.6995539901034307, + 0.8968658409301066 + ], + "xyz": [ + 21.82596457432093, + 13.669704416268033, + 10.972092307898869 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09808356578530955, + 0.8975739492818177, + 0.10254048781777789 + ], + "xyz": [ + 13.67338456342699, + 2.7428959485317623, + 13.61245032764505 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09906550599001218, + 0.8973599675839241, + 0.30020169638322497 + ], + "xyz": [ + 16.372847508659348, + 5.458709322750471, + 13.622949718117612 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09927232750775354, + 0.8973701205235702, + 0.4999213114450344 + ], + "xyz": [ + 19.103516945417006, + 8.192067576907505, + 13.625916153843612 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09887570303544015, + 0.9035186900159318, + 0.6999749664336664 + ], + "xyz": [ + 21.92267664212074, + 10.92174255986112, + 13.704555710807606 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10375732943559493, + 0.8992844069158583, + 0.898434208690021 + ], + "xyz": [ + 24.578085323212772, + 13.701782314776557, + 13.713406071884524 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2983034654303054, + 0.09836922662679375, + 0.10368684127458704 + ], + "xyz": [ + 2.7624741902554555, + 5.495939115014082, + 5.423237644720088 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3027344231617278, + 0.09680273747680385, + 0.3010837829643843 + ], + "xyz": [ + 5.439832887898245, + 8.2552938268791, + 5.462400143561088 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.296766761341132, + 0.09922015516570691, + 0.5022760824570548 + ], + "xyz": [ + 8.223548291455625, + 10.924369932696925, + 5.413861844836529 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2988168575250509, + 0.10378833652636989, + 0.6989370656181066 + ], + "xyz": [ + 10.974717207546895, + 13.641112041507084, + 5.504345744136096 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29867744262881185, + 0.10360908641512069, + 0.8998239334555057 + ], + "xyz": [ + 13.718755629727626, + 16.385695083577094, + 5.499989013513417 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30281250845480334, + 0.30124816997632864, + 0.0970901645130262 + ], + "xyz": [ + 5.446010008238251, + 5.4673973623350305, + 8.258608864588318 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3036994738325015, + 0.29797799909919964, + 0.29896357420335007 + ], + "xyz": [ + 8.161277740709265, + 8.239500713397517, + 8.22602610797709 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29959677793044076, + 0.30299389093299267, + 0.500545583899647 + ], + "xyz": [ + 10.985847062806378, + 10.939402345315829, + 8.238511158380465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3028973511852627, + 0.2967373589807237, + 0.6999055840043056 + ], + "xyz": [ + 13.625922920761582, + 13.710141225383442, + 8.198097823141534 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2988631331429816, + 0.3007657295458241, + 0.903127679692056 + ], + "xyz": [ + 16.45941399028663, + 16.43340203473432, + 8.198017877486066 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2983803671534153, + 0.502317716308898, + 0.10199840735615867 + ], + "xyz": [ + 8.262101265846393, + 5.473906536915483, + 10.947000071441723 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30305403639966133, + 0.5002491217887118, + 0.2968626404481509 + ], + "xyz": [ + 10.897968533185184, + 8.201952820861456, + 10.982616184182962 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3033283714655558, + 0.4971872830319603, + 0.4994801317181098 + ], + "xyz": [ + 13.626257494328302, + 10.975853349996502, + 10.944505935472229 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29911844101061064, + 0.5032510101287229, + 0.6972174084031204 + ], + "xyz": [ + 16.412588133852022, + 13.621724392731634, + 10.969850709475761 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30264608663662057, + 0.5012330867459396, + 0.8967928479920553 + ], + "xyz": [ + 19.113558935069612, + 16.39851321523502, + 10.990491360235152 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29997032387910627, + 0.7026595765428181, + 0.09659611489684516 + ], + "xyz": [ + 10.927279947338615, + 5.421784968985827, + 13.707775525186472 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30204389864064835, + 0.7004476119808635, + 0.3011809732911184 + ], + "xyz": [ + 13.694085724693185, + 8.247181868574167, + 13.705883484745396 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30241529079951535, + 0.6988354548210478, + 0.5017503099039923 + ], + "xyz": [ + 16.414192469883098, + 10.994407343010229, + 13.688919968990126 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2982791605074961, + 0.7024822063337858, + 0.7018382394673354 + ], + "xyz": [ + 19.19961635731268, + 13.673425071323898, + 13.682229270407973 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30140476688046663, + 0.7025928371742645, + 0.8968669315904267 + ], + "xyz": [ + 21.867526055792478, + 16.382554972588327, + 13.726474523067553 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2992995296234906, + 0.9037490399066654, + 0.09829286682600835 + ], + "xyz": [ + 13.699736581305903, + 5.435811677626188, + 16.447863493873776 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2962460234854722, + 0.9009531519021857, + 0.30181063582250156 + ], + "xyz": [ + 16.443970008290133, + 8.17652299585994, + 16.367891630048486 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2982356625891448, + 0.8977072848042378, + 0.5031818794033753 + ], + "xyz": [ + 19.15270449299693, + 10.956836378964177, + 16.350716707031793 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29936823207975677, + 0.9035863619681155, + 0.6976188837805759 + ], + "xyz": [ + 21.89138990293187, + 13.630628390361613, + 16.44657867799558 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30246404773881086, + 0.8993454954967797, + 0.8967369892746386 + ], + "xyz": [ + 24.55571643694757, + 16.395260721861217, + 16.43092374939921 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4974233284101937, + 0.09823134856327816, + 0.10201229684641704 + ], + "xyz": [ + 2.7376950761851786, + 8.195375970095835, + 8.143683525739451 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5021185120419296, + 0.10221819659415292, + 0.29735851576202627 + ], + "xyz": [ + 5.462940887525457, + 10.930306018270679, + 8.262382699864965 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49838041013606854, + 0.1025013699081316, + 0.4973240458430608 + ], + "xyz": [ + 8.200705115575467, + 13.613092095344578, + 8.215147538043896 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4979120850034683, + 0.09892213850038206, + 0.7036718436430784 + ], + "xyz": [ + 10.972920456948605, + 16.42783918734843, + 8.15981007358441 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5009074422838303, + 0.10311811604989808, + 0.8985399662507007 + ], + "xyz": [ + 13.69448900275897, + 19.13299306895057, + 8.258128708938234 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4994239925550201, + 0.30242760028544624, + 0.09669507680765953 + ], + "xyz": [ + 5.456733399135065, + 8.15003261489407, + 10.962770644028144 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49891915211273397, + 0.30377609832081137, + 0.29896889967001694 + ], + "xyz": [ + 8.240621118430965, + 10.908581824124449, + 10.974304978782353 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5019759487354366, + 0.2991347203955906, + 0.49679987442352436 + ], + "xyz": [ + 10.881874512139872, + 13.655083274581145, + 10.952640868438959 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49955450358642983, + 0.3034936128011825, + 0.6995272290947632 + ], + "xyz": [ + 13.713120406649827, + 16.393629614505386, + 10.979129298590484 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49711595846411705, + 0.3027774894141079, + 0.9013225070166268 + ], + "xyz": [ + 16.462238413201646, + 19.119198981128942, + 10.935999238570473 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.499171986893597, + 0.5015483988476268, + 0.09681871765564472 + ], + "xyz": [ + 8.180767510751757, + 8.148277634270412, + 13.681668984184578 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49689002854223135, + 0.4991330841100658, + 0.3013071096790285 + ], + "xyz": [ + 10.943474250249613, + 10.912807598276183, + 13.617448712021927 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49840395148822003, + 0.5033398369033141, + 0.5005489213748824 + ], + "xyz": [ + 13.72498640320301, + 13.65750386626722, + 13.695660761007142 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4993383515316465, + 0.4986280617464617, + 0.6982898918778891 + ], + "xyz": [ + 16.36404681672047, + 16.373757770811356, + 13.644017168383904 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.501086082856336, + 0.5026154528042287, + 0.8966678710259841 + ], + "xyz": [ + 19.13074973240838, + 19.10984046176738, + 13.72242672927482 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4991051763423289, + 0.7006059759933395, + 0.10314859438092742 + ], + "xyz": [ + 10.988787810334308, + 8.23390514764963, + 16.402234926725836 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5033301027204105, + 0.6989770917465782, + 0.30034009208558515 + ], + "xyz": [ + 13.662484660260246, + 10.987634242752506, + 16.437727547457662 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4964234256620521, + 0.7004087528958841, + 0.5023849116175229 + ], + "xyz": [ + 16.444378478367685, + 13.655527801785638, + 16.362874115451962 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49717654503286646, + 0.7018331615301799, + 0.6985668061820677 + ], + "xyz": [ + 19.146016286567658, + 16.347987864007358, + 16.392644886382786 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003993088448705, + 0.6969457423391193, + 0.8995600751716892 + ], + "xyz": [ + 21.82714016596062, + 19.13999270558528, + 16.369886017678294 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5012505833710423, + 0.8969602118182486, + 0.10274592845123943 + ], + "xyz": [ + 13.667802402659191, + 8.257731590262107, + 19.11608631388485 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4964729376057878, + 0.8999531743012664, + 0.3013227165632598 + ], + "xyz": [ + 16.423627750239447, + 10.907318580581467, + 19.0916864452931 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003715826191291, + 0.8990747080866707, + 0.5032861883260537 + ], + "xyz": [ + 19.17282575079341, + 13.721828385963766, + 19.132977786197365 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4967145275708546, + 0.9027569802265994, + 0.6996622522952805 + ], + "xyz": [ + 21.907987311577287, + 16.356647986509422, + 19.133322549735386 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4995557595724272, + 0.8978642725153338, + 0.9036535528128679 + ], + "xyz": [ + 24.630027434678613, + 19.184425141255524, + 19.10527514309809 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7023262160269064, + 0.10066481001126845, + 0.09639103690981074 + ], + "xyz": [ + 2.6941120690525486, + 10.919918513045268, + 10.978348769609239 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7021592361545197, + 0.10213786081525487, + 0.2972211962805809 + ], + "xyz": [ + 5.45996514398399, + 13.663349383774856, + 10.996205136293302 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6985190482722559, + 0.09968445985014701, + 0.49812757463004464 + ], + "xyz": [ + 8.173178529246973, + 16.360337231928128, + 10.912894686418028 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6974258061930431, + 0.10218701981974991, + 0.7021652909325329 + ], + "xyz": [ + 10.996960009189273, + 19.134957553503387, + 10.93216262693822 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6982250955187537, + 0.10287885306404217, + 0.9013470099137626 + ], + "xyz": [ + 13.72959523797721, + 21.869061902494384, + 10.95254898631324 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6991930588487655, + 0.30063437188166864, + 0.09707038987871877 + ], + "xyz": [ + 5.4373479159309, + 10.886370543581393, + 13.669460664008962 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7011033429557312, + 0.30244329158015537, + 0.299927177726511 + ], + "xyz": [ + 8.235500629676267, + 13.68590909327389, + 13.720308948980422 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6988181194654379, + 0.3000081718063399, + 0.50351721352945 + ], + "xyz": [ + 10.985654433741557, + 16.438112252346166, + 13.655773265535315 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7016141927079066, + 0.2992722452316158, + 0.6967521791930755 + ], + "xyz": [ + 13.617466646337983, + 19.118213330683282, + 13.683939219950318 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7013309785740816, + 0.2980092777528627, + 0.9029093683236877 + ], + "xyz": [ + 16.418743563802302, + 21.932885259523857, + 13.66280010325584 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7021927377780388, + 0.5021955476832003, + 0.0978423326337663 + ], + "xyz": [ + 8.203609892875109, + 10.937935476357525, + 16.466179848934676 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6975046884030945, + 0.5012501280017027, + 0.3029350659123047 + ], + "xyz": [ + 10.994675217857402, + 13.67783224184436, + 16.389160074019433 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6979666406255904, + 0.5004760674351301, + 0.49816273843102576 + ], + "xyz": [ + 13.653209998817026, + 16.353265567173825, + 16.384892984918718 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6984610226356323, + 0.4976833705951471, + 0.7004974818762386 + ], + "xyz": [ + 16.38131294243534, + 19.126308861155483, + 16.35347083826043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.702594395492115, + 0.4978072508063296, + 0.9017536610885172 + ], + "xyz": [ + 19.134544866462203, + 21.934357846920218, + 16.411675235896 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6967888583213733, + 0.7027820821261709, + 0.09946745004327823 + ], + "xyz": [ + 10.968211198904916, + 10.886272921826007, + 19.13468197502954 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7026503726276004, + 0.698602996038023, + 0.2971940781284351 + ], + "xyz": [ + 13.614358354530465, + 13.669693358735381, + 19.15768383079004 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6982672365199015, + 0.7028087447663197, + 0.49748851881509815 + ], + "xyz": [ + 16.4102481341777, + 16.348157450904154, + 19.155258622468583 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7013934197570283, + 0.7003627953948881, + 0.7019187057172188 + ], + "xyz": [ + 19.171740272534525, + 19.18583078330132, + 19.16455865743827 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6986194422038507, + 0.7037803314111096, + 0.8991029432056117 + ], + "xyz": [ + 21.91433161157038, + 21.843772863288795, + 19.173357272904486 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7025820556339358, + 0.8972078973425471, + 0.10165014579154419 + ], + "xyz": [ + 13.65620737128153, + 10.995317896092905, + 21.872040274902936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6993435303286569, + 0.9012055062829741, + 0.3026601704096518 + ], + "xyz": [ + 16.459034835919777, + 13.699214235828023, + 21.882418329727628 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7003664690521463, + 0.9034206240307792, + 0.49775028720099423 + ], + "xyz": [ + 19.15655648759678, + 16.380436630476808, + 21.926688454953 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7022541395024415, + 0.9008547075737545, + 0.6963700549446887 + ], + "xyz": [ + 21.836969452694902, + 19.121738234126163, + 21.917415597633276 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6963522068388032, + 0.9013799391725851, + 0.9002744195138911 + ], + "xyz": [ + 24.631894094176936, + 21.82879184270129, + 21.843906308481415 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9031823136741359, + 0.09906834778502514, + 0.10056757793147932 + ], + "xyz": [ + 2.7293864419294196, + 13.723087843051482, + 13.702590638350587 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8982152231263094, + 0.09837074625363626, + 0.2997586807205275 + ], + "xyz": [ + 5.4431538622939115, + 16.37848357809126, + 13.625143987888128 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9028351916245911, + 0.09667492569533047, + 0.5003954254615828 + ], + "xyz": [ + 8.163038368354108, + 19.184716415291092, + 13.66512241217685 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9000323067667537, + 0.09644182072156021, + 0.7013258194794029 + ], + "xyz": [ + 10.90693557865233, + 21.893480057574727, + 13.623614905677279 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9016702082637972, + 0.09806153821610153, + 0.8976165381882321 + ], + "xyz": [ + 13.612731438546295, + 24.59952452587778, + 13.668152486158807 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8962852992807765, + 0.3004850464033482, + 0.10168592284941007 + ], + "xyz": [ + 5.498409100849245, + 13.644082914143926, + 16.362028747531127 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9026118705258225, + 0.30172867306711715, + 0.2979509234670081 + ], + "xyz": [ + 8.198711501487184, + 16.41387841816706, + 16.46552713070482 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8965595149955978, + 0.30070962482229674, + 0.5026284445447466 + ], + "xyz": [ + 10.983093483533729, + 19.12944592900287, + 16.368848171145086 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8970557017408879, + 0.2989867512725547, + 0.7010478976036372 + ], + "xyz": [ + 13.672293713198496, + 21.84898475159046, + 16.352077129958243 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8979176251979634, + 0.2981528928541068, + 0.9005879311963639 + ], + "xyz": [ + 16.388968773069706, + 24.58884423602309, + 16.35246083011465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8983674585281166, + 0.4981996275578159, + 0.10364787257554045 + ], + "xyz": [ + 8.228350689273222, + 13.6993732440896, + 19.093613818891374 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9022080664031467, + 0.5005253995222676, + 0.30091056744129263 + ], + "xyz": [ + 10.95708828185174, + 16.44882140056708, + 19.177919454108395 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8971117034395732, + 0.5000953741026665, + 0.4995245433656241 + ], + "xyz": [ + 13.666623580041323, + 19.09455937179623, + 19.10236366688354 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9028241276492878, + 0.5013157850145983, + 0.6972288701784326 + ], + "xyz": [ + 16.386286787761183, + 21.875636576760982, + 19.19714814075637 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9037797798846816, + 0.4985537821434992, + 0.8985515487827209 + ], + "xyz": [ + 19.100972605463713, + 24.641149505901566, + 19.17245204000812 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8978492667684759, + 0.7036628073669863, + 0.0994372487376466 + ], + "xyz": [ + 10.979839409052442, + 13.634721728426914, + 21.895584805406692 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.897491473631332, + 0.6981893873592818, + 0.30173459269751124 + ], + "xyz": [ + 13.670780669020063, + 16.395602918156005, + 21.815861508908693 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9019356610219424, + 0.702054943237429, + 0.4992945966382687 + ], + "xyz": [ + 16.42463466626336, + 19.157367861284026, + 21.929470823125357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8984335082254067, + 0.7034662898717887, + 0.6978282098389599 + ], + "xyz": [ + 19.158246167035404, + 21.823802882266765, + 21.900885697621195 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9013243383381874, + 0.6965733062224764, + 0.9023841560889514 + ], + "xyz": [ + 21.86065861237862, + 24.65997786827884, + 21.84616897485737 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9029321962254518, + 0.9002182703998561, + 0.09674375843470076 + ], + "xyz": [ + 13.63028540506087, + 13.667389710441766, + 24.652348612617214 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9030206703561681, + 0.9005408368826429, + 0.2995422341547652 + ], + "xyz": [ + 16.407319732270654, + 16.441223569150665, + 24.657968285897716 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8969441994603085, + 0.9021227317773401, + 0.502044586716647 + ], + "xyz": [ + 19.19752282833246, + 19.12672286662982, + 24.596519251833506 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8993179803222678, + 0.9010976007572744, + 0.7027505436250505 + ], + "xyz": [ + 21.927523137329153, + 21.903192487073422, + 24.614957749714904 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8993758593582625, + 0.8966799895175684, + 0.9021585279048587 + ], + "xyz": [ + 24.593396419266284, + 24.630253866471683, + 24.55535227577756 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15179823682152985, + 0.15232119571523645, + 0.14897788835629272 + ], + "xyz": [ + 4.119306843590814, + 4.112157043728658, + 4.157866140144812 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15122152123568733, + 0.15261985499622552, + 0.34675155548065406 + ], + "xyz": [ + 6.827316037186011, + 6.80819826971201, + 4.15406460439499 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15062962297327698, + 0.15181524284820375, + 0.5512855042906829 + ], + "xyz": [ + 9.612666856748373, + 9.596457275229952, + 4.134971765435436 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14834175431579874, + 0.15335744491372652, + 0.7477731095603154 + ], + "xyz": [ + 12.320094737269294, + 12.251521118238733, + 4.124777146010207 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15277243753243092, + 0.1466265703800446, + 0.950220868395104 + ], + "xyz": [ + 14.995900750394851, + 15.07992593984619, + 4.09332934435794 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14899821644384761, + 0.3527222870007679, + 0.15130368349877973 + ], + "xyz": [ + 6.890952343995124, + 4.10567352167361, + 6.859432413404162 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14903665623399825, + 0.3535016048520807, + 0.3475373323357618 + ], + "xyz": [ + 9.584478162223487, + 6.789070188407816, + 6.870612648681875 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15056195363829708, + 0.3519285851408173, + 0.551216751111922 + ], + "xyz": [ + 12.347640471086926, + 9.594592131178139, + 6.869960197891071 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14877085100738796, + 0.35352840349524656, + 0.7476979860869524 + ], + "xyz": [ + 15.055768977617698, + 12.256360576363143, + 6.867344993694208 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15064089363175018, + 0.3515560725987343, + 0.9462544168438808 + ], + "xyz": [ + 17.743431405771332, + 14.99655524366694, + 6.865946526849261 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1495307725481334, + 0.5522011896895007, + 0.1516533895460986 + ], + "xyz": [ + 9.62297311348485, + 4.117735651003163, + 9.59395307595973 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15257642864438473, + 0.5496232313047409, + 0.3511429944708957 + ], + "xyz": [ + 12.315113700883863, + 6.886761283335952, + 9.600347354885653 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1483772674125666, + 0.5483059765871959, + 0.5536901632478156 + ], + "xyz": [ + 15.066292864519106, + 9.598539539851226, + 9.524927908980832 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1467726876205848, + 0.5516932000282097, + 0.7523163289499395 + ], + "xyz": [ + 17.828183558474038, + 12.292183198529225, + 9.54929989207454 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15149438512975033, + 0.5473380083588381, + 0.9484322136985256 + ], + "xyz": [ + 20.449901237328305, + 15.037998472392397, + 9.554310693945151 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15158139718110925, + 0.7516155181316649, + 0.14627564670825866 + ], + "xyz": [ + 12.275806385281763, + 4.072247889787538, + 12.348345650711492 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500242413258054, + 0.7534099443098646, + 0.34735162021963817 + ], + "xyz": [ + 15.049413973165747, + 6.800033251394225, + 12.351589567857465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15316712232016133, + 0.7509231710216892, + 0.5480308658417836 + ], + "xyz": [ + 17.759065780270763, + 9.586652678512241, + 12.360559754316977 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1531273891099308, + 0.7479242361330731, + 0.7509936277424982 + ], + "xyz": [ + 20.492935229691312, + 12.360979800623374, + 12.319015631029805 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15056339030106952, + 0.7532925587270876, + 0.9474944481815766 + ], + "xyz": [ + 23.252853816794012, + 15.01244911732381, + 12.357355841042137 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14967313242762006, + 0.9536327890500368, + 0.14884259805756347 + ], + "xyz": [ + 15.07284504696543, + 4.081253334361942, + 15.084199963376657 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15117259795091856, + 0.9467723729193995, + 0.3493911192498763 + ], + "xyz": [ + 17.720913955509747, + 6.84361704010017, + 15.01090601164423 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15163296494857206, + 0.9520834391830583, + 0.5465067763817348 + ], + "xyz": [ + 20.488455680963046, + 9.544840878314515, + 15.089812008334905 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15343934473012824, + 0.9473290124576766, + 0.7496409324951342 + ], + "xyz": [ + 23.200667632804738, + 12.346750995773887, + 15.049506841167373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1501961372691662, + 0.951077811091663, + 0.9522996987117226 + ], + "xyz": [ + 26.02263470608012, + 15.073124620280234, + 15.05641919267855 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3512963014855286, + 0.1472209094220848, + 0.1486489509491486 + ], + "xyz": [ + 4.0450794744206355, + 6.835161501141467, + 6.8156375744309265 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35013452784664223, + 0.1487920860594192, + 0.34760356489951166 + ], + "xyz": [ + 6.78663198869333, + 9.53934961116872, + 6.821234858533169 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34680653387715177, + 0.15095266407915314, + 0.5528001811438452 + ], + "xyz": [ + 9.621582224376692, + 12.299261078558365, + 6.805274157802968 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3527738283783855, + 0.14907609206222874, + 0.7511964640150838 + ], + "xyz": [ + 12.308364337628921, + 15.09328312295088, + 6.861201779278398 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3496245575372575, + 0.14822301556222467, + 0.9536881679507776 + ], + "xyz": [ + 15.065131356976734, + 17.81865698658183, + 6.806482406852962 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3531233623091307, + 0.3473487043359598, + 0.15085105680034228 + ], + "xyz": [ + 6.811297458298517, + 6.890247542669274, + 9.57672801019968 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34774249594426615, + 0.34803914997350827, + 0.35295214832530847 + ], + "xyz": [ + 9.583826851907729, + 9.579771051417655, + 9.512601422291546 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34698440777765494, + 0.35289993524465396, + 0.5491225197166693 + ], + "xyz": [ + 12.332288640189317, + 12.25141261345545, + 9.568692758619262 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3489483690056694, + 0.3517113040507141, + 0.7469308532877812 + ], + "xyz": [ + 15.020437819543584, + 14.982663468936043, + 9.579292931285725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34953130166230006, + 0.34666120640140363, + 0.951336297339087 + ], + "xyz": [ + 17.745988231589312, + 17.785227657379142, + 9.518218655595504 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34737202137250683, + 0.5515226590388189, + 0.14838193569511285 + ], + "xyz": [ + 9.568969636375263, + 6.777858865316223, + 12.28952626954117 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35142579780453653, + 0.552301192157654, + 0.34655756513301367 + ], + "xyz": [ + 12.289035135101695, + 9.542702901076856, + 12.355592735904876 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3493154147730179, + 0.5468651582820901, + 0.5528234457960741 + ], + "xyz": [ + 15.034744651007927, + 12.333880116705721, + 12.252419482306285 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3502255839713079, + 0.5486856192934552, + 0.7534502966974247 + ], + "xyz": [ + 17.80256785896243, + 15.08925797884439, + 12.289752167019252 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34702247826438826, + 0.5532104938484724, + 0.9497107862652511 + ], + "xyz": [ + 20.547669215884405, + 17.72870378066161, + 12.30782315279205 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3473711926314932, + 0.7524859470535203, + 0.1518262732663064 + ], + "xyz": [ + 12.363593900013013, + 6.824937898210854, + 15.03704883948836 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3463686430500979, + 0.7522059340036104, + 0.35040376105016086 + ], + "xyz": [ + 15.074681281030049, + 9.526146889825998, + 15.019513874054429 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3503829671125023, + 0.753010864595139, + 0.5497674437147458 + ], + "xyz": [ + 17.81135053111725, + 12.306694389756185, + 15.085401856217162 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35112314621789636, + 0.7510807879837557, + 0.7462146124078696 + ], + "xyz": [ + 20.470753200982227, + 15.002604315134917, + 15.069133791696828 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35215315455584756, + 0.7463441315607282, + 0.951005513435992 + ], + "xyz": [ + 23.205858823459057, + 17.81655074022419, + 15.018457166274322 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3499232742094389, + 0.9523981414415212, + 0.1511639706048389 + ], + "xyz": [ + 15.087702554717666, + 6.850774615396738, + 17.805103976925107 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3488397995311511, + 0.9515600481176779, + 0.3525749599400876 + ], + "xyz": [ + 17.82989908586432, + 9.58961633683407, + 17.77883264508221 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3511450382863396, + 0.950352336187034, + 0.5521412431706836 + ], + "xyz": [ + 20.541821768134426, + 12.349567448549758, + 17.793837834272555 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35307746142216057, + 0.9472362465474415, + 0.7488181080049265 + ], + "xyz": [ + 23.188149845656156, + 15.064917884004636, + 17.777654958892963 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34625557630398085, + 0.9507266793833723, + 0.9512282015025911 + ], + "xyz": [ + 26.00318477959433, + 17.738964663091444, + 17.732107942951465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5464918780783853, + 0.15254358794222891, + 0.1503879478345423 + ], + "xyz": [ + 4.141625429463575, + 9.52761554151288, + 9.557087065049952 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5468617743682643, + 0.1500206049066824, + 0.35005032602866465 + ], + "xyz": [ + 6.836879754980496, + 12.26242079244874, + 9.5276504506188 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5531084945011872, + 0.14718495774390253, + 0.5507558967399847 + ], + "xyz": [ + 9.542121733149898, + 15.091835261458877, + 9.57428602627346 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5485275591793796, + 0.14719174403559096, + 0.7522872295127607 + ], + "xyz": [ + 12.297514620137825, + 17.784505644336974, + 9.511749084080497 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5519923959034266, + 0.14655480898856424, + 0.9518139233668758 + ], + "xyz": [ + 15.01669960239175, + 20.559769311926104, + 9.550411646786417 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5520336241395383, + 0.3507269088003499, + 0.14629751265980295 + ], + "xyz": [ + 6.795228425807346, + 9.54745760271597, + 12.34237950945822 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5537416366286138, + 0.34924324990978134, + 0.34816665721602996 + ], + "xyz": [ + 9.534862716440808, + 12.330727849951076, + 12.34544683147336 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5527253501833571, + 0.35060355432645357, + 0.5466140512918752 + ], + "xyz": [ + 12.26659760484478, + 15.02997041587711, + 12.350150183255318 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5510628014983985, + 0.34926173044573294, + 0.7468769516405933 + ], + "xyz": [ + 14.986210756521475, + 17.74519867576073, + 12.309074942324415 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.548779670795897, + 0.34943555722324426, + 0.9480764305917174 + ], + "xyz": [ + 17.739350345248347, + 20.46474718407321, + 12.280236918736655 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5484412094452038, + 0.5482487867007834, + 0.15369032442868194 + ], + "xyz": [ + 9.596785178322046, + 9.599415947447667, + 14.993748223108629 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5510103875932504, + 0.5462090142254111, + 0.3514167072973221 + ], + "xyz": [ + 12.272177292028934, + 12.337820804466824, + 15.000986162172412 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5487275455415851, + 0.5537588286809376, + 0.5492154807167621 + ], + "xyz": [ + 15.079666222709657, + 15.010879425259395, + 15.07299526082297 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502092511635279, + 0.5473186776349165, + 0.7491181509894498 + ], + "xyz": [ + 17.72465096232318, + 17.764170363303123, + 15.005204287505146 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5520030392502275, + 0.5523426450913156, + 0.948225325935396 + ], + "xyz": [ + 20.515495197642412, + 20.51085216771211, + 15.098415414094395 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5493503428921885, + 0.7507371471674585, + 0.15298036199391338 + ], + "xyz": [ + 12.355463116102626, + 9.602138977675905, + 17.774562148347282 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5482938018894848, + 0.749109889922219, + 0.3488297641235077 + ], + "xyz": [ + 15.010833320975447, + 12.26531191228775, + 17.737869741785087 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5485024375549603, + 0.7472060245772628, + 0.5521779680533059 + ], + "xyz": [ + 17.76494405812646, + 15.048304383003204, + 17.714692866748567 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497942074100405, + 0.7493521683211948, + 0.7534627090752605 + ], + "xyz": [ + 20.546214497086403, + 17.817893975942066, + 17.761695402649814 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5479110319728145, + 0.7477171172423916, + 0.9524387429112511 + ], + "xyz": [ + 23.244224891965775, + 20.512512059255464, + 17.71359484300344 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.547472148948714, + 0.9521264857803988, + 0.14816755765287917 + ], + "xyz": [ + 15.043022108891957, + 9.510660853509792, + 20.502242606262175 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5489459445877535, + 0.9537649994163357, + 0.3490310846094437 + ], + "xyz": [ + 17.81159355750533, + 12.276980307318823, + 20.544793538453984 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5488514132044807, + 0.9516789333846694, + 0.5524717055346948 + ], + "xyz": [ + 20.56447678819054, + 15.057091441240633, + 20.51498080310447 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5496759208043467, + 0.9465482902347034, + 0.7521246384073266 + ], + "xyz": [ + 23.223950519266676, + 17.79798292144134, + 20.456108092967906 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5496200736206138, + 0.9467357989067791, + 0.9527761415089397 + ], + "xyz": [ + 25.96978533721443, + 20.54049062193253, + 20.45790814513746 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7480183352949834, + 0.15371738384469258, + 0.1491930338768973 + ], + "xyz": [ + 4.1413367072143865, + 12.2665123412715, + 12.328368439648203 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7490281713176787, + 0.15365679975565794, + 0.3478394240439924 + ], + "xyz": [ + 6.8563661024685345, + 14.9961763276176, + 12.341346441219866 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7468505596783178, + 0.1518036937009034, + 0.5490632286521911 + ], + "xyz": [ + 9.582126406365484, + 17.717500049572816, + 12.286239194435103 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7487043268641576, + 0.15348089334910212, + 0.7476670808454849 + ], + "xyz": [ + 12.320332896553039, + 20.458120539352844, + 12.334513937416046 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7466025383667771, + 0.15019446743943157, + 0.9504724344094058 + ], + "xyz": [ + 15.04811976203497, + 23.20210355430087, + 12.26084723992144 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7474235036789716, + 0.3497520086872325, + 0.15348239066691907 + ], + "xyz": [ + 6.880130125778075, + 12.317023224436035, + 15.000386113478516 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.747619136306386, + 0.35270776222641204, + 0.34807504645972154 + ], + "xyz": [ + 9.580976419451254, + 14.980133641825322, + 15.043471297898677 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7477013647977285, + 0.3479562946260749, + 0.5517403003232925 + ], + "xyz": [ + 12.30048990076066, + 17.765732546034876, + 14.979634301263543 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7530128283402997, + 0.3481340097166753, + 0.7476883288276222 + ], + "xyz": [ + 14.981885764556695, + 20.517316094591536, + 15.054681363484109 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7468889064714301, + 0.34904745581291774, + 0.9524883793837307 + ], + "xyz": [ + 17.79436366235824, + 23.233580364300302, + 14.983444676606391 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7516610426360427, + 0.5523547471340117, + 0.149194713467471 + ], + "xyz": [ + 9.591457946440562, + 12.31633774341114, + 17.828269154894024 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7489365899689313, + 0.5524846360946293, + 0.3469499944228425 + ], + "xyz": [ + 12.29690837020138, + 14.982764122219141, + 17.792796746920306 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7483819062912455, + 0.5488029368446308, + 0.5490362947492806 + ], + "xyz": [ + 15.009460363290268, + 17.738068109349882, + 17.734877682081933 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7482494041193627, + 0.5536948569290278, + 0.7495993084340878 + ], + "xyz": [ + 17.81840323589475, + 20.478317985262514, + 17.799947587086603 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.748253171987662, + 0.5488855562175898, + 0.9490990181166298 + ], + "xyz": [ + 20.48017546307407, + 23.205893619711656, + 17.734247207051123 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7529074960746027, + 0.7472049555289211, + 0.1487215662697715 + ], + "xyz": [ + 12.2489461392578, + 12.326910247141061, + 20.509267418082086 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7515273286867583, + 0.7516995868738885, + 0.3504879576550989 + ], + "xyz": [ + 15.068909715042297, + 15.066554632114327, + 20.55184780870036 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7463454705661453, + 0.7521944307032906, + 0.5508364883045055 + ], + "xyz": [ + 17.814804179109164, + 17.734838248926938, + 20.487767792973496 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7491286594405419, + 0.7489970060922941, + 0.7537423337299479 + ], + "xyz": [ + 20.545181760968525, + 20.546981701848164, + 20.482104436545136 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7526562603886828, + 0.7475245205235794, + 0.9516502495672132 + ], + "xyz": [ + 23.230811605222698, + 23.300971828945215, + 20.510201604091883 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7513209984667562, + 0.9510599808696245, + 0.15141302588277575 + ], + "xyz": [ + 15.0728125031776, + 12.342017088782416, + 23.274646320910712 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7511663976868679, + 0.9511706087177746, + 0.3514581016727781 + ], + "xyz": [ + 17.809305255291765, + 15.074883682835193, + 23.274045130903115 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7531411902944533, + 0.950593278229658, + 0.5471160231355674 + ], + "xyz": [ + 20.476411980591113, + 17.776882575716822, + 23.293150981457313 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7490103229641405, + 0.9492407908644471, + 0.7537182568607649 + ], + "xyz": [ + 23.282549567870504, + 20.545034652221734, + 23.218183543063958 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7530176612259042, + 0.9469233585277118, + 0.9494438397225868 + ], + "xyz": [ + 25.926790988382393, + 23.275747197897594, + 23.24128763268788 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9500401910698931, + 0.15324975050999298, + 0.14963670051009623 + ], + "xyz": [ + 4.141009038785476, + 15.034584519841129, + 15.083981489090718 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9513070603102417, + 0.14836534451803046, + 0.35288643873407916 + ], + "xyz": [ + 6.853024155301857, + 17.830698764104124, + 15.034523177779267 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9490600563424911, + 0.14684209675857657, + 0.5521109419003084 + ], + "xyz": [ + 9.555960132997315, + 20.52373967719587, + 14.982976974810239 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9476993726962639, + 0.15069228615118768, + 0.7532733999504118 + ], + "xyz": [ + 12.358856146557567, + 23.25539357252627, + 15.017013049263763 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9474365433951761, + 0.15346362818056195, + 0.9491714107308807 + ], + "xyz": [ + 15.075027777690238, + 25.930082559379702, + 15.051308983752605 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9497708058750544, + 0.34651020375925834, + 0.15209725737777458 + ], + "xyz": [ + 6.816871459322509, + 15.064541824541289, + 17.722520633138586 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9534946302922526, + 0.34820188008288894, + 0.35024146135795736 + ], + "xyz": [ + 9.54899164437779, + 17.824445172545172, + 17.796560384477065 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9537697666100635, + 0.34919800801010875, + 0.5485438579350097 + ], + "xyz": [ + 12.273765197665789, + 20.53936145832782, + 17.81394088040756 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9465817616371792, + 0.3504823500618465, + 0.7502364858693431 + ], + "xyz": [ + 15.048829795460755, + 23.19859365262462, + 17.73322706360897 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501821578933102, + 0.34817384553481706, + 0.9535183226496351 + ], + "xyz": [ + 17.796501018827556, + 26.027050303896647, + 17.750889574788737 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9513490843978996, + 0.548778400692607, + 0.1527593102648171 + ], + "xyz": [ + 9.591297307421929, + 15.09517123231762, + 20.509472953210086 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501687043729543, + 0.5535184062622165, + 0.34799109969146375 + ], + "xyz": [ + 12.325275693687642, + 17.74820717240399, + 20.55813951292414 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9471078680489319, + 0.5500451358332928, + 0.5532728974517132 + ], + "xyz": [ + 15.08436555382661, + 20.512935757387027, + 20.468806381537075 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9493283550266105, + 0.5467021247164308, + 0.751820321309978 + ], + "xyz": [ + 17.753165148032775, + 23.257798496112095, + 20.453459433560504 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9534994639902152, + 0.5485187407211006, + 0.9478113295575002 + ], + "xyz": [ + 20.45755538143638, + 25.994378933441524, + 20.53532253153626 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9521119658313587, + 0.7496880596999911, + 0.15165752137497412 + ], + "xyz": [ + 12.323034542252328, + 15.090537750577283, + 23.266703625060018 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9465104939933185, + 0.7525829934942604, + 0.3504405261369371 + ], + "xyz": [ + 15.080339016164196, + 17.73168089603723, + 23.229700324102428 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9529671013454483, + 0.7511346185405696, + 0.5485642057051453 + ], + "xyz": [ + 17.769248379299047, + 20.528665754360443, + 23.298171975972053 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9486730615821337, + 0.7536599260293332, + 0.7480020994229181 + ], + "xyz": [ + 20.530452912818596, + 23.196637399732086, + 23.273990186686202 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9534239786057933, + 0.7484350197482175, + 0.950366452986466 + ], + "xyz": [ + 23.2257079509635, + 26.02828009845168, + 23.26750989087633 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9531277531721646, + 0.9509745709075864, + 0.14771160984841702 + ], + "xyz": [ + 15.021039699783541, + 15.050477620132046, + 26.032544236400017 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9491817219786722, + 0.9523057164183215, + 0.35172281384681087 + ], + "xyz": [ + 17.82844334064944, + 17.785732650989555, + 25.996793990024784 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9527784596502775, + 0.946771426081161, + 0.5495127071021647 + ], + "xyz": [ + 20.456927337738453, + 20.539054419429373, + 25.970304118740795 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9531410707548578, + 0.9498292971186459, + 0.7469411727541052 + ], + "xyz": [ + 23.197940445415675, + 23.24321841845071, + 26.017068334900323 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9468342109715834, + 0.9524420124969712, + 0.9491346672791082 + ], + "xyz": [ + 25.998014082096194, + 25.921345229045368, + 25.966562657541854 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1040152474681861, + 0.09991324334989712, + 0.09694755609944797 + ], + "xyz": [ + 2.6914454151275446, + 2.7475272770720505, + 2.7880736193364863 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1008950239997988, + 0.0962722843457196, + 0.29947913030608975 + ], + "xyz": [ + 5.410642105864899, + 5.473843370322332, + 2.695635949584425 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09961410101153474, + 0.10296932719627913, + 0.5013456840680157 + ], + "xyz": [ + 8.26208605730341, + 8.216214008846299, + 2.7696841654401534 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0986109528062456, + 0.09682965798838027, + 0.7008940403574503 + ], + "xyz": [ + 10.906334813518493, + 10.93068835563528, + 2.6720288514741815 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10391659432929705, + 0.09932588523714607, + 0.899985563283689 + ], + "xyz": [ + 13.66240624811612, + 13.725169596496373, + 2.778694596986088 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09978826951275085, + 0.29935472017905085, + 0.09686577012787913 + ], + "xyz": [ + 5.417055223788091, + 2.6886186322395575, + 5.4570111093281675 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0987709012953903, + 0.2964765496916341, + 0.3030819175300064 + ], + "xyz": [ + 8.197055443330168, + 5.494059405473434, + 5.40375200535342 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10244764019562659, + 0.29944788969180364, + 0.5020624116140727 + ], + "xyz": [ + 10.958104567599705, + 8.264752616532883, + 5.494643343425566 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09889592857157355, + 0.3027218218465612, + 0.7020440850801476 + ], + "xyz": [ + 13.736978621638714, + 10.950307697443874, + 5.490845592521663 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09767592949062245, + 0.30246208048715845, + 0.8972160416523889 + ], + "xyz": [ + 16.401783343829905, + 13.601983948912444, + 5.470614847574424 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09592668759198528, + 0.4997107401099829, + 0.10228863401766797 + ], + "xyz": [ + 8.230427083185898, + 2.7099641982892892, + 8.143447696804321 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09833884894078719, + 0.5043155687528522, + 0.29948152094939623 + ], + "xyz": [ + 10.989369126932994, + 5.438928489472007, + 8.239382720912252 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09951982539030099, + 0.4966829785839231, + 0.5038699000388658 + ], + "xyz": [ + 13.679378857012615, + 8.24943571591699, + 8.151177419430875 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09881319401974765, + 0.4967691274418021, + 0.7006906786785394 + ], + "xyz": [ + 16.371454926512207, + 10.930673036833895, + 8.142694294204444 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09792027329975236, + 0.499584811405602, + 0.9042974301910088 + ], + "xyz": [ + 19.193625308305375, + 13.702140042939057, + 8.168981967176357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09758500488931714, + 0.6978161861286286, + 0.10071213569231714 + ], + "xyz": [ + 10.917335480838043, + 2.711082812546799, + 10.87458191138297 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10162856699882661, + 0.7024971786290166, + 0.300036602221311 + ], + "xyz": [ + 13.706461395705125, + 5.491493893847261, + 10.993862451589658 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10353794808401802, + 0.6996593644730051, + 0.500459267178974 + ], + "xyz": [ + 16.40780591059216, + 8.25774120757688, + 10.98116908176336 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10151319769218088, + 0.7034230603591285, + 0.6974219172058114 + ], + "xyz": [ + 19.152100381171895, + 10.922897082564667, + 11.00494363155105 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10423329799605155, + 0.6997616467193296, + 0.897643922660757 + ], + "xyz": [ + 21.839441411562053, + 13.697485022920167, + 10.992074165058641 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09952345087777585, + 0.896007943059443, + 0.10205158308154923 + ], + "xyz": [ + 13.645290190684937, + 2.7558975807857795, + 13.610726022258746 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10088078717762744, + 0.9018281443728686, + 0.295610113500875 + ], + "xyz": [ + 16.371160322763405, + 5.420752225714363, + 13.708856024550702 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09996642796349518, + 0.9041494660024343, + 0.4984544611348793 + ], + "xyz": [ + 19.176148423114466, + 8.181502679992937, + 13.728091761441272 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09634062834289148, + 0.9024487130595329, + 0.7023509763453196 + ], + "xyz": [ + 21.94053248959905, + 10.919567854808378, + 13.655268093572491 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10064949798484764, + 0.8986065381314515, + 0.903805222843193 + ], + "xyz": [ + 24.642249161928362, + 13.732724141311222, + 13.66164865969554 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3032564498520745, + 0.09667971203336588, + 0.09851801756742677 + ], + "xyz": [ + 2.6687082235107087, + 5.492988199155285, + 5.4678552167886005 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2994648605455274, + 0.09788152869974547, + 0.2983335219786266 + ], + "xyz": [ + 5.416980854165581, + 8.172991882161378, + 5.432448311411306 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29818007109098044, + 0.10089477990841252, + 0.49717062308360555 + ], + "xyz": [ + 8.176642537934331, + 10.873891527629986, + 5.45607952939052 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30415676859251023, + 0.09835138569223752, + 0.6975064597300267 + ], + "xyz": [ + 10.880825208201019, + 13.694559358244625, + 5.503019033913299 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29744573050273737, + 0.10361049353698644, + 0.8977259140315166 + ], + "xyz": [ + 13.69009112372321, + 16.3401715931763, + 5.483168504950776 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30410586259083977, + 0.29707410836838105, + 0.09963305681201577 + ], + "xyz": [ + 5.423708955056653, + 5.519845833070348, + 8.219224350559694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2962859908924034, + 0.3031441456825512, + 0.30137413395013224 + ], + "xyz": [ + 8.264865105847713, + 8.171101648024674, + 8.195300929828194 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29825868274924144, + 0.29675841715052237, + 0.5021309510400217 + ], + "xyz": [ + 10.922271641814843, + 10.942783003032723, + 8.134966686751588 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2962709565745671, + 0.3029496804619562, + 0.70167508567965 + ], + "xyz": [ + 13.735048970230132, + 13.643738659412048, + 8.192436689848678 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30051710711921215, + 0.30382531329879925, + 0.8987998412223706 + ], + "xyz": [ + 16.442074640085618, + 16.396845440675417, + 8.262460790319377 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3036886571401093, + 0.5009771693988381, + 0.09704717111620115 + ], + "xyz": [ + 8.176081139140322, + 5.478788111471189, + 11.00124634059171 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29770954208976624, + 0.49839161788016767, + 0.2996276702823021 + ], + "xyz": [ + 10.910376064285416, + 8.16668684685269, + 10.88415176090014 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30090443520611543, + 0.4980062097985869, + 0.49731759976751566 + ], + "xyz": [ + 13.60788796610203, + 10.913147982193188, + 10.922562534588188 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30271877203298136, + 0.4960596346188047, + 0.7017400143360308 + ], + "xyz": [ + 16.376101196573696, + 13.732779724655588, + 10.92075459563002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3003488265361497, + 0.4976356928145732, + 0.8979686696301947 + ], + "xyz": [ + 19.080451634559626, + 16.38318111043695, + 10.909900711349598 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30403785922515475, + 0.6969267711079766, + 0.09953017743346709 + ], + "xyz": [ + 10.88901603820788, + 5.517509554950078, + 13.685008252281111 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30061934590706374, + 0.697930163725723, + 0.303926404208651 + ], + "xyz": [ + 13.697202662616533, + 8.26524067734703, + 13.651989156787726 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29727017709509895, + 0.7001145600341554, + 0.49853908001994407 + ], + "xyz": [ + 16.387776809164436, + 10.880160917610587, + 13.636064596778482 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29958452769258187, + 0.7038221598451195, + 0.6966188112136935 + ], + "xyz": [ + 19.1465768769413, + 13.619912732925592, + 13.718395618811694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2998209006346492, + 0.6958830103087774, + 0.9020993638157893 + ], + "xyz": [ + 21.84732738220373, + 16.432437509918792, + 13.613084643714558 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29702240648497946, + 0.89805557376043, + 0.10331383317104803 + ], + "xyz": [ + 13.690542285073917, + 5.473325008054069, + 16.33889103187879 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2966895816078206, + 0.8983296659837103, + 0.30231462356505945 + ], + "xyz": [ + 16.41499261073866, + 8.189477672366685, + 16.338088049606842 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30172469018481757, + 0.8984149909159633, + 0.4967116158752733 + ], + "xyz": [ + 19.073919845260562, + 10.91607745791847, + 16.408093694867276 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29570797097483703, + 0.9005829589913034, + 0.7013185050185047 + ], + "xyz": [ + 21.900908473678573, + 13.631166515015288, + 16.355474262129675 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30036502074500804, + 0.9036495374248407, + 0.8964591126362612 + ], + "xyz": [ + 24.61076144407837, + 16.362764123244702, + 16.4610703166777 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5027227565519662, + 0.09600026646394938, + 0.10163548503296466 + ], + "xyz": [ + 2.702040420030539, + 8.262677094465689, + 8.185633400529454 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5030270805884065, + 0.09844255771497702, + 0.29666269653677313 + ], + "xyz": [ + 5.401807917184162, + 10.933214688695571, + 8.223184630348964 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500368840092353, + 0.10373805574634422, + 0.4993015816787393 + ], + "xyz": [ + 8.244649375741004, + 13.667314065778454, + 8.259240740665417 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49710235466021546, + 0.09781759696407154, + 0.7022644033988672 + ], + "xyz": [ + 10.938577094202032, + 16.397526430167325, + 8.133638493015958 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5032853178404774, + 0.09959550358500481, + 0.9009162940003472 + ], + "xyz": [ + 13.678817204463366, + 19.19799168079762, + 8.242478071981335 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5002869744407705, + 0.2971945387159723, + 0.0985124038213624 + ], + "xyz": [ + 5.4100340911207825, + 8.186677315711794, + 10.90302370120662 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5005046825000177, + 0.30150772715953394, + 0.2957027642540449 + ], + "xyz": [ + 8.164954340717994, + 10.885604894681126, + 10.96496930263165 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5020552024196804, + 0.3007051682393409, + 0.5015933368745109 + ], + "xyz": [ + 10.968880748185661, + 13.72170217249311, + 10.97519529078342 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5004200787129676, + 0.2972609886447434, + 0.7039743586180004 + ], + "xyz": [ + 13.688709445413725, + 16.46626395619027, + 10.905751970322498 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4961379379025546, + 0.299607375962757, + 0.9011041723622941 + ], + "xyz": [ + 16.4159121606214, + 19.102842627961163, + 10.879286697010043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5038957866757816, + 0.4973422473191169, + 0.10064736440099388 + ], + "xyz": [ + 8.175606333307243, + 8.26520514375448, + 13.688746177932133 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49714275679276526, + 0.5001208106651286, + 0.2986950023417165 + ], + "xyz": [ + 10.921266008583244, + 10.880550592089989, + 13.63440798684218 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000975699189151, + 0.49984218710122774, + 0.5036480194643358 + ], + "xyz": [ + 13.7195374759272, + 13.723029023841715, + 13.670996368823127 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5025858948349662, + 0.4957543142850661, + 0.7010793535975339 + ], + "xyz": [ + 16.362894477230686, + 16.456294616824422, + 13.64912763785144 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49970647664367784, + 0.49843359371357887, + 0.8976174765450136 + ], + "xyz": [ + 19.086558943382826, + 19.103961569684213, + 13.646391376711748 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4999117769218838, + 0.7037439986634212, + 0.0998314726333216 + ], + "xyz": [ + 10.986339199984231, + 8.199581754133847, + 16.456165105762683 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4985515289166625, + 0.6978410608301202, + 0.2992592189575729 + ], + "xyz": [ + 13.632175547206977, + 10.907524939001927, + 16.356864136351856 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49700215498320716, + 0.6990134379744578, + 0.5040313800461881 + ], + "xyz": [ + 16.447812203911024, + 13.685950304885585, + 16.35170990411046 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4974623823130258, + 0.7012337466326312, + 0.6977021103821083 + ], + "xyz": [ + 19.125999228651253, + 16.340073814519187, + 16.38835770964181 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49662797004197656, + 0.7008070519865403, + 0.9036173482931693 + ], + "xyz": [ + 21.935401604232137, + 19.143901948120813, + 16.371116082869914 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.503357810768379, + 0.8983890155090339, + 0.09680078101097635 + ], + "xyz": [ + 13.606055763858205, + 8.205260238260825, + 19.16443029443606 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4999644106588901, + 0.9041243777388333, + 0.2986051276638908 + ], + "xyz": [ + 16.443501306555067, + 10.917898985432162, + 19.19644917899176 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49759060543290035, + 0.9030074960152868, + 0.5020658524220998 + ], + "xyz": [ + 19.20990990663323, + 13.667123153631147, + 19.14872513534135 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49923474096555803, + 0.8967447970272487, + 0.7001460172610772 + ], + "xyz": [ + 21.832403772603417, + 16.397717837938075, + 19.085580967120812 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4979946330841707, + 0.8974768242917979, + 0.903933530076325 + ], + "xyz": [ + 24.62855811105719, + 19.166909499660928, + 19.078634580381912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6982251593124322, + 0.10081393169535666, + 0.09716832575477949 + ], + "xyz": [ + 2.7067777870519203, + 10.874476557011604, + 10.924318625222107 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6973338629776701, + 0.10310948894714488, + 0.30193924077777173 + ], + "xyz": [ + 5.537753324027709, + 13.661882005385722, + 10.943517427712722 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6958031537952485, + 0.1026776239760251, + 0.500387183536575 + ], + "xyz": [ + 8.244993496646915, + 16.35409897773997, + 10.916685467148852 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.696208722335985, + 0.10071157467181183, + 0.6997243349283545 + ], + "xyz": [ + 10.943415677589744, + 19.08494549096774, + 10.895350855037135 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.699409760089643, + 0.09872289340636886, + 0.8975801873769238 + ], + "xyz": [ + 13.621276385914635, + 21.833759103572355, + 10.911925974719844 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6986840611606248, + 0.3012501609727022, + 0.0966477855328236 + ], + "xyz": [ + 5.439989102993177, + 10.87363384826042, + 13.670920696846862 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6980777483842929, + 0.29697341340522615, + 0.30322068762539023 + ], + "xyz": [ + 8.2057457143524, + 13.689571983405905, + 13.604160374777182 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7005514563681003, + 0.2995128936901077, + 0.503550503003234 + ], + "xyz": [ + 10.979338208179962, + 16.462265250172194, + 13.672699782412808 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7008063414319963, + 0.29793233915736095, + 0.6974295864695241 + ], + "xyz": [ + 13.608409082024158, + 19.116429923802563, + 13.654575468055185 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7010494486942255, + 0.2955956141021956, + 0.9014690802668506 + ], + "xyz": [ + 16.36605302976861, + 21.909344874620615, + 13.625951902441363 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6975238974325466, + 0.5016518343734253, + 0.10332891838499503 + ], + "xyz": [ + 8.271187955177625, + 10.949115544350581, + 16.39491475361952 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998041489221711, + 0.49593646735662905, + 0.3015852743350718 + ], + "xyz": [ + 10.903573698495428, + 13.690815944676837, + 16.347950472452823 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7027628807791872, + 0.4960640904939083, + 0.5016823516866051 + ], + "xyz": [ + 13.641009763132386, + 16.466958418130467, + 16.39014656239093 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7030796792981892, + 0.5014975391540225, + 0.6962950401044471 + ], + "xyz": [ + 16.376004540957528, + 19.131999276223347, + 16.468762906779315 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6984349316686228, + 0.5042249714361208, + 0.8975798085351279 + ], + "xyz": [ + 19.165222626906516, + 21.82042624541244, + 16.442549716465493 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6962215968026306, + 0.6993786981880139, + 0.10123197798628655 + ], + "xyz": [ + 10.945805054733324, + 10.902641732870613, + 19.08039602505899 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.701019578965871, + 0.6978084445008547, + 0.29744868132882485 + ], + "xyz": [ + 13.606976278060728, + 13.650878330462227, + 19.124524947792846 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7009425478220827, + 0.6962698273642075, + 0.5033337351597131 + ], + "xyz": [ + 16.400763978185786, + 16.464648571196175, + 19.102436095319423 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7030088704249544, + 0.6989280641138672, + 0.6963729235610364 + ], + "xyz": [ + 19.0763039493135, + 19.132095998653547, + 19.16702942036655 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6974795524824858, + 0.6985095717863462, + 0.8998148880600775 + ], + "xyz": [ + 21.85200431661753, + 21.837922078098625, + 19.0857120289611 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6977787493357736, + 0.8994033594220304, + 0.09849738067284299 + ], + "xyz": [ + 13.64311929644389, + 10.886543919774402, + 21.836386298157116 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998695706393941, + 0.9034491232827682, + 0.30043758925665504 + ], + "xyz": [ + 16.459322434230735, + 13.676019434810001, + 21.920284585938894 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.702427208536618, + 0.8974061985922711, + 0.49747738130843366 + ], + "xyz": [ + 19.07059722535805, + 16.40487956953537, + 21.872634372252886 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7022147298706957, + 0.9022002248779301, + 0.699625918421066 + ], + "xyz": [ + 21.89987870247808, + 19.165713012128272, + 21.935272466631353 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7012173767072718, + 0.8970688622735333, + 0.903565436220716 + ], + "xyz": [ + 24.617948014839644, + 21.94030175744512, + 21.85148176782255 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9033412810988126, + 0.10088266053662556, + 0.09952365145543149 + ], + "xyz": [ + 2.7399190244192453, + 13.710988842193764, + 13.729568969730215 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9015938240747485, + 0.10331402073871133, + 0.29811534550931984 + ], + "xyz": [ + 5.4882700380571565, + 16.402207818902856, + 13.738919170877555 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9031833452855906, + 0.09766978282951692, + 0.5018413752996103 + ], + "xyz": [ + 8.196408641932964, + 19.20924507539116, + 13.683483814026689 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9013771198105565, + 0.1017080340975919, + 0.701342010030678 + ], + "xyz": [ + 10.979155654313761, + 21.912087453745983, + 13.7139996689045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8986154459180208, + 0.09772180295822883, + 0.9043213119315962 + ], + "xyz": [ + 13.699753099013005, + 24.649426824703546, + 13.621743525931286 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8962077110172882, + 0.29932744196670524, + 0.10307307546931876 + ], + "xyz": [ + 5.501547442292181, + 13.661987042303322, + 16.34514141526962 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9038807062520899, + 0.2975936403088527, + 0.2978004119278613 + ], + "xyz": [ + 8.14012031125095, + 16.42916794515502, + 16.426341000798825 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8955898452560196, + 0.3018886874908803, + 0.5011629914745496 + ], + "xyz": [ + 10.979178005513143, + 19.09615336826973, + 16.37171095357972 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8962460158594916, + 0.3026930449941042, + 0.6990630012241059 + ], + "xyz": [ + 13.695828347807048, + 21.81077772594387, + 16.391679030959406 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9008517948640539, + 0.2964921018998, + 0.9035253528198315 + ], + "xyz": [ + 16.40642263778495, + 24.669119575247493, + 16.36987023465399 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9041255741086877, + 0.5000437094848238, + 0.09741492048087211 + ], + "xyz": [ + 8.168346846337599, + 13.692881364739433, + 19.19754969481944 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8983981670268127, + 0.49673474325291983, + 0.3031893752789237 + ], + "xyz": [ + 10.936418562226027, + 16.42788859264641, + 19.07400602542065 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9039764655188915, + 0.4998966669335292, + 0.49686112814037353 + ], + "xyz": [ + 13.627493157847283, + 19.151999429742613, + 19.193500769725652 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9008023167059982, + 0.5026981744595482, + 0.6957835798285238 + ], + "xyz": [ + 16.385426817910748, + 21.828234991958606, + 19.18840608512694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8985145199960671, + 0.49658898436479176, + 0.9028870516692921 + ], + "xyz": [ + 19.133384458971506, + 24.62843803552589, + 19.073603992990876 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9016670800618612, + 0.6956020887395854, + 0.10093814986802109 + ], + "xyz": [ + 10.890154765000245, + 13.707438234659962, + 21.83757656740299 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8984443307540262, + 0.704433094405125, + 0.29859585860760607 + ], + "xyz": [ + 13.713231300378517, + 16.36571800171815, + 21.914251638839385 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9037421099358218, + 0.6967842952586913, + 0.4988062287740579 + ], + "xyz": [ + 16.34589843828142, + 19.175388428140508, + 21.882108917066446 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9042328916122687, + 0.6976990249438763, + 0.6982801841376408 + ], + "xyz": [ + 19.085576470304865, + 21.909270319299125, + 21.901324815410632 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9036503889578704, + 0.7007052113132844, + 0.8966167286881437 + ], + "xyz": [ + 21.838298045750324, + 24.612927984375126, + 21.93446098289918 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8983954856920937, + 0.903278471668299, + 0.10155996746526927 + ], + "xyz": [ + 13.737970268915099, + 13.671210963585896, + 24.63216204371896 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8997727390166803, + 0.9040695040057791, + 0.29913260634391947 + ], + "xyz": [ + 16.449962676321213, + 16.391218078807952, + 24.66180645499932 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8960096280099051, + 0.9003541062695786, + 0.503151350181301 + ], + "xyz": [ + 19.18847396961426, + 19.129077044854093, + 24.559561629596928 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8964735099279326, + 0.8986598673689581, + 0.7021682500846164 + ], + "xyz": [ + 21.886233872764127, + 21.856342387374763, + 24.542740410395172 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8970092779871969, + 0.8988143166996598, + 0.9001983392754713 + ], + "xyz": [ + 24.595777210213914, + 24.57109904584409, + 24.552176938311657 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.149335205071795, + 0.14748642211699964, + 0.15427279945342323 + ], + "xyz": [ + 4.125597760650939, + 4.150873988427969, + 4.058091859032306 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14944411923168657, + 0.15142958854966837, + 0.34613676307313695 + ], + "xyz": [ + 6.8026375974437014, + 6.7754926183127315, + 4.113491175519283 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1471288167498143, + 0.15278517278620532, + 0.5523024334018733 + ], + "xyz": [ + 9.639830836034298, + 9.562498154448845, + 4.100370080418343 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15416951237862186, + 0.14925997233498622, + 0.7493810344895347 + ], + "xyz": [ + 12.286058089923621, + 12.353180437683, + 4.148433297697201 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1518275405330826, + 0.1531867812281788, + 0.9477643354874693 + ], + "xyz": [ + 15.05200549653533, + 15.0334222024153, + 4.170100904542048 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1521335016669191, + 0.3457337569613273, + 0.1518369740234246 + ], + "xyz": [ + 6.80269747129195, + 4.1558296289527545, + 6.806751543858831 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15160250546078674, + 0.348972097947162, + 0.3463641971391981 + ], + "xyz": [ + 9.506512665887598, + 6.808111123940524, + 6.843765874364861 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1514416091171594, + 0.3489931718024973, + 0.5531758494244735 + ], + "xyz": [ + 12.334292467791322, + 9.633403062038667, + 6.8418542464729795 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14788642390049514, + 0.3484049125180937, + 0.7543368718338339 + ], + "xyz": [ + 15.076487182138369, + 12.335034499086513, + 6.78520581907439 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15207936375052578, + 0.3525035601810488, + 0.9493087642442241 + ], + "xyz": [ + 17.798143773323932, + 15.057980236081178, + 6.898566911066179 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15279639143974855, + 0.5461872540061921, + 0.14921564380986763 + ], + "xyz": [ + 9.50742324641956, + 4.1290541837664065, + 9.556378583480718 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14593749108417287, + 0.5526764943406327, + 0.34980236368129164 + ], + "xyz": [ + 12.338528500681305, + 6.7776660611795725, + 9.551324658210564 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1508858818665546, + 0.5537822684108694, + 0.5480039014841396 + ], + "xyz": [ + 15.063422193293981, + 9.555095317809688, + 9.63409611032589 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1541996446812861, + 0.5492399191314493, + 0.7472592937751554 + ], + "xyz": [ + 17.725503869000775, + 12.324584343967546, + 9.617299097326232 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14604059471046332, + 0.5501383137713279, + 0.950642038807324 + ], + "xyz": [ + 20.518398839991864, + 14.993647562581154, + 9.518032724559522 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14964694583083932, + 0.7460659012159222, + 0.15130007478623314 + ], + "xyz": [ + 12.268626098025786, + 4.114493495412903, + 12.246024816510854 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15419713713285982, + 0.7473572275277786, + 0.3496735835256205 + ], + "xyz": [ + 14.99840778317608, + 6.888829796113024, + 12.325888993854608 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14559044635962373, + 0.7510950165685935, + 0.5514593944321249 + ], + "xyz": [ + 17.80828944740784, + 9.529939954333443, + 12.259322245771257 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15389159298742539, + 0.7467377949708446, + 0.7493461388925855 + ], + "xyz": [ + 20.45419024867272, + 12.34890368747177, + 12.313242878875633 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1489999607158345, + 0.7544050783824171, + 0.9482178840959787 + ], + "xyz": [ + 23.27795467087138, + 15.000964875055043, + 12.351191081644256 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15041387981423224, + 0.9465207571408741, + 0.14938326785321773 + ], + "xyz": [ + 14.983002566994724, + 4.098772639422795, + 14.99709290821556 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14843034034078176, + 0.9508426128443969, + 0.3537381703910264 + ], + "xyz": [ + 17.835993643853723, + 6.865557488393349, + 15.029061946816187 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14812929916580045, + 0.9535983310406698, + 0.54710213106754 + ], + "xyz": [ + 20.51730659186026, + 9.505078972492788, + 15.062621849209423 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1519128374989189, + 0.9511177711030044, + 0.7513755396181944 + ], + "xyz": [ + 23.276182095384296, + 12.34959610003729, + 15.080435935295945 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15215544308542556, + 0.9457424564198731, + 0.9518360933795241 + ], + "xyz": [ + 25.943352368718394, + 15.093573568072227, + 15.01026246041453 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34701477115143725, + 0.1525867874238457, + 0.14790442522300426 + ], + "xyz": [ + 4.108261770889456, + 6.766446167376016, + 6.830462580560725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3530383004973044, + 0.1519899474706347, + 0.3479228035005739 + ], + "xyz": [ + 6.834717146983189, + 9.583414040860271, + 6.904655301133029 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35282583653280614, + 0.1522541834833419, + 0.5471102658535685 + ], + "xyz": [ + 9.561584865733357, + 12.303764403328083, + 6.9053631192571725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34800178917804425, + 0.14904726927018416, + 0.7485634233379705 + ], + "xyz": [ + 12.27197181941402, + 14.9920422037807, + 6.795565258273657 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34940046394756674, + 0.15286654196485996, + 0.9516113510195829 + ], + "xyz": [ + 15.100222946862564, + 17.787199352104174, + 6.8669040967736334 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35011042738139936, + 0.3466830169622794, + 0.1538459370362453 + ], + "xyz": [ + 6.843141763856109, + 6.890000702172442, + 9.526434548246792 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35014878173074027, + 0.35383390226332423, + 0.3466739703150737 + ], + "xyz": [ + 9.577217542474791, + 9.526835237875, + 9.62472453868373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3536667260698971, + 0.34643064898370807, + 0.5498401297066684 + ], + "xyz": [ + 12.253652757514661, + 12.352583100943162, + 9.571605294205378 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35220908252811167, + 0.3476873451994648, + 0.7472250539712738 + ], + "xyz": [ + 14.969445237230486, + 15.031265616075027, + 9.568857978534433 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3473764098557341, + 0.3481759124876247, + 0.953972148318694 + ], + "xyz": [ + 17.802733900693042, + 17.791803244620308, + 9.509466151660378 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3542241133098808, + 0.5497362911161294, + 0.14754045778453215 + ], + "xyz": [ + 9.533042201155041, + 6.860034898380016, + 12.358783936439615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.348597824158684, + 0.5518160044840643, + 0.34656314647904696 + ], + "xyz": [ + 12.282478043720483, + 9.504115661584342, + 12.310295790714498 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3518599263278732, + 0.5528169700248368, + 0.5490549801680366 + ], + "xyz": [ + 15.064594966085927, + 12.317146436928908, + 12.368579685092906 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3524015374442538, + 0.5503709282734759, + 0.7514831188062888 + ], + "xyz": [ + 17.79871419794607, + 15.092112321019291, + 12.34254265224897 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3500997965356049, + 0.5458611122930425, + 0.9513423708038545 + ], + "xyz": [ + 20.469496524273815, + 17.793083052274966, + 12.249416272541676 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3508279187223036, + 0.7536528000685239, + 0.14879593031365895 + ], + "xyz": [ + 12.338116601013734, + 6.830767331726853, + 15.10026158077881 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34751703548519125, + 0.7474678094782484, + 0.3532361443560606 + ], + "xyz": [ + 15.04862633011098, + 9.580571339217222, + 14.970435703068052 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34882332908921343, + 0.7511191311838633, + 0.5465954080659104 + ], + "xyz": [ + 17.74211959200584, + 12.242003799012165, + 15.038215327210654 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3486056191585546, + 0.7519312183906354, + 0.7529250598330068 + ], + "xyz": [ + 20.574124161743555, + 15.059929167650408, + 15.046341546341765 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35296331165121436, + 0.7487895986609536, + 0.9464372857080728 + ], + "xyz": [ + 23.176836822254142, + 17.765171074988647, + 15.062967474264104 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3462867644111698, + 0.9489710324982675, + 0.15212263305533075 + ], + "xyz": [ + 15.053954398588994, + 6.81416356847045, + 17.70853145294238 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35387448977566716, + 0.948850842014008, + 0.35039356004939937 + ], + "xyz": [ + 17.763035601018533, + 9.62862600895934, + 17.810626245668715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3492643075275814, + 0.953416075304769, + 0.550941427630581 + ], + "xyz": [ + 20.567304995781573, + 12.307450774050066, + 17.810011711614983 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.352591125276383, + 0.94611774544035, + 0.7493048049991253 + ], + "xyz": [ + 23.179511933549424, + 15.064922817459298, + 17.75571391284244 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3509159476758962, + 0.9505670039848227, + 0.9457977016924651 + ], + "xyz": [ + 25.926756910372855, + 17.728435605707347, + 17.793640648174048 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5516269629751043, + 0.15182169287676764, + 0.15094984707421782 + ], + "xyz": [ + 4.139437995332682, + 9.605503683168521, + 9.617423402048738 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5542284847351622, + 0.14838643995163778, + 0.34976772047148746 + ], + "xyz": [ + 6.810674013556092, + 12.359273398268376, + 9.606024779631484 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.548039082571484, + 0.1541360804160298, + 0.5477089681469851 + ], + "xyz": [ + 9.595499171844798, + 14.98087011477378, + 9.60001243683595 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5478136751633819, + 0.14864455602345433, + 0.7491896731514609 + ], + "xyz": [ + 12.275027971118188, + 17.732396317557832, + 9.52185157430481 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5535918588856328, + 0.14675814808609158, + 0.948654034433474 + ], + "xyz": [ + 14.976278185214644, + 20.538435449198026, + 9.575059232316159 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5493332794083244, + 0.35079484539711836, + 0.1534806595454205 + ], + "xyz": [ + 6.894363933983501, + 9.608745666866588, + 12.306389699277547 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.552942667561028, + 0.35063400743795137, + 0.3458924976632707 + ], + "xyz": [ + 9.522785002972988, + 12.28871258861687, + 12.353537656784544 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5485487010863159, + 0.3540275167155346, + 0.550223347747939 + ], + "xyz": [ + 12.362755053789007, + 15.022213672693143, + 12.339859586067695 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5486462616697811, + 0.34647155525675316, + 0.7525254282445639 + ], + "xyz": [ + 15.025288938972976, + 17.78938513360474, + 12.23788967181253 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5478645564532548, + 0.35437447865028965, + 0.9488037061035045 + ], + "xyz": [ + 17.816817569880616, + 20.46217908538875, + 12.33524968490934 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5511401738224393, + 0.5461719304779707, + 0.14952074919659752 + ], + "xyz": [ + 9.511385091828355, + 9.579310020550126, + 15.00225357381643 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5497366357184468, + 0.5462600396961339, + 0.35056210624527034 + ], + "xyz": [ + 12.261190951324608, + 12.308722346354385, + 14.984269266866571 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5480535269804458, + 0.5542869718931496, + 0.5480208135453549 + ], + "xyz": [ + 15.070553627113853, + 14.985331090287453, + 15.071000879309997 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5540472033152757, + 0.5503473515981245, + 0.7479730848975688 + ], + "xyz": [ + 17.750403310090547, + 17.800987016794128, + 15.099083563756121 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5519606784705715, + 0.5522167415249831, + 0.950000666578103 + ], + "xyz": [ + 20.53804600445193, + 20.534545156463366, + 15.096114934243621 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5528826580452257, + 0.7507101257124306, + 0.15054311313474297 + ], + "xyz": [ + 12.321772055935563, + 9.617110526933718, + 17.822485892833598 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5467286796561094, + 0.7482685299615707, + 0.3525251630665118 + ], + "xyz": [ + 15.049853228215197, + 12.294436672011985, + 17.70496875039519 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5521165350724274, + 0.7526615974129617, + 0.5488828446011507 + ], + "xyz": [ + 17.79448133321738, + 15.052665339008817, + 17.83869176727639 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5498651323705398, + 0.7520808085106108, + 0.752187196851126 + ], + "xyz": [ + 20.566081401064697, + 17.801425075699353, + 17.79997055345773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5458917726790493, + 0.7501181465045148, + 0.9528204942642471 + ], + "xyz": [ + 23.28227056763517, + 20.490124345440694, + 17.718814333292233 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5506412826743494, + 0.9538066109512277, + 0.1469330817582194 + ], + "xyz": [ + 15.049114945578872, + 9.537111147136482, + 20.568540801028036 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5499339560745926, + 0.9525175173318778, + 0.3458701718151532 + ], + "xyz": [ + 17.751322776234158, + 12.247272791765583, + 20.541246103148048 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5507726836356777, + 0.9503532640407849, + 0.552962568414134 + ], + "xyz": [ + 20.55306346447381, + 15.090069693679656, + 20.52312375396201 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5462309735746971, + 0.9497786925268554, + 0.7534091491648112 + ], + "xyz": [ + 23.28567759779696, + 17.76844582287246, + 20.453174873200524 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5471982083490687, + 0.9526775203138256, + 0.9476969995470945 + ], + "xyz": [ + 25.98157836812492, + 20.43793820121892, + 20.50603098464793 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7473216123755092, + 0.15420841563374346, + 0.14895250090998444 + ], + "xyz": [ + 4.144761482020869, + 12.253698347498876, + 12.32555626753746 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.746475157110207, + 0.15329706187943123, + 0.3489110741463838 + ], + "xyz": [ + 6.866099238280458, + 14.975923384218481, + 12.301523819026913 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7542379442660194, + 0.14791933531728238, + 0.5480273953905889 + ], + "xyz": [ + 9.514858431826488, + 17.80433731602401, + 12.334131938152577 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7486615659052223, + 0.15434776564694982, + 0.7477910257785093 + ], + "xyz": [ + 12.33387917138642, + 20.459230472033475, + 12.345781039301617 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7537157903167417, + 0.15089989749777863, + 0.9470046203737431 + ], + "xyz": [ + 15.010352945526227, + 23.251943325286383, + 12.367742852976315 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.754276879070534, + 0.34946506590055126, + 0.14756525195769385 + ], + "xyz": [ + 6.795309040300712, + 12.329823283834344, + 15.090161198094581 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7526911323587371, + 0.3462679667432756, + 0.3520208850483003 + ], + "xyz": [ + 9.546879489701102, + 15.103423853825879, + 15.024770990284877 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.747569745286043, + 0.3540692500181353, + 0.5480835692536695 + ], + "xyz": [ + 12.334070957576644, + 17.71393889879033, + 15.06141004877957 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.746040161071163, + 0.35319933364413625, + 0.7504486875091332 + ], + "xyz": [ + 15.088877088563692, + 20.45972616979706, + 15.028604508638521 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7497148334864705, + 0.3474236837414703, + 0.9542057948704733 + ], + "xyz": [ + 17.795643938276342, + 23.295696125183028, + 14.999880322607305 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7518841101379476, + 0.5462583272074281, + 0.14906607427730054 + ], + "xyz": [ + 9.506350058706941, + 12.317628750292076, + 17.74796973774725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7476115572291387, + 0.5498572253756031, + 0.34832570761929643 + ], + "xyz": [ + 12.279795386978325, + 14.98345701630013, + 17.73875965139116 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7543617811752072, + 0.5492243042050611, + 0.548487820044028 + ], + "xyz": [ + 15.00772257455118, + 17.812325234941163, + 17.822394313823658 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7509932985031089, + 0.5456949688081382, + 0.7524339694014287 + ], + "xyz": [ + 17.74778517999232, + 20.554586989882612, + 17.72808858679125 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7465842749583208, + 0.5502318067777837, + 0.9494211262023237 + ], + "xyz": [ + 20.50298496217609, + 23.18748056369612, + 17.729836042601306 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7516687101320599, + 0.7468512776012132, + 0.1482479842122569 + ], + "xyz": [ + 12.237635989646636, + 12.303499060070516, + 20.487495538691515 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7498922450431189, + 0.7497124393259543, + 0.3465891836629424 + ], + "xyz": [ + 14.988438455212055, + 14.990896726612101, + 20.502325315850783 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7510536926889484, + 0.7468008944910322, + 0.5535795638541461 + ], + "xyz": [ + 17.77856755801277, + 17.836711049471006, + 20.478398302099 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7540408528979412, + 0.7489626036442631, + 0.747032060289048 + ], + "xyz": [ + 20.45296976625672, + 20.52239867596814, + 20.548792717222838 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7532985503383797, + 0.7461663635508877, + 0.9497704265785184 + ], + "xyz": [ + 23.186542526027015, + 23.284052499991983, + 20.50041439900956 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7456337943866381, + 0.9508886848033639, + 0.1521353226857173 + ], + "xyz": [ + 15.080345686069368, + 12.27413777017217, + 23.19454996143945 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7498959828876932, + 0.9507388312948187, + 0.34611493084866696 + ], + "xyz": [ + 17.73035120234855, + 14.984463930639041, + 23.250773065236746 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.74990572902342, + 0.9500668706560779, + 0.5536331529382545 + ], + "xyz": [ + 20.558316056577464, + 17.82174895718126, + 23.241719387750152 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7542696120841811, + 0.9478221241265682, + 0.749680148443233 + ], + "xyz": [ + 23.207945520165257, + 20.56173041497391, + 23.270691840960843 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7465808686111421, + 0.9528275609008445, + 0.9520782095750017 + ], + "xyz": [ + 26.04352881090708, + 23.223761158326884, + 23.23400615477057 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499154295698773, + 0.14605268331733445, + 0.15089833608531827 + ], + "xyz": [ + 4.0598608860895755, + 15.050127657560015, + 14.983878765133637 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9489718774913591, + 0.1544083037337551, + 0.3482336838808001 + ], + "xyz": [ + 6.872030779108427, + 17.73516093807911, + 15.08521522927714 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9483216570871669, + 0.14670664742449824, + 0.5527962722767504 + ], + "xyz": [ + 9.563478007629925, + 20.523014129036188, + 14.971029874188671 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9520443853484948, + 0.15288379156164522, + 0.7484234310832705 + ], + "xyz": [ + 12.32251011270121, + 23.248489902048135, + 15.106379147643588 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.950548667765421, + 0.14975578111856583, + 0.9462555904865979 + ], + "xyz": [ + 14.984470190538907, + 25.932766394055115, + 15.043164370341067 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9514761258711242, + 0.3487650877439671, + 0.14652666571745074 + ], + "xyz": [ + 6.77153970080888, + 15.01169652609651, + 17.776663829127077 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9496183562278747, + 0.345975280130307, + 0.35248828587609726 + ], + "xyz": [ + 9.549268150997676, + 17.802167631649926, + 17.713122989434513 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9477193392444074, + 0.347596005522858, + 0.5538019526815505 + ], + "xyz": [ + 12.323750632938195, + 20.528528829379148, + 17.709318236895992 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9541083866787324, + 0.34829757675717543, + 0.7474660045917173 + ], + "xyz": [ + 14.981082446757418, + 23.263618794059155, + 17.80625989902231 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9522567701934614, + 0.35265793845448734, + 0.9465477130567502 + ], + "xyz": [ + 17.762505810444367, + 25.960113110189905, + 17.840559011987196 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.953005569044688, + 0.5518797237019308, + 0.1466314049707774 + ], + "xyz": [ + 9.549918419210105, + 15.034038774084118, + 20.574520843079075 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9518046309140341, + 0.5528536699140093, + 0.34907879186081825 + ], + "xyz": [ + 12.331058269542321, + 17.785443997161682, + 20.571417450426857 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9508642527386807, + 0.5456201898868674, + 0.5519873104550689 + ], + "xyz": [ + 15.00629217532489, + 20.546716058703566, + 20.45966593237682 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9504682891784403, + 0.5496586267937962, + 0.7535331186265984 + ], + "xyz": [ + 17.817002968873457, + 23.296800527257084, + 20.50946517232754 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.952512773915383, + 0.5478139935444329, + 0.9470917514778996 + ], + "xyz": [ + 20.438082262911223, + 25.971051142362384, + 20.51219750589246 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9515844975752904, + 0.7496062214524566, + 0.1527839903424393 + ], + "xyz": [ + 12.337316545421693, + 15.098727180483374, + 23.25837329621793 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9455744120809122, + 0.7512518032524224, + 0.3516994013270027 + ], + "xyz": [ + 15.079350337793073, + 17.7360940676266, + 23.19870258731859 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9520982004096346, + 0.7456472322744595, + 0.5507247652159096 + ], + "xyz": [ + 17.723764602728778, + 20.546325077898626, + 23.21126996147905 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9518407356706001, + 0.7497547454430687, + 0.7524804733864655 + ], + "xyz": [ + 20.538289509498, + 23.30117279241057, + 23.263907130599478 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9462925238128485, + 0.7516738992585088, + 0.9529660928205673 + ], + "xyz": [ + 23.305531136506552, + 25.966321940061064, + 23.21429130227544 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9527660785023653, + 0.9466778288724852, + 0.14835815306954908 + ], + "xyz": [ + 14.971134838634741, + 15.054372291689528, + 25.968855201725624 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9529276651396389, + 0.9478848213559323, + 0.35212746351266716 + ], + "xyz": [ + 17.773533956512214, + 17.84247880901117, + 25.987566169119876 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9463036774112366, + 0.9494318016988781, + 0.5508800839966917 + ], + "xyz": [ + 20.511994045090404, + 20.46922689289214, + 25.918154238007244 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9523564594731629, + 0.9516355365776811, + 0.7502421612109014 + ], + "xyz": [ + 23.267765546179895, + 23.277621874240804, + 26.031035851447847 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9515283256053815, + 0.9485585459609799, + 0.9466552562428756 + ], + "xyz": [ + 25.91102196524671, + 25.951624257984633, + 25.977645692418406 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09644473739409348, + 0.09846995486019842, + 0.10432147146413172 + ], + "xyz": [ + 2.772527878249503, + 2.74483946959206, + 2.6648385878560727 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10059746903330645, + 0.09710920647383185, + 0.29776316060348246 + ], + "xyz": [ + 5.398623925654967, + 5.446314823480843, + 2.703010080332003 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09913999967319698, + 0.10369811955824458, + 0.5013913089181229 + ], + "xyz": [ + 8.27267375003177, + 8.210355955424978, + 2.773166255270807 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10310441527954024, + 0.10273146301151491, + 0.6973191997188785 + ], + "xyz": [ + 10.938148651730646, + 10.94324758800768, + 2.8141510775372134 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10455056139327308, + 0.0993808202429239, + 0.8996806108639926 + ], + "xyz": [ + 13.658988055036163, + 13.72966782549033, + 2.7881131420813903 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10391985285041724, + 0.29892552054555643, + 0.0959627708507474 + ], + "xyz": [ + 5.398841640077814, + 2.7327592523700566, + 5.50762943290254 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10354296633885918, + 0.29568763691892186, + 0.29920266192659106 + ], + "xyz": [ + 8.13323308556206, + 5.506265735432147, + 5.458208946231795 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09961643970440898, + 0.29712589661251365, + 0.49842526221619804 + ], + "xyz": [ + 10.876632244297555, + 8.176318501152192, + 5.424189808504429 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10405917766087344, + 0.3000568252233408, + 0.6957869348062637 + ], + "xyz": [ + 13.614996635247946, + 10.935352077350455, + 5.5250012505524575 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10043239553588897, + 0.30345156548299096, + 0.8953564787240507 + ], + "xyz": [ + 16.389887794950713, + 13.614246246884527, + 5.521828815937142 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0991447750962554, + 0.5002123092755735, + 0.09624369269761605 + ], + "xyz": [ + 8.15463909689709, + 2.6713159617536073, + 8.194302173256457 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10229395943220652, + 0.5034072858273857, + 0.2964025351961064 + ], + "xyz": [ + 10.934855907265398, + 5.45090670918926, + 8.281038398964997 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09841142805675154, + 0.49609761631418686, + 0.5019052291320547 + ], + "xyz": [ + 13.644515262428833, + 8.207421280087065, + 8.128020643011482 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10134190211580761, + 0.49866610723502064, + 0.6960806735922492 + ], + "xyz": [ + 16.33436293304988, + 10.902217919016925, + 8.20320150240284 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0993212014779413, + 0.5024900760298924, + 0.8954931196106359 + ], + "xyz": [ + 19.112974613822086, + 13.600922331345231, + 8.22785546005715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09797463854871054, + 0.6979616909947676, + 0.09905475692828651 + ], + "xyz": [ + 10.896665413043367, + 2.6937504296703176, + 10.881898228979114 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10020852367575983, + 0.7016978436435404, + 0.2952064896310819 + ], + "xyz": [ + 13.629496601750645, + 5.406042887228745, + 10.963519510843353 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10128938076603415, + 0.704040232285198, + 0.4963224930026162 + ], + "xyz": [ + 16.411143114844442, + 8.170441968027708, + 11.010321510306095 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09990631458446608, + 0.7027531881751001, + 0.6952706756868561 + ], + "xyz": [ + 19.113530622425166, + 10.871516679131267, + 10.973816243018291 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0994328360046847, + 0.7048995199072209, + 0.8983475669294706 + ], + "xyz": [ + 21.919305586755613, + 13.641474068443241, + 10.996687190203508 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09918683325906186, + 0.8982194452499993, + 0.10497410025728715 + ], + "xyz": [ + 13.715481579337428, + 2.79125153406749, + 13.63635910664575 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10435453263804473, + 0.896175503579843, + 0.3002401032860772 + ], + "xyz": [ + 16.357178822261623, + 5.531545035320128, + 13.67906655976444 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09847904338285048, + 0.8998838324541287, + 0.49690879225998597 + ], + "xyz": [ + 19.096697342418928, + 8.140035319098443, + 13.649437533125528 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10295860050470358, + 0.9026589776149547, + 0.6983395621361586 + ], + "xyz": [ + 21.888563855740063, + 10.95520424595659, + 13.748622516887906 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09872108562421736, + 0.9010519141994124, + 0.8961466637036339 + ], + "xyz": [ + 24.570975461346425, + 13.601652792615502, + 13.668716494448697 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3030405014072538, + 0.09803546444131951, + 0.1026679952247862 + ], + "xyz": [ + 2.743981573932257, + 5.546773538423857, + 5.483438411407842 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3021748545039693, + 0.09496709653893239, + 0.3012108954746341 + ], + "xyz": [ + 5.416474194770918, + 8.24938136427247, + 5.429653269107364 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3018017168815269, + 0.10001261587257085, + 0.5029234502348316 + ], + "xyz": [ + 8.243233367328507, + 11.002057634284773, + 5.493533230834128 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30155714292820773, + 0.09565119423153967, + 0.6992738046307502 + ], + "xyz": [ + 10.868071497945431, + 13.68318056545551, + 5.430560888147377 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30315098061421997, + 0.10261510086658322, + 0.8964657248118302 + ], + "xyz": [ + 13.659253214126645, + 16.40094366557798, + 5.547560828110874 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2998888372222269, + 0.3040485763002139, + 0.10027679451488465 + ], + "xyz": [ + 5.527863691217281, + 5.470992487296076, + 8.256923608944376 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30168742571821244, + 0.30220957549759153, + 0.29497606827312345 + ], + "xyz": [ + 8.164614628217336, + 8.157475890420624, + 8.256371099162251 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2961116550046143, + 0.29827772091049676, + 0.5032605418914737 + ], + "xyz": [ + 10.958486852141235, + 10.928872788967873, + 8.126384557423732 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3011639122547573, + 0.29814564965676116, + 0.6965237119790972 + ], + "xyz": [ + 13.598940471800361, + 13.640205614752896, + 8.193652454733135 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2965983079949518, + 0.2976315072336307, + 0.9033382530511699 + ], + "xyz": [ + 16.41944238805694, + 16.405316674041586, + 8.124203072438439 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2987044050686276, + 0.49583011052031656, + 0.10238836785658144 + ], + "xyz": [ + 8.178735357042841, + 5.483668194734331, + 10.862732880919237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30066527118121583, + 0.49795065531410354, + 0.3044761656275108 + ], + "xyz": [ + 10.97063505908598, + 8.273384798590284, + 10.918533196177236 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3029164290031017, + 0.4951933358707756, + 0.5015945092822205 + ], + "xyz": [ + 13.627903997119633, + 10.999128736268032, + 10.91161304559797 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2960221898020522, + 0.49956659033942696, + 0.7042670710109046 + ], + "xyz": [ + 16.458597127922687, + 13.675774721767798, + 10.877146596113876 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30167590861292964, + 0.4954371151738909, + 0.9032384238107565 + ], + "xyz": [ + 19.12244020740108, + 16.4733718683168, + 10.897985780869128 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29655225910169214, + 0.6976600514941615, + 0.10264032825697542 + ], + "xyz": [ + 10.941562737889187, + 5.457689199701978, + 13.592691752250603 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2984474251786088, + 0.6995933227572793, + 0.2971231845035212 + ], + "xyz": [ + 13.626928678298356, + 8.142534172864337, + 13.645033458444832 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.297549637201162, + 0.7046366067173861, + 0.5003812017626088 + ], + "xyz": [ + 16.474786574332963, + 10.90916680276166, + 13.701709933330484 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30019341678885036, + 0.6952404241838348, + 0.7030326179288662 + ], + "xyz": [ + 19.116937342617266, + 13.71592576597437, + 13.609392295687176 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30167470693274384, + 0.6950914009331757, + 0.9026444368286294 + ], + "xyz": [ + 21.8439567814286, + 16.465234556059617, + 13.627606808843435 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.301350907074246, + 0.9008135969857385, + 0.0950830339705125 + ], + "xyz": [ + 13.615719477040289, + 5.41997348385455, + 16.435776709897375 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30366085507815355, + 0.8982830027553599, + 0.2961996209133319 + ], + "xyz": [ + 16.330751423926092, + 8.20118445286991, + 16.432760074405383 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3025776244921814, + 0.8988208633283372, + 0.5028523118334906 + ], + "xyz": [ + 19.16342334964098, + 11.011693112056047, + 16.42530387375432 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29682125612715576, + 0.8982397938458354, + 0.704571871242596 + ], + "xyz": [ + 21.91335257898932, + 13.690866586636318, + 16.338659564241738 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30275746334063686, + 0.896241495696751, + 0.9029508767442028 + ], + "xyz": [ + 24.59823426138568, + 16.48422739813871, + 16.392497948146538 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.498069264722685, + 0.1049952827289121, + 0.09781077193303196 + ], + "xyz": [ + 2.7727278742482597, + 8.146764602750363, + 8.244989941139693 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5004844267774621, + 0.09831478619214952, + 0.304501927327689 + ], + "xyz": [ + 5.507237600234798, + 11.005628535781886, + 8.186675055862194 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5003451494530735, + 0.09973936986454575, + 0.49583167297400194 + ], + "xyz": [ + 8.142540094900912, + 13.619550204394937, + 8.204247532897012 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5000900244641602, + 0.09883937536594688, + 0.7045547058557003 + ], + "xyz": [ + 10.98385926752774, + 16.469685916881673, + 8.188454947185253 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49675789412567256, + 0.09792817122149258, + 0.9010265048043024 + ], + "xyz": [ + 13.657528518782982, + 19.11025670097881, + 8.130440841934679 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49830331464222083, + 0.2960699872594803, + 0.10260612366642002 + ], + "xyz": [ + 5.450628026878942, + 8.215525676856842, + 10.860528796405715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5025511818928149, + 0.3032285958952696, + 0.29765975447312837 + ], + "xyz": [ + 8.21523736633367, + 10.94033988402663, + 11.01647608155869 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49855445264366827, + 0.2973260458773296, + 0.49918618955345956 + ], + "xyz": [ + 10.88977191060737, + 13.640930466803534, + 10.881134917289348 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49740587858477386, + 0.30167772976712803, + 0.6969742783528431 + ], + "xyz": [ + 13.653390497654783, + 16.32935051722285, + 10.924927258337698 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5005757996646281, + 0.30241858483422707, + 0.8950694985095112 + ], + "xyz": [ + 16.371841527620585, + 19.08101130048316, + 10.978394685879136 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.503424896908204, + 0.49553810752881794, + 0.10153422625212222 + ], + "xyz": [ + 8.163065474432932, + 8.27089223920581, + 13.657642383322164 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5025395741899248, + 0.5015526632035778, + 0.2950378833372963 + ], + "xyz": [ + 10.890842566008452, + 10.904335435369811, + 13.727768333041237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5024298032676631, + 0.5033784678878688, + 0.4972594121372092 + ], + "xyz": [ + 13.68054098088446, + 13.667571008956639, + 13.751229637749622 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49894416427624816, + 0.5032257530195118, + 0.7021060403848282 + ], + "xyz": [ + 16.47907931970132, + 16.420542209089394, + 13.701486718682515 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5014241931387547, + 0.49958271705335594, + 0.8955260218536641 + ], + "xyz": [ + 19.073675558763775, + 19.09885188833765, + 13.6855862949027 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49503216130291927, + 0.7010520080631908, + 0.10258500571922217 + ], + "xyz": [ + 10.987180597770667, + 8.170514336436653, + 16.35264746842297 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5027762338058878, + 0.7029934182352755, + 0.2964343573400565 + ], + "xyz": [ + 13.663996650666336, + 10.926663344240943, + 16.485065644169417 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4949466467041455, + 0.701450616650858, + 0.5015679503068321 + ], + "xyz": [ + 16.447453304103487, + 13.624168197706624, + 16.356928033082202 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5013164295725594, + 0.6950354110086264, + 0.7026002329036368 + ], + "xyz": [ + 19.10822294915256, + 16.459731904375307, + 16.356307021094665 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49585111455524367, + 0.6988753080308111, + 0.9016734611465242 + ], + "xyz": [ + 21.882414673414075, + 19.106704444570944, + 16.334084598840473 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5014733747734491, + 0.8967190451232008, + 0.1040398959782585 + ], + "xyz": [ + 13.682196106129751, + 8.27846844532861, + 19.115835090191414 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49663001736028073, + 0.9046892542221363, + 0.29923227882303655 + ], + "xyz": [ + 16.459798493917653, + 10.880886058204998, + 19.15858484360592 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5035733919244252, + 0.9016411221260193, + 0.499002323935455 + ], + "xyz": [ + 19.149345078732185, + 13.707034723607427, + 19.211839897485145 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5041169566835677, + 0.8995644544692262, + 0.70043130515481 + ], + "xyz": [ + 21.87485402634309, + 16.468367017167168, + 19.190879590626988 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5041324338173299, + 0.9013548700099094, + 0.8968878659548163 + ], + "xyz": [ + 24.58525100241725, + 19.15449735483082, + 19.215569430211325 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7039402126461817, + 0.096052448380469, + 0.10125487398452643 + ], + "xyz": [ + 2.6975501960561914, + 11.008482289299446, + 10.937355662877382 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6992300741880422, + 0.09616807637009306, + 0.30434720893909367 + ], + "xyz": [ + 5.475772887995845, + 13.720727971003237, + 10.874540342763725 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7017394353621481, + 0.1039075114254113, + 0.4972010915972635 + ], + "xyz": [ + 8.218248620977464, + 16.39169907529422, + 11.01466004002909 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.696388478040628, + 0.1002603605496018, + 0.7044606724386672 + ], + "xyz": [ + 11.002001113229674, + 19.152157432505835, + 10.891639524414675 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7041875239254007, + 0.10041096726483935, + 0.8994273378050107 + ], + "xyz": [ + 13.669609336020077, + 21.924333738903073, + 11.000325743824547 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6970483545031627, + 0.3047296418243349, + 0.09999901462088585 + ], + "xyz": [ + 5.533377339760897, + 10.897088162137548, + 13.696128445750206 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7007967429891148, + 0.2970085197559285, + 0.3044325824554528 + ], + "xyz": [ + 8.222794490035607, + 13.743314396199546, + 13.641813947302936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998674159802175, + 0.3011274699909243, + 0.4954741686483068 + ], + "xyz": [ + 10.890994215180612, + 16.342494983555948, + 13.685421901917975 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.699118815884373, + 0.30306787755891956, + 0.6956157324697108 + ], + "xyz": [ + 13.653822553261627, + 19.068559692878328, + 13.701716079151874 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.695669837553042, + 0.30098886182246565, + 0.8995576912077494 + ], + "xyz": [ + 16.413656374649552, + 21.80966363226236, + 13.626138339296052 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7016708787005235, + 0.4952088101239516, + 0.10021405291135199 + ], + "xyz": [ + 8.140514207303324, + 10.963226445709871, + 16.363523667264236 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998356099672596, + 0.5018984715853696, + 0.29531820143660115 + ], + "xyz": [ + 10.89940285455524, + 13.60556378182753, + 16.429892050852864 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7046890665715263, + 0.499419709123423, + 0.4966275851919136 + ], + "xyz": [ + 13.617779319366303, + 16.424185025912433, + 16.46235844172172 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.701505340407912, + 0.5008308438440353, + 0.7026104169808542 + ], + "xyz": [ + 16.45323229857094, + 19.19681789418288, + 16.438123890579458 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6954258354085435, + 0.4997807911209279, + 0.9033401492280967 + ], + "xyz": [ + 19.183216934682598, + 21.858040764074907, + 16.340649860718155 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.703787080211341, + 0.7011698130105282, + 0.0957546836154389 + ], + "xyz": [ + 10.895408271460827, + 10.931191077522245, + 19.208317751888615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7003140525030579, + 0.7004349627289611, + 0.2955223741583002 + ], + "xyz": [ + 13.616549437601995, + 13.614896374757288, + 19.15078840142942 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7033822089370498, + 0.6972624991748186, + 0.49693006341840235 + ], + "xyz": [ + 16.32678576111325, + 16.410453331434717, + 19.149362333258004 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7037522220999337, + 0.7005083252976341, + 0.695543162907685 + ], + "xyz": [ + 19.086564657475243, + 19.13091463065486, + 19.198797437121012 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7028058310301067, + 0.7026940974877217, + 0.8958386470785132 + ], + "xyz": [ + 21.85485194781554, + 21.856379548694992, + 19.215742032708615 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6983766294381313, + 0.9039871212019224, + 0.09627712430580875 + ], + "xyz": [ + 13.675432717017507, + 10.864363083511472, + 21.907228773275694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7041053075681102, + 0.8958379072621094, + 0.29985330211997757 + ], + "xyz": [ + 16.347274990254203, + 13.72594139910579, + 21.874135643380093 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7047075209451329, + 0.8966753480123982, + 0.4991224684460772 + ], + "xyz": [ + 19.083096503013312, + 16.458546925558533, + 21.89381833547095 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.70454175271742, + 0.899068722874773, + 0.696430260861304 + ], + "xyz": [ + 21.81337491582257, + 19.153837194685867, + 21.924273772410853 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7025150522371767, + 0.8954202382041169, + 0.9025828826190708 + ], + "xyz": [ + 24.58197502733287, + 21.94461004772634, + 21.846683662561084 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9039180762531489, + 0.10025697689231494, + 0.10016042791688173 + ], + "xyz": [ + 2.740070683418471, + 13.727580574881907, + 13.728900575095214 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9014282326689637, + 0.1020101467864918, + 0.3016160558784729 + ], + "xyz": [ + 5.5183047901189175, + 16.44780496504861, + 13.718828905006683 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.899310744146741, + 0.0956869669253663, + 0.5013499023925406 + ], + "xyz": [ + 8.162580610677946, + 19.149580240568678, + 13.603429606189856 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9009120995267751, + 0.09541634218506981, + 0.7001538937192684 + ], + "xyz": [ + 10.876893062641647, + 21.88948606778112, + 13.621623115964834 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.901281287530627, + 0.09672992625877487, + 0.8978379095791088 + ], + "xyz": [ + 13.597552429365093, + 24.597233821428826, + 13.644629672910218 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8949376486671647, + 0.30167073359698243, + 0.1015097919265959 + ], + "xyz": [ + 5.512211572463768, + 13.623250047258589, + 16.35981441280661 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9014078359686778, + 0.30365938757896566, + 0.29573030139101447 + ], + "xyz": [ + 8.194747937453553, + 16.367057129116986, + 16.47546216824314 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9039046938297634, + 0.29614467669496547, + 0.501411998661165 + ], + "xyz": [ + 10.904051305267451, + 19.21323686273132, + 16.406858984927396 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9041018663903172, + 0.2995841232549814, + 0.7004426091044851 + ], + "xyz": [ + 13.6721854800068, + 21.937043250959345, + 16.456578186952385 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9047038852416892, + 0.29665573749176766, + 0.8993680254785252 + ], + "xyz": [ + 16.351821603052507, + 24.66494643042284, + 16.42477251727973 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9038188758770851, + 0.4962355382839057, + 0.0983170413710885 + ], + "xyz": [ + 8.128615849578742, + 13.701021876151923, + 19.141291940614515 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8953459034345789, + 0.500628074319395, + 0.3005847303289384 + ], + "xyz": [ + 10.954037246847177, + 16.350548357300728, + 19.085504948536332 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8964553943579847, + 0.5045577206798801, + 0.4999346022106195 + ], + "xyz": [ + 13.73323822994079, + 19.09119268288657, + 19.154399126436978 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9029376645776516, + 0.49591515413921106, + 0.6985406567417874 + ], + "xyz": [ + 16.330384844319052, + 21.89512334298153, + 19.124863943989574 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9031726594716432, + 0.49758393446939647, + 0.8966175281144529 + ], + "xyz": [ + 19.061271440183123, + 24.606407482443338, + 19.150892016174982 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9012573676893109, + 0.6963513944328428, + 0.1040667847667801 + ], + "xyz": [ + 10.943173270744987, + 13.744610854032231, + 21.8422194261569 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.903578799414932, + 0.6968345822193358, + 0.3021730544046186 + ], + "xyz": [ + 13.65825258654811, + 16.484822310087207, + 21.880563679295015 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9030287729130652, + 0.6952098340355638, + 0.5003472718633974 + ], + "xyz": [ + 16.345441551571533, + 19.186704676495733, + 21.8508305512524 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8999618970966468, + 0.7046012633471828, + 0.6988706348117728 + ], + "xyz": [ + 19.18801516668757, + 21.858950586396166, + 21.937298708219156 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9021431219178637, + 0.6954198889452705, + 0.8995303528457003 + ], + "xyz": [ + 21.805872614722627, + 24.632155445741986, + 21.841593923178813 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9043897192164534, + 0.9006311879916145, + 0.09649790529882632 + ], + "xyz": [ + 13.632569480230114, + 13.68395544260049, + 24.677920939585402 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9023393451992379, + 0.8986906731007641, + 0.29584341495021926 + ], + "xyz": [ + 16.331455035697193, + 16.38133902386655, + 24.62335822479433 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8980116317665635, + 0.8965828225803322, + 0.5012887678488347 + ], + "xyz": [ + 19.11144876746129, + 19.13098318946979, + 24.535372352828972 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9042998290512247, + 0.8984815838400978, + 0.7007975857499481 + ], + "xyz": [ + 21.86505693638458, + 21.944602937626968, + 24.64730297639584 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.900940579855298, + 0.9017831397690039, + 0.8950004287086876 + ], + "xyz": [ + 24.56530152718467, + 24.553782199705267, + 24.64651420443392 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15491927011177872, + 0.14744069514901126, + 0.1494139508836213 + ], + "xyz": [ + 4.058543286721866, + 4.160789017469329, + 4.133811020251773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14704050879423017, + 0.15425332065580083, + 0.35116321920458354 + ], + "xyz": [ + 6.909963957993999, + 6.81135169252874, + 4.119235003351522 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14688584374172384, + 0.1525611319477956, + 0.5532622455499169 + ], + "xyz": [ + 9.649890168940775, + 9.572298650139238, + 4.093985151171485 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14671870632790854, + 0.1536866030208362, + 0.752010874631658 + ], + "xyz": [ + 12.382532888918924, + 12.287269059554621, + 4.107087316460355 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14810944549260396, + 0.15501773892075346, + 0.9478896215429033 + ], + "xyz": [ + 15.07875090893423, + 14.984301964677387, + 4.1443003024062275 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1540791283255185, + 0.34822624738865976, + 0.14641866776866644 + ], + "xyz": [ + 6.762696243946235, + 4.1083517785964, + 6.867428681796616 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1532501641214858, + 0.35144437357182684, + 0.34995168394739956 + ], + "xyz": [ + 9.589360647112509, + 6.879685090465147, + 6.900092874326185 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1545333572111992, + 0.3467878224975673, + 0.5482219751398449 + ], + "xyz": [ + 12.236412851535125, + 9.607944407943652, + 6.853972931165908 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1492256964425189, + 0.3480475895308857, + 0.7477501482955033 + ], + "xyz": [ + 14.981549427969581, + 12.263292293606186, + 6.798630856636912 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1528368405013214, + 0.3468762903731258, + 0.9472804711508045 + ], + "xyz": [ + 17.6934782953381, + 15.040605863791766, + 6.831987976951884 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1468902127967371, + 0.5516447938273785, + 0.15395664508924856 + ], + "xyz": [ + 9.646855864609119, + 4.113124088582777, + 9.550244874263715 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1489359711891374, + 0.5549756595702751, + 0.3486356737320023 + ], + "xyz": [ + 12.354011498868742, + 6.802709966465736, + 9.62375311164915 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15216990900107027, + 0.5517903561680179, + 0.5449798212463072 + ], + "xyz": [ + 14.994844446976716, + 9.531305624990699, + 9.62441803254404 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1464934848941327, + 0.5509938186324848, + 0.7482731162341882 + ], + "xyz": [ + 17.763343665448875, + 12.233087912638199, + 9.535920866101279 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14830596104615598, + 0.5462655894507417, + 0.9515545114948096 + ], + "xyz": [ + 20.477926812509406, + 15.037094405695022, + 9.496057215514494 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15240745615231643, + 0.7532178924490145, + 0.1482518775827925 + ], + "xyz": [ + 12.324732431316258, + 4.110560292146337, + 12.381546753514646 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14854309537730284, + 0.7549097285918535, + 0.3492861316443233 + ], + "xyz": [ + 15.096367045894164, + 6.806231582578809, + 12.351844387797989 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14775033338868104, + 0.746544327169544, + 0.5521593558810683 + ], + "xyz": [ + 17.75564298800502, + 9.569039287951943, + 12.22663562611315 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1524749391068057, + 0.7533186703384244, + 0.7475017176780624 + ], + "xyz": [ + 20.518946197291562, + 12.304318855764494, + 12.383847185485484 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14707195827652114, + 0.7482503094069679, + 0.9499239068947379 + ], + "xyz": [ + 23.217132213917985, + 14.99793000936572, + 12.240684885760478 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15056461790106979, + 0.9502548861626171, + 0.1536841420814577 + ], + "xyz": [ + 15.092855685127907, + 4.159634281704318, + 15.050206112047995 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1506203515426538, + 0.9540172720164983, + 0.34581539010997214 + ], + "xyz": [ + 17.77107818671392, + 6.787180101441203, + 15.102406754528486 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14803146883457044, + 0.9486741490469204, + 0.5482427807331691 + ], + "xyz": [ + 20.46557881890602, + 9.519336210725212, + 14.993961800664522 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14588361257949645, + 0.9509672602587341, + 0.7491870174490962 + ], + "xyz": [ + 23.244203257051467, + 12.237244541037512, + 14.995947700287175 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14720433742097633, + 0.9487033139674418, + 0.9491853431935967 + ], + "xyz": [ + 25.947592100747425, + 14.98964236321993, + 14.983052146405202 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3476865790081253, + 0.1505325359618424, + 0.15456591560196345 + ], + "xyz": [ + 4.171251112059072, + 6.866705700860102, + 6.811562060428702 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34797560909675734, + 0.1530470437943841, + 0.3463001042886583 + ], + "xyz": [ + 6.8269843261047, + 9.492012583776992, + 6.849891526250165 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3507506172963508, + 0.15447007106660496, + 0.547572325807183 + ], + "xyz": [ + 9.59819728242699, + 12.281709579981754, + 6.907286311574425 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35091645422778733, + 0.1501794132444433, + 0.7454044156128969 + ], + "xyz": [ + 12.24426090304836, + 14.988701594705264, + 6.850892502824192 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35014036108485813, + 0.15307952631480673, + 0.9452633590957558 + ], + "xyz": [ + 15.016346227613834, + 17.71052648963972, + 6.879931720948485 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3505334970111604, + 0.34869370378821174, + 0.14638953497594595 + ], + "xyz": [ + 6.7686889254005855, + 6.793842247181959, + 9.55970842843287 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35001522781247996, + 0.3547724823204053, + 0.34763432528154037 + ], + "xyz": [ + 9.603179440308432, + 9.538139112981888, + 9.635730711148982 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3483948860093612, + 0.3460496076179835, + 0.5533370721400557 + ], + "xyz": [ + 12.296252796049554, + 12.32831702006636, + 9.494320116864202 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3547175677472088, + 0.34679654987370245, + 0.7497794472757116 + ], + "xyz": [ + 14.992189649347301, + 15.100484379930661, + 9.590974743571925 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35212639242248583, + 0.34958609026742055, + 0.9453967380169666 + ], + "xyz": [ + 17.704772131395046, + 17.739502685204712, + 9.593686755089514 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35459078088988, + 0.5483276789742966, + 0.15028846297941603 + ], + "xyz": [ + 9.551354141885605, + 6.902618143917119, + 12.344538657940246 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.346383565403599, + 0.547910725950434, + 0.3523438007960457 + ], + "xyz": [ + 12.308117843863055, + 9.552874779755626, + 12.226630578419893 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35032277604394146, + 0.5546584791601759, + 0.5476264784237037 + ], + "xyz": [ + 15.070241528794435, + 12.27660057621584, + 12.372740824524755 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35077468289310587, + 0.5452270795965373, + 0.7531961228173836 + ], + "xyz": [ + 17.75180830722669, + 15.093290140928783, + 12.249974816441151 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34569002787155667, + 0.5519629288998559, + 0.9533014591409693 + ], + "xyz": [ + 20.579703765704313, + 17.75957779196759, + 12.272549647446532 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3453136643857187, + 0.7533530857476516, + 0.15093661445433934 + ], + "xyz": [ + 12.363286009015582, + 6.784644487251081, + 15.020774047808413 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3492448507096742, + 0.7541470199025788, + 0.3459889972910805 + ], + "xyz": [ + 15.040861602588615, + 9.505112027773677, + 15.085375044474011 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3455064109581605, + 0.7506804233655179, + 0.5501297799317696 + ], + "xyz": [ + 17.784442953643918, + 12.244976787332762, + 14.98686908524315 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3534267595424511, + 0.7522495280975714, + 0.7479762005473997 + ], + "xyz": [ + 20.510816121402886, + 15.058183017815622, + 15.11660718288261 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35078527194829795, + 0.754450747083366, + 0.9476119280020927 + ], + "xyz": [ + 23.270294522486875, + 17.75145280622575, + 15.110587909717482 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3478646530540205, + 0.9464808498154895, + 0.15363616707379227 + ], + "xyz": [ + 15.040601833847218, + 6.856428942639832, + 17.696058733041422 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34905675894362104, + 0.954477469595961, + 0.346354499661139 + ], + "xyz": [ + 17.784740533928602, + 9.507537553617729, + 17.821685336432026 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3484786426618573, + 0.9538617253808224, + 0.5515012743306041 + ], + "xyz": [ + 20.58105196671467, + 12.304363428735872, + 17.805363090613266 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35211103942377175, + 0.9534614412098655, + 0.7461471859860228 + ], + "xyz": [ + 23.236743221469286, + 15.015188771322135, + 17.849551952176572 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3529772754582085, + 0.9460614354830515, + 0.9526487074749166 + ], + "xyz": [ + 25.958823306695606, + 17.850283425984756, + 17.760223429020936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5509761624127185, + 0.14644424936419945, + 0.15423225043804895 + ], + "xyz": [ + 4.110794983526375, + 9.64148248298138, + 9.5350063341399 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5490879235049282, + 0.1498699723362463, + 0.3545736876750482 + ], + "xyz": [ + 6.896662919815616, + 12.354698888962623, + 9.556026539519285 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5537457862322328, + 0.14933239629426745, + 0.5512018281781444 + ], + "xyz": [ + 9.57757782082641, + 15.106644893648083, + 9.612358357429455 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.546706006121912, + 0.14746757925654144, + 0.7529477590493583 + ], + "xyz": [ + 12.310316430557364, + 17.768632339743874, + 9.490616308048846 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5487945226400918, + 0.1529977071973576, + 0.9524351028620338 + ], + "xyz": [ + 15.113278401226188, + 20.52454121853247, + 9.594777043736237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5459020692834884, + 0.3487308527765092, + 0.15352998984509367 + ], + "xyz": [ + 6.866819833370882, + 9.562509214635329, + 12.231260276478315 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5470326867509746, + 0.35423677427854855, + 0.3475379049965291 + ], + "xyz": [ + 9.59453709560659, + 12.230408107665355, + 12.321993842692654 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5464149234687657, + 0.3534286204970965, + 0.5522712898394899 + ], + "xyz": [ + 12.382566148137949, + 15.021040144832075, + 12.302498961263353 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5473140759390572, + 0.34817546122835646, + 0.7496548252427613 + ], + "xyz": [ + 15.009338067181556, + 17.731925362555607, + 12.242971764036188 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5548705290224794, + 0.34936734901125954, + 0.947126943465646 + ], + "xyz": [ + 17.725436597771605, + 20.5350390843126, + 12.36257750565923 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5549433390338777, + 0.5473683281055994, + 0.1491645502326295 + ], + "xyz": [ + 9.522872136722164, + 9.626436322631617, + 15.070606697030845 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5524982837412674, + 0.5521951615250253, + 0.34518699252924173 + ], + "xyz": [ + 12.26884728144221, + 12.27299151382067, + 15.103169938860605 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5550600001120747, + 0.5482579461589256, + 0.5481210775986165 + ], + "xyz": [ + 14.989496664588838, + 15.08249312186658, + 15.084364364186786 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5542022709271397, + 0.5486632912646238, + 0.750878917119868 + ], + "xyz": [ + 17.76710715543526, + 17.84283508836484, + 15.078179450484594 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5528814878798601, + 0.550174955854214, + 0.9452133286777268 + ], + "xyz": [ + 20.444679456229476, + 20.481682674908345, + 15.080789148572388 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.55233315015042, + 0.7501463754876894, + 0.15234495841866552 + ], + "xyz": [ + 12.33869906872758, + 9.634232258296993, + 17.807265628209613 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5503489468829246, + 0.7452208427495635, + 0.3513595346415339 + ], + "xyz": [ + 14.99224953522315, + 12.32799605187572, + 17.71279696129324 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5460457977744276, + 0.7528320473723273, + 0.5527919593699341 + ], + "xyz": [ + 17.850256407858982, + 15.023112024881426, + 17.758024100834305 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5530881689812814, + 0.7527024563974735, + 0.7476676093440395 + ], + "xyz": [ + 20.51278947220613, + 17.783698865223688, + 17.852534387865767 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5515574504368679, + 0.7494804417535088, + 0.95341839368396 + ], + "xyz": [ + 23.281726356310692, + 20.575758845168014, + 17.787555875206234 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502708725649291, + 0.9497629402867631, + 0.14585336289900072 + ], + "xyz": [ + 14.979068886221189, + 9.517285244900465, + 20.508192283222023 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.550516251371003, + 0.9511756180538348, + 0.34520693421265924 + ], + "xyz": [ + 17.723908905728095, + 12.246166163126423, + 20.530860934239882 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5543510150786102, + 0.9495458036259612, + 0.5461139029486108 + ], + "xyz": [ + 20.448390289540363, + 15.045358275582918, + 20.56100660390153 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5539953721826001, + 0.9457478080402955, + 0.7504133469592532 + ], + "xyz": [ + 23.189610002145926, + 17.83364121453797, + 20.504218806234984 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5482272474688575, + 0.9467383529774607, + 0.9544902569906307 + ], + "xyz": [ + 25.99325533433395, + 20.54488323181932, + 20.43890059549398 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7462593885698495, + 0.1489393000119725, + 0.15434949354277402 + ], + "xyz": [ + 4.146509793497654, + 12.31296252664501, + 12.238995334526726 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7472293826737668, + 0.15218744979481932, + 0.3470046252438349 + ], + "xyz": [ + 6.824864195354973, + 14.960170394128024, + 12.296665038480665 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7488418865324337, + 0.14636406869428814, + 0.5503738026878139 + ], + "xyz": [ + 9.52567476471925, + 17.762643044195162, + 12.239094682787798 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7512741774343175, + 0.15069733848466738, + 0.7528992288616837 + ], + "xyz": [ + 12.353809621377188, + 20.564788059665794, + 12.331592210771495 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7511247908870411, + 0.1462250652797681, + 0.9485671221384759 + ], + "xyz": [ + 14.967801723788495, + 23.23788189034052, + 12.268405710538504 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7509041181480641, + 0.3457080500783007, + 0.1538459528274725 + ], + "xyz": [ + 6.829812408007207, + 12.36958011536476, + 14.992684173800578 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7547250258472298, + 0.34695923639645737, + 0.3499481250406675 + ], + "xyz": [ + 9.52799200224331, + 15.10289247777217, + 15.062028930228484 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7472499928777042, + 0.34709308177148496, + 0.5517733852292274 + ], + "xyz": [ + 12.289140540869678, + 17.76001380126991, + 14.961661534850277 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7508120337639793, + 0.3527048496153797, + 0.751410126376457 + ], + "xyz": [ + 15.095261211064711, + 20.538110973451218, + 15.087084196523586 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7514421735619676, + 0.35140969666541305, + 0.9449611851042716 + ], + "xyz": [ + 17.72374934879641, + 23.19292136708026, + 15.077992256412106 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7461824960198427, + 0.5486350588487294, + 0.15407011100844142 + ], + "xyz": [ + 9.607258595356665, + 12.308091597821432, + 17.702512543003238 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7475114653320046, + 0.5544111673558008, + 0.3508744439000209 + ], + "xyz": [ + 12.376901925679567, + 15.016934441556591, + 17.79965188803379 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7500574506518085, + 0.5546151654234297, + 0.5486686220223466 + ], + "xyz": [ + 15.08389735087691, + 17.755949094907965, + 17.83724916590976 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7514437663904556, + 0.5540929176619521, + 0.7470372096756254 + ], + "xyz": [ + 17.788816897536435, + 20.486962178199764, + 17.84906254776139 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7454147643268211, + 0.5532415993316259, + 0.9516216760792516 + ], + "xyz": [ + 20.574219826027942, + 23.20157674667255, + 17.754996045792826 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7470502807380243, + 0.7548539691597844, + 0.14933470918599173 + ], + "xyz": [ + 12.361904856381347, + 12.255214232942958, + 20.533764561837856 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.754826282007553, + 0.7476456575623308, + 0.3476804429185455 + ], + "xyz": [ + 14.975101287076454, + 15.07327349197913, + 20.541525912850325 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7548813301816453, + 0.749532182327037, + 0.5482695355457258 + ], + "xyz": [ + 17.743311482447194, + 17.816444069068783, + 20.56807074858645 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7507141332076598, + 0.7540821231337983, + 0.7492697655373484 + ], + "xyz": [ + 20.553556418571954, + 20.507509866539976, + 20.57330355337427 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7483339959860638, + 0.7460610508720407, + 0.9524554518321919 + ], + "xyz": [ + 23.221811892001778, + 23.252887188470584, + 20.43110008953557 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7458983739415145, + 0.9539968003007563, + 0.1508998350344725 + ], + "xyz": [ + 15.105947916908885, + 12.260863689442077, + 23.240660841108962 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7525888811154459, + 0.946537653800269, + 0.34768283761461666 + ], + "xyz": [ + 17.69434959893586, + 15.042716889568041, + 23.230152142591365 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7517487244740321, + 0.9529227229140087, + 0.5452427132839442 + ], + "xyz": [ + 20.482648173919895, + 17.732233478568254, + 23.30596118782876 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7543967308377398, + 0.9465811753922417, + 0.7506818879826143 + ], + "xyz": [ + 23.20467509510962, + 20.57716396236049, + 23.255463757953184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7549338163118843, + 0.9472674675755707, + 0.948838573269573 + ], + "xyz": [ + 25.92322049134745, + 23.293669431327558, + 23.272189557078182 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9535916912236124, + 0.15150173701429057, + 0.14920150301486637 + ], + "xyz": [ + 4.111160571095428, + 15.077190048853518, + 15.108638434051526 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9506920584654586, + 0.15449210554013432, + 0.34713981681724937 + ], + "xyz": [ + 6.858221348724125, + 17.74372378912763, + 15.109878957134944 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9472079341791951, + 0.15255488812939683, + 0.5469651557738715 + ], + "xyz": [ + 9.563712126637581, + 20.428065534682133, + 15.035759349295052 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9533284587047326, + 0.14689593991806651, + 0.7472896775107254 + ], + "xyz": [ + 12.225144808075305, + 23.25054504707322, + 15.042069937579155 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9486913846665306, + 0.14986652653624902, + 0.9546877428054149 + ], + "xyz": [ + 15.101267150670745, + 26.022656822553493, + 15.019286021540385 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9519922985303655, + 0.352304506768528, + 0.14504729538405994 + ], + "xyz": [ + 6.799704315705793, + 14.998527860871118, + 17.832111148621514 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9542550395856829, + 0.34816063191471724, + 0.34657483245467563 + ], + "xyz": [ + 9.498298216474753, + 17.78471186115881, + 17.8063926259326 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9512817859421879, + 0.3540917836313406, + 0.5464717289272297 + ], + "xyz": [ + 12.312342242268512, + 20.477016459662, + 17.846832475966757 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9453489701037154, + 0.3529188524130342, + 0.7497286587690125 + ], + "xyz": [ + 15.07519829632893, + 23.17479622797474, + 17.749683981240945 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9454579585341868, + 0.35314168469751495, + 0.9518746290753496 + ], + "xyz": [ + 17.841948138966124, + 25.939989617931808, + 17.75422057432804 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.954735532450909, + 0.5483953524212912, + 0.1499073288156887 + ], + "xyz": [ + 9.547068563389365, + 15.102478363521895, + 20.550534894413442 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9516726673099007, + 0.5515716233504063, + 0.3518208885774429 + ], + "xyz": [ + 12.351019812425406, + 17.821129267251703, + 20.552085357935397 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9549281888778806, + 0.5494447986619698, + 0.5480168380444668 + ], + "xyz": [ + 15.004297953955792, + 20.547993877977486, + 20.567516698507074 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9547084961837756, + 0.5475716096083896, + 0.747523340507211 + ], + "xyz": [ + 17.706305040889468, + 23.272607269508562, + 20.53890319597144 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9477672326313284, + 0.5549118871329216, + 0.9477832955681048 + ], + "xyz": [ + 20.544578052755543, + 25.91562562244757, + 20.544358443175266 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9451285334023293, + 0.7516264614560524, + 0.15276221721543196 + ], + "xyz": [ + 12.364639224834372, + 15.01016472211092, + 23.197728873804717 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9510533178258903, + 0.750875069782068, + 0.34513036596103763 + ], + "xyz": [ + 14.984389036501305, + 17.721190011671794, + 23.268458568266233 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9482330398884145, + 0.7530682382789864, + 0.5525786483918967 + ], + "xyz": [ + 17.85056921812471, + 20.518827256064522, + 23.25988484087463 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9487128170319555, + 0.7543841694944804, + 0.7463819600611639 + ], + "xyz": [ + 20.518204385381445, + 23.17503067535725, + 23.284435442331855 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9545102728741497, + 0.7463247093195698, + 0.9494400813947674 + ], + "xyz": [ + 23.184190980984088, + 26.030466532500864, + 23.253509726255736 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.951488796236577, + 0.9538256973663984, + 0.14862046523684463 + ], + "xyz": [ + 15.072445494802269, + 15.040495803197553, + 26.049116799931028 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9462800349181616, + 0.9543323770411315, + 0.35054359887047526 + ], + "xyz": [ + 17.840029464987822, + 17.72993929290416, + 25.9848307860733 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9504182457405153, + 0.9525831293189804, + 0.54511642323875 + ], + "xyz": [ + 20.47627869664983, + 20.446680798044095, + 26.01749225956591 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9513881329711505, + 0.950925003921755, + 0.7450499077785045 + ], + "xyz": [ + 23.18706371728184, + 23.193395534281947, + 26.00808279123516 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9549286396405192, + 0.9481839046855179, + 0.9493939475007939 + ], + "xyz": [ + 25.94334283107786, + 26.035555633330343, + 26.019012145767597 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09941666990082705, + 0.10283161534545858, + 0.10290380003253435 + ], + "xyz": [ + 2.812777566673151, + 2.766089047244329, + 2.7651021511958724 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09530125846567994, + 0.09858616200956581, + 0.3035926817485474 + ], + "xyz": [ + 5.498516759669047, + 5.453606149699677, + 2.6507939130018743 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09602698016551704, + 0.10517899039982831, + 0.4994101705044484 + ], + "xyz": [ + 8.265834181834308, + 8.140709545272646, + 2.7508518124946995 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09481146323331197, + 0.10193408338532035, + 0.7035477775351063 + ], + "xyz": [ + 11.012403015769108, + 10.915023835122476, + 2.6898696991715494 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09805809636863688, + 0.10070209433027293, + 0.9049960826122362 + ], + "xyz": [ + 13.749724449486134, + 13.71357618527428, + 2.7174135504011687 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09656686259625494, + 0.30275453212179254, + 0.10378387987273424 + ], + "xyz": [ + 5.558119991875011, + 2.739159287902375, + 5.459450230734095 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10171861972038052, + 0.29443819527667925, + 0.30090621183113764 + ], + "xyz": [ + 8.139441571984792, + 5.504614224502676, + 5.416184666413101 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10136371924285821, + 0.30067977565996784, + 0.49456664309237636 + ], + "xyz": [ + 10.872465892826673, + 8.147452646382106, + 5.496666294482354 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09986285294487096, + 0.3037084779951696, + 0.694809519107568 + ], + "xyz": [ + 13.651558323149148, + 10.864617629673976, + 5.517554593772664 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10125984023460524, + 0.30472663843834935, + 0.8961444715519318 + ], + "xyz": [ + 16.418093658987324, + 13.63633221796941, + 5.550574058850474 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10355489875983423, + 0.5026831339522672, + 0.09545948482908612 + ], + "xyz": [ + 8.177698218307281, + 2.720888829838673, + 8.288377260393961 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10329460540604309, + 0.4954007013047586, + 0.2983637585143975 + ], + "xyz": [ + 10.852204817044734, + 5.491400853014757, + 8.185254468194872 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09622539163002534, + 0.5003481160295208, + 0.4983150791038418 + ], + "xyz": [ + 13.653543444488207, + 8.1284502985887, + 8.156245613489935 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10169087540983666, + 0.49430534639195295, + 0.702126583768092 + ], + "xyz": [ + 16.357401991400703, + 10.989647614737988, + 8.148353065154142 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09911007492750941, + 0.49955506877481615, + 0.9052200925182428 + ], + "xyz": [ + 19.20583314566967, + 13.731021269888181, + 8.184842084972328 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10291858628514476, + 0.7013559180496284, + 0.10131542820467788 + ], + "xyz": [ + 10.973978165146548, + 2.792250683982247, + 10.995896253854237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10408506173229962, + 0.6964087123951009, + 0.29714280889690403 + ], + "xyz": [ + 13.583657559830458, + 5.4855152262257585, + 10.944206790990476 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10301334683384634, + 0.7029039319845667, + 0.49908025519314037 + ], + "xyz": [ + 16.433311449939918, + 8.231715350064597, + 11.018355970895154 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10119481095937789, + 0.698172717732436, + 0.704696179325339 + ], + "xyz": [ + 19.179771044172426, + 11.017996558794398, + 10.928808966119314 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10231025877176236, + 0.7016512340376453, + 0.9017222101666957 + ], + "xyz": [ + 21.92103312194179, + 13.726951189482188, + 10.991616816621514 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10035693541270665, + 0.8958907722588247, + 0.09877120232886585 + ], + "xyz": [ + 13.598839477407479, + 2.7224440561379857, + 13.620519334697795 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1004892807620472, + 0.898938060034893, + 0.29571449871099015 + ], + "xyz": [ + 16.333074745713137, + 5.416826756275061, + 13.66399070645442 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09433783245826646, + 0.902484087231206, + 0.5017524857814474 + ], + "xyz": [ + 19.198469663645852, + 8.149639534716083, + 13.628369858048922 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10393953555231002, + 0.8959987982198897, + 0.7024601230722541 + ], + "xyz": [ + 21.853842649300354, + 11.024950980776488, + 13.670976910433435 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09585648465338342, + 0.9026181497527791, + 0.8977504112980859 + ], + "xyz": [ + 24.614314900346436, + 13.584414632207215, + 13.65096547616686 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29519999194029867, + 0.10435007266687349, + 0.09942812194305893 + ], + "xyz": [ + 2.786018796631966, + 5.395284539952765, + 5.462576564297628 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3024593531400044, + 0.09695062488571161, + 0.29656585643158534 + ], + "xyz": [ + 5.380086499603446, + 8.18976484072505, + 5.460661325771544 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29779904308030575, + 0.10318840614385731, + 0.49577554598653245 + ], + "xyz": [ + 8.188927340015304, + 10.849608938295779, + 5.482228228051897 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30354250427429547, + 0.10256054050476611, + 0.6952743995327123 + ], + "xyz": [ + 10.907855689903197, + 13.655644921806724, + 5.552167729671269 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2952556602574817, + 0.1023557115844146, + 0.9036866471144014 + ], + "xyz": [ + 13.754430040505644, + 16.391723416773058, + 5.436071105775474 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29756831699024094, + 0.3032842748618716, + 0.09594938643078658 + ], + "xyz": [ + 5.4582507551341894, + 5.380103207985672, + 8.21474848233555 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2990476633681203, + 0.3000881534751259, + 0.2958469942806846 + ], + "xyz": [ + 8.147518071790845, + 8.133292678336083, + 8.191277043433828 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2992691819088123, + 0.304075881565048, + 0.5015362629263068 + ], + "xyz": [ + 11.014184229299794, + 10.948467896805678, + 8.248825105703192 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30060326069590404, + 0.29960060185200477, + 0.7045235489444315 + ], + "xyz": [ + 13.728204647341732, + 13.74191281857693, + 8.205879172059749 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30084985839024053, + 0.30502775377159785, + 0.8972353019094835 + ], + "xyz": [ + 16.43712408992172, + 16.38000465628897, + 8.283449655506464 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2997463607335901, + 0.5036399453544939, + 0.0948220738431031 + ], + "xyz": [ + 8.18206500330609, + 5.3944686152143255, + 10.983752967301188 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30467962366251017, + 0.4997955835353794, + 0.3001477636026266 + ], + "xyz": [ + 10.936681452268331, + 8.26909116975924, + 10.998640227272249 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3009769700688915, + 0.49509739889420584, + 0.5042692303967231 + ], + "xyz": [ + 13.663160669672306, + 11.009181108449798, + 10.883785479077051 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30270652661296565, + 0.49720855908496636, + 0.69628657357255 + ], + "xyz": [ + 16.317250624569684, + 13.658053846978335, + 10.9362950669467 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29724125996625766, + 0.501528503116625, + 0.9046543415912289 + ], + "xyz": [ + 19.22507873993373, + 16.432100323285674, + 10.920636422311816 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3042438281225714, + 0.7010412147140656, + 0.09962400816577706 + ], + "xyz": [ + 10.94655080747309, + 5.521608361523767, + 13.744076154354788 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3020338879661911, + 0.7025854614831419, + 0.3009951589179747 + ], + "xyz": [ + 13.720773597612393, + 8.244504583771874, + 13.734974914188378 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3017062288513696, + 0.7043510281961175, + 0.49822566651573025 + ], + "xyz": [ + 16.44141210629533, + 10.936524885717823, + 13.754633728046974 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3039679610843055, + 0.7000913394447713, + 0.7010802000827457 + ], + "xyz": [ + 19.156565077543096, + 13.740837550806914, + 13.727318026159441 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30172164183471856, + 0.7023728982767, + 0.8943225074567709 + ], + "xyz": [ + 21.82973218201498, + 16.35210032116637, + 13.727799815386094 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29629159658874116, + 0.8972084733478196, + 0.10382656475993081 + ], + "xyz": [ + 13.685970854702303, + 5.47034348069, + 16.317318126160067 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30386850767394424, + 0.9026379891762676, + 0.29709515340471176 + ], + "xyz": [ + 16.402535573401483, + 8.21626700080839, + 16.49513965376666 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29890433906061353, + 0.9011469558931275, + 0.49545677239006053 + ], + "xyz": [ + 19.094114784416654, + 10.860362130753554, + 16.406885295374455 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30419123103032025, + 0.8971757795268863, + 0.7022197135433588 + ], + "xyz": [ + 21.866647290067636, + 13.759469280241316, + 16.424873522276226 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3000676507439922, + 0.8946279106863052, + 0.9022039435153387 + ], + "xyz": [ + 24.565961680911116, + 16.437240827826603, + 16.333662670673966 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4978278403075557, + 0.09588279888734175, + 0.10217341719968573 + ], + "xyz": [ + 2.707788936222944, + 8.203109192412652, + 8.117104991157582 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49568019684223036, + 0.09922404940339054, + 0.30019328508607934 + ], + "xyz": [ + 5.460761902019823, + 10.881038987697103, + 8.133423771905804 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5021811890638073, + 0.1041441318634894, + 0.4976734315670842 + ], + "xyz": [ + 8.227941400061384, + 13.669832399433833, + 8.289570649160233 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4990006529689398, + 0.09846305559823815, + 0.705555165492416 + ], + "xyz": [ + 10.992392395471626, + 16.468470329956332, + 8.168416280062914 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5054660149720842, + 0.09665498933018511, + 0.8990359632236705 + ], + "xyz": [ + 13.612907478944853, + 19.20209823553628, + 8.232089989039851 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49524617909947294, + 0.30186605080205947, + 0.09888617220398895 + ], + "xyz": [ + 5.479012257538552, + 8.122870563197695, + 10.897974927012367 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5046560123590926, + 0.2981880473533023, + 0.295901368239084 + ], + "xyz": [ + 8.122283553884298, + 10.945076407209761, + 10.976339472457115 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5009611643047946, + 0.29689645449331664, + 0.4971671140982073 + ], + "xyz": [ + 10.856294178340967, + 13.646230159235728, + 10.908165749836392 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5020749713301815, + 0.2943110890577674, + 0.7020666458820426 + ], + "xyz": [ + 13.622297044104792, + 16.46280744503443, + 10.888046868133166 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.499787762828356, + 0.29469981872167905, + 0.9028009978092929 + ], + "xyz": [ + 16.37201561346447, + 19.175941069461018, + 10.8620912071874 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5019088585432536, + 0.49891545252197467, + 0.09521894138525838 + ], + "xyz": [ + 8.122898489308787, + 8.163823797618628, + 13.683089832507807 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4994888280170008, + 0.4966315911689141, + 0.2984611909530693 + ], + "xyz": [ + 10.870365400470973, + 10.909429028355383, + 13.618779069434373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.504753971071413, + 0.5010461300763108, + 0.4982872027841267 + ], + "xyz": [ + 13.662705446867985, + 13.713398381541642, + 13.751117938873472 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4963150197892058, + 0.49960554305089205, + 0.6987779109822397 + ], + "xyz": [ + 16.38408287451925, + 16.33909543277966, + 13.616046669448505 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4969367446942836, + 0.4966087537641612, + 0.9041272445605777 + ], + "xyz": [ + 19.15061043661613, + 19.155094669574396, + 13.583575216734134 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4987935362791746, + 0.6956369919446118, + 0.10086986580317371 + ], + "xyz": [ + 10.889698387893327, + 8.19849009385749, + 16.330039184380528 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5037950560469439, + 0.7005738482554327, + 0.3009025319917131 + ], + "xyz": [ + 13.69200480499053, + 11.00168057809867, + 16.465914873219315 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5049065763484468, + 0.7002909270713218, + 0.49571776887307495 + ], + "xyz": [ + 16.35161560938652, + 13.680355935486505, + 16.47724333120446 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4951127517570601, + 0.699002514146247, + 0.7036970642417523 + ], + "xyz": [ + 19.177456149796615, + 16.389912018568882, + 16.32572897468215 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4944359320182185, + 0.7009158519477284, + 0.901718400425545 + ], + "xyz": [ + 21.910927024281964, + 19.087970725391294, + 16.342634427061313 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4960465659301154, + 0.9050834075632035, + 0.09865230533461976 + ], + "xyz": [ + 13.722893994310716, + 8.13061592213463, + 19.155996794205425 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4944162219409664, + 0.9025720633310775, + 0.3022147497484441 + ], + "xyz": [ + 16.471628446796863, + 10.891395251362715, + 19.099372378348033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4957253258473429, + 0.9046836471387227, + 0.5010286675393765 + ], + "xyz": [ + 19.218645738062328, + 13.627441181864416, + 19.14613940505035 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4966501106558342, + 0.9029488912906158, + 0.6967846361316256 + ], + "xyz": [ + 21.871268834881946, + 16.316425039823727, + 19.135065626791512 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4948384164772291, + 0.9002456769563351, + 0.9039660956014424 + ], + "xyz": [ + 24.66685859629087, + 19.12420350432742, + 19.073338610286868 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6982823699665459, + 0.095447438535423, + 0.10315294633516046 + ], + "xyz": [ + 2.71522871388134, + 10.957079386119993, + 10.851731070473386 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7028415573829938, + 0.09869177334214674, + 0.2952100958977499 + ], + "xyz": [ + 5.385355453911403, + 13.645182554356737, + 10.95841942167459 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6966411007584646, + 0.10304125130457284, + 0.503531693155104 + ], + "xyz": [ + 8.292956113522699, + 16.408546407283403, + 10.933113174582475 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6998471006855949, + 0.10513443455756324, + 0.6990160027163889 + ], + "xyz": [ + 10.994200031330763, + 19.125004554353307, + 11.005562653168113 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6989281362653518, + 0.09520957048900103, + 0.9019177343168164 + ], + "xyz": [ + 13.63254502839027, + 21.886476590342696, + 10.857307781958294 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6946379064868008, + 0.3026114524467104, + 0.09996471552928951 + ], + "xyz": [ + 5.503948904857634, + 10.863664019732022, + 13.634213730454356 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7012327868046931, + 0.2980388972280776, + 0.2960223008143559 + ], + "xyz": [ + 8.121897768620501, + 13.634292052011865, + 13.661862595192913 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7009849378921815, + 0.3036586946689219, + 0.49466184937083113 + ], + "xyz": [ + 10.914494780413575, + 16.3466676590382, + 13.735306908521544 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6993367594506186, + 0.2971286201814837, + 0.705535789728627 + ], + "xyz": [ + 13.708247332697248, + 19.20716461531979, + 13.623495306561768 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6964082613448006, + 0.2980130146429166, + 0.9004522078991892 + ], + "xyz": [ + 16.38520079885561, + 21.831988900619365, + 13.59554868947439 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.698032993289606, + 0.49907568693416443, + 0.09729650203670691 + ], + "xyz": [ + 8.153493220615738, + 10.873601700792191, + 16.366654396456948 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6980089338847427, + 0.5042299650626072, + 0.30196041041469623 + ], + "xyz": [ + 11.022089699258105, + 13.671400880779954, + 16.436793823406354 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7048042409168884, + 0.5003303995703697, + 0.49556690971586254 + ], + "xyz": [ + 13.615728751045696, + 16.411258304643855, + 16.476383880506503 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7026144294193586, + 0.503268234294395, + 0.6991220263333067 + ], + "xyz": [ + 16.438863213055022, + 19.1642885104884, + 16.48661071941497 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7049678278043482, + 0.49964270058160964, + 0.8996820574784574 + ], + "xyz": [ + 19.131316213740785, + 21.938484394607165, + 16.469218314197704 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.695021139107281, + 0.6994623882892584, + 0.10152524407031165 + ], + "xyz": [ + 10.950958731846216, + 10.890238772455074, + 19.065127779530556 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7041612892343028, + 0.6983145367816004, + 0.30193323703862496 + ], + "xyz": [ + 13.675207519070831, + 13.755143266188737, + 19.174397047640742 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6983229708677189, + 0.6981390106891948, + 0.5056932837813285 + ], + "xyz": [ + 16.45857844018799, + 16.461093510635937, + 19.09217684868944 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6992058050188996, + 0.6980725901177622, + 0.7055611081217467 + ], + "xyz": [ + 19.19022726826488, + 19.20572037841455, + 19.103338708197313 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.695609418543541, + 0.7044825305376052, + 0.9013611224630644 + ], + "xyz": [ + 21.954805371967613, + 21.833493781944924, + 19.141805111286594 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6953420942796521, + 0.9043824896759103, + 0.10123181230439234 + ], + "xyz": [ + 13.74857772610034, + 10.890615067513869, + 21.871146561415333 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7035206365698327, + 0.8946044915441891, + 0.30112504080757363 + ], + "xyz": [ + 16.347798934997474, + 13.735334864881969, + 21.84927908905184 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6990032600497806, + 0.9000760795980761, + 0.5050380627175602 + ], + "xyz": [ + 19.210467633193762, + 16.461436237436985, + 21.862324897384358 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7053966259943107, + 0.8964955395054439, + 0.6987899132740021 + ], + "xyz": [ + 21.810455559019083, + 19.197785611299302, + 21.90078134612285 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7047161106954993, + 0.8954443892995929, + 0.8995159011765679 + ], + "xyz": [ + 24.54037399853778, + 21.932771304552762, + 21.8771063270429 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9016140344289209, + 0.09512276053734309, + 0.10404174062063698 + ], + "xyz": [ + 2.7229412102216948, + 13.749144738438044, + 13.627206048155664 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8966906971812817, + 0.09784705347348671, + 0.3001983782412027 + ], + "xyz": [ + 5.4420054942255245, + 16.36365199914263, + 13.597141110156874 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9041164525016296, + 0.09497091468069112, + 0.4998727810022846 + ], + "xyz": [ + 8.13259593551242, + 19.195088082403483, + 13.659342648390595 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9031459161628017, + 0.09544117066258757, + 0.698292281617684 + ], + "xyz": [ + 10.851780887554462, + 21.894574781179198, + 13.652502905401093 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8991612870368653, + 0.10127099500154166, + 0.895260472240224 + ], + "xyz": [ + 13.624398844465315, + 24.533011296919693, + 13.67773008221833 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9010944230198233, + 0.2997729180517303, + 0.09499966281371841 + ], + "xyz": [ + 5.397259666527858, + 13.618419044580731, + 16.418042131008885 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9027280358512672, + 0.2962324883527737, + 0.3037722583233914 + ], + "xyz": [ + 8.203156895702127, + 16.495054851902978, + 16.391972474023287 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9012276808015283, + 0.2993733168328668, + 0.4951578150533054 + ], + "xyz": [ + 10.862686619544005, + 19.09113114993803, + 16.414400731477873 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8981480396184403, + 0.2968913143998651, + 0.7054750407676351 + ], + "xyz": [ + 13.704172381906131, + 21.92444610288395, + 16.338362941054548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9048185186596569, + 0.2958164977431484, + 0.8985841019097253 + ], + "xyz": [ + 16.32963000634615, + 24.655796015952888, + 16.4148658299562 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9039586051372229, + 0.5025077303457609, + 0.09628291934812354 + ], + "xyz": [ + 8.186557980297842, + 13.675122079289247, + 19.228954574782964 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8989603164524377, + 0.5024512920814275, + 0.3034923061856662 + ], + "xyz": [ + 11.018715805660015, + 16.43971581523608, + 19.159847257785465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9035572114422545, + 0.49571536096484964, + 0.49790832213109937 + ], + "xyz": [ + 13.584644143024855, + 19.16058451121885, + 19.130602740886893 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.90039806757956, + 0.5050944390576497, + 0.6982878586503138 + ], + "xyz": [ + 16.45242616544969, + 21.85694621994811, + 19.215640562092734 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9017823494265225, + 0.5042293388836243, + 0.8955450040622485 + ], + "xyz": [ + 19.13746285737424, + 24.572736057974844, + 19.222738720472428 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8988345286122784, + 0.6981585304477786, + 0.10563046551739458 + ], + "xyz": [ + 10.989258470816575, + 13.732864596041946, + 21.833801644718466 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8971268039770287, + 0.6965511323202657, + 0.30189608749899044 + ], + "xyz": [ + 13.6505906688693, + 16.392825148139664, + 21.788477883028072 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9053152373071542, + 0.6994834797076266, + 0.4988855487812197 + ], + "xyz": [ + 16.383885651074376, + 19.19798039125875, + 21.940519195257018 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8959414992480688, + 0.697603251810408, + 0.7028511891295952 + ], + "xyz": [ + 19.146761034732354, + 21.858405852815512, + 21.7866569984163 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8989462651335292, + 0.6992065660424628, + 0.8964576888762559 + ], + "xyz": [ + 21.815634473682834, + 24.546439686510055, + 21.849657840328547 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8960742562168317, + 0.9013049624500191, + 0.10468572162614585 + ], + "xyz": [ + 13.753723554366193, + 13.682210280273177, + 24.573445149353823 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9033553021520719, + 0.8978526832488435, + 0.30305221576546104 + ], + "xyz": [ + 16.418555616441747, + 16.493786431615284, + 24.62579135896394 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9041551505479857, + 0.9022918214236801, + 0.49664439379953274 + ], + "xyz": [ + 19.126004126013022, + 19.151479226401285, + 24.697417840341657 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8980716527938646, + 0.8971372106899356, + 0.7055533187769629 + ], + "xyz": [ + 21.91169643457613, + 21.924471958821467, + 24.543772443955085 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8976095622898402, + 0.905470678986911, + 0.8996739412696287 + ], + "xyz": [ + 24.679612322115762, + 24.572136549634415, + 24.65138850429231 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15481277846199248, + 0.14911074378440972, + 0.15045523393970525 + ], + "xyz": [ + 4.095612125568109, + 4.1735693173137784, + 4.155187689918806 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15196210551008565, + 0.14739823954389694, + 0.35435162372838835 + ], + "xyz": [ + 6.859833815683295, + 6.922230169677153, + 4.09280075271594 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14921264262493464, + 0.1502802456683158, + 0.5456433873962478 + ], + "xyz": [ + 9.514542645004761, + 9.499946568364201, + 4.094612860025427 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14440893470436267, + 0.15286503122377473, + 0.7516371619653536 + ], + "xyz": [ + 12.366191174886987, + 12.250580945370958, + 4.064276152855627 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14761060601789933, + 0.14657704110432881, + 0.9550294737128673 + ], + "xyz": [ + 15.060965981408037, + 15.075096694864689, + 4.0220805576786205 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15041601470043364, + 0.347583187716577, + 0.15520270241510928 + ], + "xyz": [ + 6.87399818842019, + 4.178364089034622, + 6.808555455588933 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1485525585150459, + 0.349051266235402, + 0.3468697885190834 + ], + "xyz": [ + 9.514507394813467, + 6.773325152628149, + 6.803149923299668 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14613841905394795, + 0.34742580710020327, + 0.5524808360994784 + ], + "xyz": [ + 12.303361642630271, + 9.551396704991717, + 6.747921258418847 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1533554055935905, + 0.3445923398459668, + 0.750423239484287 + ], + "xyz": [ + 14.97085589779895, + 12.356298955348626, + 6.807851945055448 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14935211257216385, + 0.34992395744216626, + 0.9549796905648343 + ], + "xyz": [ + 17.840407792895068, + 15.098225632764473, + 6.826012559543318 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14916498867797076, + 0.5527789261227252, + 0.15309161738909255 + ], + "xyz": [ + 9.65053501419574, + 4.132397911959797, + 9.59685085325045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14862966779553272, + 0.5505848866728225, + 0.35490969031641345 + ], + "xyz": [ + 12.379758867572974, + 6.884299467022067, + 9.559535530071546 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14950007220781455, + 0.5466649117565063, + 0.555425209646554 + ], + "xyz": [ + 15.067577763600786, + 9.63761156696219, + 9.51784235106308 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14775089459228805, + 0.5458481992754372, + 0.7526747950167175 + ], + "xyz": [ + 17.753172643823365, + 12.310457951710193, + 9.482761963522641 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1509815696499897, + 0.5519080071347439, + 0.9443985567255817 + ], + "xyz": [ + 20.457234005916874, + 14.975839919384063, + 9.609779773677054 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15530343517730275, + 0.7464396969352034, + 0.14984009377981325 + ], + "xyz": [ + 12.253775968293377, + 4.171867402066478, + 12.328469788478403 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14797250443629423, + 0.75111794775454, + 0.35478837360731924 + ], + "xyz": [ + 15.119752162521491, + 6.873656227654235, + 12.29220282607169 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1500794844996607, + 0.7446102577591064, + 0.5523557136319488 + ], + "xyz": [ + 17.731885306983656, + 9.6035675905197, + 12.232037112008255 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14721411072969193, + 0.7495793398012047, + 0.7554926990518672 + ], + "xyz": [ + 20.577074002232205, + 12.341645016107714, + 12.260798632837322 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14531738930673388, + 0.7532372800041185, + 0.9529456185253862 + ], + "xyz": [ + 23.32662547577365, + 15.015254155739335, + 12.284877698977496 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14551118733449644, + 0.9508255246565853, + 0.14902152059118537 + ], + "xyz": [ + 15.036910830159375, + 4.026798166872495, + 14.98891818573391 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15114290952018553, + 0.94436164420392, + 0.35250515269546806 + ], + "xyz": [ + 17.73052941118499, + 6.885785649961217, + 14.977541067696299 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15501057785173178, + 0.9465479342674676, + 0.5476243059404166 + ], + "xyz": [ + 20.42805391711895, + 9.606297656927168, + 15.060309697161511 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14712155791632106, + 0.9483009926872366, + 0.7489958702638437 + ], + "xyz": [ + 23.205137196831835, + 12.25155617694214, + 14.976419935792729 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15477691910968275, + 0.9511010161269633, + 0.9480680335740871 + ], + "xyz": [ + 25.96509739708381, + 15.077897681001016, + 15.11936407252708 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3490197542553235, + 0.1528495111876806, + 0.14503382387419614 + ], + "xyz": [ + 4.0726073379656675, + 6.754611590542729, + 6.861466260668972 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3547203885371239, + 0.15133381919740377, + 0.34766082766248246 + ], + "xyz": [ + 6.8221649928319295, + 9.602829559262101, + 6.918682038389069 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34947901002069043, + 0.15525395490942373, + 0.5461743387325387 + ], + "xyz": [ + 9.589801373580054, + 12.245211366551372, + 6.900618244590833 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3455573354046971, + 0.14836628450119602, + 0.75414878994283 + ], + "xyz": [ + 12.339023645085321, + 15.034984198648825, + 6.752834825101786 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.353547822100123, + 0.14700715090597827, + 0.9530115993840889 + ], + "xyz": [ + 15.039258350590744, + 17.863045229836274, + 6.843497491044275 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35399785917257665, + 0.3448440060682226, + 0.15079880286820224 + ], + "xyz": [ + 6.776339268073191, + 6.901489100022361, + 9.554440190036463 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3449689435792419, + 0.3541726870338764, + 0.35077783353161335 + ], + "xyz": [ + 9.637956626077672, + 9.512124702239731, + 9.558538528249041 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3537558370474723, + 0.34982836545570295, + 0.5515824604001366 + ], + "xyz": [ + 12.323926557152383, + 12.377622241810167, + 9.61927657146696 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34842946076492926, + 0.35560510017676766, + 0.7487925881425045 + ], + "xyz": [ + 15.09912640311719, + 15.00102235269363, + 9.62543379097391 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35439259301428616, + 0.3511458774927184, + 0.9453086408661945 + ], + "xyz": [ + 17.72489281318975, + 17.76928132339183, + 9.645994971847074 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35529685898320434, + 0.5501361709239636, + 0.1477835811491023 + ], + "xyz": [ + 9.541833224787583, + 6.878025223009672, + 12.378917406945416 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3527208705834818, + 0.5527709481231081, + 0.3498205113285478 + ], + "xyz": [ + 12.340067967160337, + 9.605019316052523, + 12.37972115682913 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3457009636023107, + 0.5480869204246395, + 0.5521320002426555 + ], + "xyz": [ + 15.041995043957535, + 12.275010671754885, + 12.219707068597335 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35271761580521976, + 0.5530273578801184, + 0.7448601728546073 + ], + "xyz": [ + 17.744484700449636, + 15.005885962555194, + 12.383182246130678 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3470511559147592, + 0.55066136696937, + 0.9471697611213257 + ], + "xyz": [ + 20.478077573652932, + 17.694355417952284, + 12.273364024617694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34465077327065496, + 0.7504111672543099, + 0.15355504447405866 + ], + "xyz": [ + 12.358863332832144, + 6.811380263158529, + 14.971489739708023 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3549153249674808, + 0.7467094556706385, + 0.3473132698987797 + ], + "xyz": [ + 14.957281779894481, + 9.600742947864436, + 15.06121570842385 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3502598393638148, + 0.746300437980707, + 0.5551596458570034 + ], + "xyz": [ + 17.793328003414086, + 12.378732226431685, + 14.991974731004378 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3499095635529296, + 0.7539864293653192, + 0.7512020177133248 + ], + "xyz": [ + 20.578665514538745, + 15.054199338987601, + 15.09226731389957 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35565994922632127, + 0.7478641151839825, + 0.9487516859289491 + ], + "xyz": [ + 23.1958258419718, + 17.833681081748527, + 15.087182374286078 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34747856571275504, + 0.949241545381125, + 0.1477015033321097 + ], + "xyz": [ + 14.997207912258576, + 6.770012771568962, + 17.72852394925553 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34621022339106594, + 0.9543265124716142, + 0.34748338861958505 + ], + "xyz": [ + 17.798110641936677, + 9.484054198559457, + 17.780704156102104 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34944565439851955, + 0.9504391614099204, + 0.5546850947337902 + ], + "xyz": [ + 20.577787907630704, + 12.361112858602095, + 17.771791222466142 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3487904066026516, + 0.9478567973203847, + 0.7556549217683814 + ], + "xyz": [ + 23.290105591272173, + 15.099777729329656, + 17.727527175539045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3490095745218357, + 0.9453428561642636, + 0.954359510203105 + ], + "xyz": [ + 25.972388806548715, + 17.819427519924137, + 17.696153448902823 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5453090931841896, + 0.14913858862864413, + 0.1543845125819885 + ], + "xyz": [ + 4.149713205593551, + 9.566085033186148, + 9.494363705162336 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5551747288602592, + 0.14661499693159216, + 0.35042739522242333 + ], + "xyz": [ + 6.795474117899111, + 12.3812292320761, + 9.594742808875548 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5513479954194621, + 0.14604884324910186, + 0.5479461819532985 + ], + "xyz": [ + 9.48817506546268, + 15.029352120088454, + 9.534684046845646 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5552721603864386, + 0.1488178210299138, + 0.7496545916769584 + ], + "xyz": [ + 12.283753101494067, + 17.840723667395388, + 9.626191489727713 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5518126782839798, + 0.15033661770450105, + 0.9445879849383344 + ], + "xyz": [ + 14.96961208090437, + 20.458520515456097, + 9.599658787881232 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5482337339268475, + 0.34668904135300804, + 0.15539895398177875 + ], + "xyz": [ + 6.864456696378044, + 9.619939455202912, + 12.235223097526633 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5553298764244239, + 0.346533453484481, + 0.34983443888962595 + ], + "xyz": [ + 9.520616478318162, + 12.375243589396932, + 12.330113111115162 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5515687569056837, + 0.3526245819340266, + 0.5443541839962072 + ], + "xyz": [ + 12.263332231620288, + 14.98326118188129, + 12.361968573815528 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5469910634439319, + 0.3464387938093383, + 0.7533719052128512 + ], + "xyz": [ + 15.03641391110555, + 17.778328442141177, + 12.214812190992403 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5515069367163836, + 0.34472975449989784, + 0.9536432962991543 + ], + "xyz": [ + 17.751122643375496, + 20.57814305874649, + 12.25318671970458 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5449694622621677, + 0.5515504395891959, + 0.15392735819797285 + ], + "xyz": [ + 9.645165465342568, + 9.555191527903357, + 14.991422724529508 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5485329060925127, + 0.5481262366189028, + 0.3476647864133047 + ], + "xyz": [ + 12.247093624512194, + 12.252653536354885, + 14.993326400504783 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5553022499485899, + 0.5499979280438536, + 0.5465835707946335 + ], + "xyz": [ + 14.992264867450002, + 15.064784601753614, + 15.111465079480647 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5513643151264308, + 0.551166744259101, + 0.7530303158632058 + ], + "xyz": [ + 17.830747450521354, + 17.83344860385673, + 15.073606188328299 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5443688647812134, + 0.551967442246396, + 0.9511098628038042 + ], + "xyz": [ + 20.549802360731427, + 20.445915977371392, + 14.98891264914621 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.552940702105473, + 0.7502318972192713, + 0.14456661323260322 + ], + "xyz": [ + 12.233524171166147, + 9.536194463985415, + 17.816741206900023 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5490382078906738, + 0.7450740791239644, + 0.3523066617889631 + ], + "xyz": [ + 15.003191961228179, + 12.323024816183452, + 17.69287024785247 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5549655578906946, + 0.7469175315023538, + 0.5471345313467543 + ], + "xyz": [ + 17.692046873901692, + 15.067714042038336, + 17.799111259225665 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5500892286703286, + 0.7552567791884072, + 0.7464895094694534 + ], + "xyz": [ + 20.53160494419831, + 17.726591123674233, + 17.84645565716322 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.548978882334709, + 0.7450630215017907, + 0.9526888206765078 + ], + "xyz": [ + 23.211357590930103, + 20.530530535382812, + 17.69190798170993 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.54567525151229, + 0.9511705251482474, + 0.1485533544228461 + ], + "xyz": [ + 15.035226931197665, + 9.491368539196111, + 20.464606026263066 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5526627994363166, + 0.9463829052782083, + 0.3471077899882272 + ], + "xyz": [ + 17.68437195735756, + 12.301501539906265, + 20.494683046630133 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5532541285500372, + 0.9447614101734342, + 0.5522831871728219 + ], + "xyz": [ + 20.46732426689049, + 15.114707183846098, + 20.48059880263033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5547285731248575, + 0.9470310138349167, + 0.7468167307726462 + ], + "xyz": [ + 23.157981471680568, + 17.794493116731967, + 20.531786756188378 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5456741343717845, + 0.9548508705063347, + 0.9490473947951189 + ], + "xyz": [ + 26.029754381513715, + 20.43556369689465, + 20.514907772192764 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7447983101292254, + 0.14996837057151488, + 0.15148044588410312 + ], + "xyz": [ + 4.121353957794247, + 12.253761822038143, + 12.233089000537992 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7505260557415135, + 0.15084942652745534, + 0.34476307646570103 + ], + "xyz": [ + 6.775924930671894, + 14.974595863493239, + 12.323443345994534 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7451848813005244, + 0.1544629746119308, + 0.5498855177352142 + ], + "xyz": [ + 9.629725804641543, + 17.70596938294479, + 12.299823549421022 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.749184594693698, + 0.14923638181457208, + 0.7553083445972795 + ], + "xyz": [ + 12.36677268145208, + 20.56915665725717, + 12.283049875045297 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7483999163969319, + 0.15297094927364704, + 0.9532520735679842 + ], + "xyz": [ + 15.12408204814667, + 23.264679709442138, + 12.323380228692335 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7463311995951547, + 0.3512098962364615, + 0.154792267449193 + ], + "xyz": [ + 6.917970501520804, + 12.319997839206254, + 15.005384304812605 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7542536604108941, + 0.3450127448076459, + 0.35058921020719486 + ], + "xyz": [ + 9.510144720610999, + 15.105212855373798, + 15.028972424194938 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499632752535738, + 0.35323623220414774, + 0.5521245841482828 + ], + "xyz": [ + 12.377930116223485, + 17.80191083792749, + 15.082745090050624 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7470251678480979, + 0.3496944302741245, + 0.7554487990661002 + ], + "xyz": [ + 15.10931930575827, + 20.541553630336868, + 14.994152935999361 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7523664262962403, + 0.3532869092579499, + 0.9495132584491727 + ], + "xyz": [ + 17.811649388861593, + 23.26779271149603, + 15.116293386096487 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7550958643747911, + 0.5491176013366684, + 0.14985684156866624 + ], + "xyz": [ + 9.556252768002011, + 12.372350504171877, + 17.830971744783245 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7443577138881768, + 0.5514811009828626, + 0.35151157002952876 + ], + "xyz": [ + 12.345553259400631, + 14.982527593251763, + 17.716475025930173 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7457211214449956, + 0.5480464915421306, + 0.5540617187297534 + ], + "xyz": [ + 15.067825071359348, + 17.770397029957934, + 17.68815792658965 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.751016664102042, + 0.5519954657766069, + 0.7526038258167366 + ], + "xyz": [ + 17.836246686791704, + 20.557228686481352, + 17.814547297517507 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7460955561964515, + 0.5529208645150895, + 0.9535800344353283 + ], + "xyz": [ + 20.5966091202883, + 23.237658733511378, + 17.759918681012458 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7536758651765294, + 0.7448568818317216, + 0.1496625775103882 + ], + "xyz": [ + 12.229709034622642, + 12.350280587495853, + 20.487669981202345 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7538671374008835, + 0.7501522112708282, + 0.35117457243518324 + ], + "xyz": [ + 15.05714154800752, + 15.107931349370933, + 20.562681811556878 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7453433224481458, + 0.7524968947470827, + 0.5536375169356267 + ], + "xyz": [ + 17.857234572331897, + 17.759432219503847, + 20.478201838254066 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7470104449576339, + 0.7507094225168363, + 0.7471844288303975 + ], + "xyz": [ + 20.478935114726134, + 20.428363359352684, + 20.47655643853481 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7476387723587105, + 0.7475882030196347, + 0.9491809457345056 + ], + "xyz": [ + 23.197922383319828, + 23.198613758221192, + 20.442474066517164 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7499830718915373, + 0.9523838460330301, + 0.152990879195889 + ], + "xyz": [ + 15.112484275879238, + 12.345297323956094, + 23.274454075819456 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7536084770217796, + 0.9446803990046984, + 0.3513805015195224 + ], + "xyz": [ + 17.71951134100505, + 15.107210416600541, + 23.218699821036317 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7544933701037719, + 0.9453125971084432, + 0.5493376048783749 + ], + "xyz": [ + 20.434588524527417, + 17.825742400380413, + 23.239441218651304 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7551266471381094, + 0.9459419979057948, + 0.7495477257206514 + ], + "xyz": [ + 23.180430313270517, + 20.57163718433786, + 23.256704322684147 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7459151144609414, + 0.9529574660297946, + 0.9476255194732783 + ], + "xyz": [ + 25.98442847286062, + 23.15378270983454, + 23.22668012340485 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9552947572938059, + 0.1464997531705499, + 0.1482547942245436 + ], + "xyz": [ + 4.029831116167187, + 15.087530829439599, + 15.063536224056786 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9449776710166146, + 0.14982872779298187, + 0.35108113447601796 + ], + "xyz": [ + 6.848349473166556, + 17.719482698110284, + 14.967996019373016 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9487952276440258, + 0.14962863368999443, + 0.5552882282693662 + ], + "xyz": [ + 9.637496451673226, + 20.56355827422583, + 15.017453315863683 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9471481008627192, + 0.1531645990507617, + 0.753388889834809 + ], + "xyz": [ + 12.394236120415522, + 23.249435640158275, + 15.043277176931124 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.951012501501151, + 0.14854363114322394, + 0.9546990799880698 + ], + "xyz": [ + 15.083335762899043, + 26.054545714035957, + 15.032933525410016 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9491184625038841, + 0.34540341452533146, + 0.1545312298360095 + ], + "xyz": [ + 6.835016469472268, + 15.088899936726403, + 17.698470088805568 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9482330255602309, + 0.3459010583451107, + 0.35117137500321105 + ], + "xyz": [ + 9.530248835700252, + 17.765223071711276, + 17.693168251018726 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9504651508833596, + 0.34471621698583105, + 0.5537490960337712 + ], + "xyz": [ + 12.283656035847658, + 20.565346425286563, + 17.707486528861356 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.950207892700604, + 0.3534265378623353, + 0.7517144580445208 + ], + "xyz": [ + 15.109288770659271, + 23.26837603336421, + 17.823055280459002 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.948324469321883, + 0.3528300299895137, + 0.9534134551500693 + ], + "xyz": [ + 17.85872580500105, + 26.000218590554123, + 17.789150106775537 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9555865074253905, + 0.5490620033003991, + 0.14720610231995268 + ], + "xyz": [ + 9.519252211782437, + 15.077182057768578, + 20.571283601911063 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9546436923970705, + 0.5514061068810646, + 0.34611100964637515 + ], + "xyz": [ + 12.27069246408218, + 17.78368415049162, + 20.59044176676679 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9492532992525096, + 0.551078800924423, + 0.5543923398747675 + ], + "xyz": [ + 15.113802452201186, + 20.55757252193309, + 20.512270413840987 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9479351035738746, + 0.5467853377677346, + 0.7499195186352042 + ], + "xyz": [ + 17.728315389866825, + 23.212762781010525, + 20.435548824343037 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9499882479253768, + 0.5458524658463282, + 0.9550361907788102 + ], + "xyz": [ + 20.519879553420697, + 26.045151221564677, + 20.45086498735827 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9528327893741253, + 0.7516855238803578, + 0.1510770907478933 + ], + "xyz": [ + 12.342407969926814, + 15.092457177249814, + 23.303867565518907 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9518385476986905, + 0.744303896371007, + 0.35174420582732274 + ], + "xyz": [ + 14.984972364597168, + 17.822348761312018, + 23.18935418968097 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9545654401762759, + 0.7485524048022465, + 0.5456540448320953 + ], + "xyz": [ + 17.694157622239786, + 20.51073075952715, + 23.28472061533426 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9481830223150663, + 0.7498261506161558, + 0.7553555184123546 + ], + "xyz": [ + 20.578572846257366, + 23.290472291887966, + 23.214875770664538 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.946658401712775, + 0.7517367299751192, + 0.947069871661656 + ], + "xyz": [ + 23.225778072389694, + 25.89071208248601, + 23.220152529313186 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9467863400861368, + 0.9553905409389186, + 0.1480229061063201 + ], + "xyz": [ + 15.085670033582035, + 14.968034948278955, + 26.00621992553597 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9538232750228517, + 0.9447804706878076, + 0.35019878975523866 + ], + "xyz": [ + 17.704723352510445, + 17.82835494567439, + 25.957368662681905 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9450155448052975, + 0.9515925669892267, + 0.5539543551388454 + ], + "xyz": [ + 20.583566520889015, + 20.49364665745433, + 25.93008471499461 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9473924323499684, + 0.9518889671659202, + 0.7544033426186341 + ], + "xyz": [ + 23.328121326758662, + 23.266645512131237, + 25.966633423529313 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9489864841022708, + 0.9552161175327848, + 0.9461283418772711 + ], + "xyz": [ + 25.994839207051587, + 25.90966878012362, + 26.033915213086186 + ], + "label": "Si", + "properties": {} + } + ] + }, + { + "@module": "pymatgen.core.structure", + "@class": "Structure", + "charge": null, + "lattice": { + "matrix": [ + [ + 0.0, + 13.671819999999999, + 13.671819999999999 + ], + [ + 13.671819999999999, + 0.0, + 13.671819999999999 + ], + [ + 13.671819999999999, + 13.671819999999999, + 0.0 + ] + ], + "a": 19.334873266323726, + "b": 19.334873266323726, + "c": 19.334873266323726, + "alpha": 59.99999999999999, + "beta": 59.99999999999999, + "gamma": 59.99999999999999, + "volume": 5111.036606083104 + }, + "sites": [ + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09841179355078757, + 0.10168240092614332, + 0.10485911805681639 + ], + "xyz": [ + 2.823798470061608, + 2.7790833147350718, + 2.735651809933593 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10496191700816095, + 0.09579630536960244, + 0.29728421527593174 + ], + "xyz": [ + 5.374126123772027, + 5.499436716284303, + 2.7447302798687527 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09547093739375047, + 0.09733515160216519, + 0.5036647902518031 + ], + "xyz": [ + 8.21676302503792, + 8.191275823939032, + 2.636010143656139 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09626773111606461, + 0.10478157232851203, + 0.7023174797080365 + ], + "xyz": [ + 11.034512961614324, + 10.91811325704916, + 2.7487098878196314 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10436857593040627, + 0.10109228075843887, + 0.8942437498543447 + ], + "xyz": [ + 13.608055050052466, + 13.652847967910473, + 2.8090238496956865 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10363697464431959, + 0.2940490250807679, + 0.10011291674524987 + ], + "xyz": [ + 5.388911119495786, + 2.7856318400977433, + 5.437091404761445 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09810360429085195, + 0.29506506115607845, + 0.3023631222699531 + ], + "xyz": [ + 8.167930586727685, + 5.475109001528545, + 5.375331223630651 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10345883421157295, + 0.2941598541035249, + 0.502706084013477 + ], + "xyz": [ + 10.894607670066788, + 8.287377652287603, + 5.43617113528012 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09488261137339483, + 0.3050749844465565, + 0.7009030108569699 + ], + "xyz": [ + 13.753550075750656, + 10.879837785721545, + 5.468148257683127 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09936344798494508, + 0.30398373622302277, + 0.902302714733091 + ], + "xyz": [ + 16.492131225910814, + 13.694599476771698, + 5.514490099998178 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09931376156600703, + 0.4975222822689349, + 0.09700574118425041 + ], + "xyz": [ + 8.128280121607727, + 2.6840449040910244, + 8.159834960823435 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10202190954873905, + 0.4968137649621392, + 0.30497426742720346 + ], + "xyz": [ + 10.961901656981262, + 5.56437847230323, + 8.187173551491314 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1025759341521456, + 0.4942524934614729, + 0.499488108658269 + ], + "xyz": [ + 13.586242638872728, + 8.23131122177628, + 8.15973083321642 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10180779754357198, + 0.4953836928972249, + 0.6978703532705812 + ], + "xyz": [ + 16.313954533477933, + 10.933055735863954, + 8.164694562838294 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10553520603846146, + 0.4964014907514788, + 0.9010361507969316 + ], + "xyz": [ + 19.105515896474387, + 13.761662407809261, + 8.22957016990664 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09807272629581214, + 0.7061776863593968, + 0.09673725040004195 + ], + "xyz": [ + 10.977308490686429, + 2.663406935589912, + 10.995566876747738 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10486970121606945, + 0.7001326119109316, + 0.3004361944357566 + ], + "xyz": [ + 13.679596617986777, + 5.541269250290548, + 11.005846724655994 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09495860568391794, + 0.7025722921431535, + 0.5042692363797469 + ], + "xyz": [ + 16.49972014648996, + 8.192535195682852, + 10.903698879530111 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.0964875869063614, + 0.6982562460206734, + 0.699141836548788 + ], + "xyz": [ + 19.104975053234813, + 10.87770226418258, + 10.865594629888491 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10021683759776268, + 0.700617598509492, + 0.9047171084687801 + ], + "xyz": [ + 21.947847153559678, + 13.73927602251148, + 10.948864260259885 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10475223388413683, + 0.9011085820182577, + 0.09456839798925416 + ], + "xyz": [ + 13.6127164488063, + 2.725075801259264, + 13.751948020070675 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09523572907102867, + 0.8976574395590928, + 0.3037263506217997 + ], + "xyz": [ + 16.425102930270928, + 5.454537740386004, + 13.574656680740667 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09861718761661321, + 0.89463587920204, + 0.503211154777902 + ], + "xyz": [ + 19.11111303610765, + 8.22808876811618, + 13.579577143992598 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.10120092992807747, + 0.9025221399887775, + 0.6937358999750107 + ], + "xyz": [ + 21.823752595937716, + 10.868233249805638, + 13.722721141750654 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.09441562167703284, + 0.9023545609549187, + 0.8992113584672892 + ], + "xyz": [ + 24.630684968474927, + 13.584689219676743, + 13.627662518311167 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30448888963600573, + 0.09856519344542564, + 0.09482421249654369 + ], + "xyz": [ + 2.6439851479455347, + 5.459336855997831, + 5.510482874154374 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2983806603472553, + 0.10512599655113293, + 0.29520917397105556 + ], + "xyz": [ + 5.473310391048667, + 8.115453368629767, + 5.516670381916522 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2970396134178732, + 0.09592023956431911, + 0.5022337926289427 + ], + "xyz": [ + 8.17785426042048, + 10.927522138258977, + 5.372476377198996 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3061809549365091, + 0.09796314666561223, + 0.6967967017743346 + ], + "xyz": [ + 10.865813591098233, + 13.712529986572445, + 5.525385411165914 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30251206986696044, + 0.0995269609365106, + 0.8942430738250766 + ], + "xyz": [ + 13.586645036654161, + 16.361820908631664, + 5.496605262119511 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30473842358353825, + 0.3002699322721903, + 0.09446004620168202 + ], + "xyz": [ + 5.3966772142986565, + 5.45776962317897, + 8.271565339755465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2998744440198188, + 0.29545557869930417, + 0.3056461314027136 + ], + "xyz": [ + 8.218154382206967, + 8.278568313473285, + 8.139244911211758 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29656451795598593, + 0.303280931887216, + 0.5040092092175911 + ], + "xyz": [ + 11.037125496959522, + 10.945299894646253, + 8.200979018075284 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2964080628552885, + 0.30605049641089627, + 0.6994658569887915 + ], + "xyz": [ + 13.747238590736917, + 13.615408974802687, + 8.236704979746609 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2938126250249869, + 0.3024212334873212, + 0.9008197470832275 + ], + "xyz": [ + 16.450494102984038, + 16.332798757636528, + 8.151601991485743 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3029325152792723, + 0.4960866281349235, + 0.09667571723502594 + ], + "xyz": [ + 8.10414008867578, + 5.463371825453632, + 10.924045905313069 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2940936101384785, + 0.5016590011181309, + 0.30397319761225466 + ], + "xyz": [ + 11.014458407246059, + 8.176661743542628, + 10.879386465630336 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29865469389577665, + 0.49980970885956394, + 0.5057914485537826 + ], + "xyz": [ + 13.748398015946938, + 10.998242859264732, + 10.91646159087852 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30050448477492303, + 0.5057796384048574, + 0.6970763175532366 + ], + "xyz": [ + 16.445230115786988, + 13.638745164886178, + 11.023371400971785 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3023246193453962, + 0.4937477849603152, + 0.9011600087030542 + ], + "xyz": [ + 19.070928271562725, + 16.453825207445362, + 10.88375861863491 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3018057104344447, + 0.6942296537440419, + 0.09985129101471177 + ], + "xyz": [ + 10.856531742171622, + 5.491382225552606, + 13.617616212682716 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29979177710924965, + 0.7052794173115362, + 0.299986811915857 + ], + "xyz": [ + 13.743818938075657, + 8.200064909005233, + 13.741152457305986 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.30549019411543343, + 0.7001370117384575, + 0.49912359601044026 + ], + "xyz": [ + 16.396075162233537, + 11.000534908118722, + 13.748754145537342 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.304069456325904, + 0.6952773093136766, + 0.6976413270397668 + ], + "xyz": [ + 19.043732870869732, + 13.695209522234444, + 13.662889097406529 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2943194626568181, + 0.7026579761672911, + 0.903701934155319 + ], + "xyz": [ + 21.961863549146862, + 16.37913289336411, + 13.63049608766423 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3024500256000118, + 0.9033907922498464, + 0.09400213012091392 + ], + "xyz": [ + 13.636176503927006, + 5.420222511628466, + 16.486038610296045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3011370231405194, + 0.8938664717202665, + 0.30147265923762895 + ], + "xyz": [ + 16.34246143741277, + 8.238771107731214, + 16.337872681107587 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.29399116779794837, + 0.9015065183845304, + 0.5006718961611953 + ], + "xyz": [ + 19.170330891554542, + 10.864490371097899, + 16.344629175903336 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3051359925488511, + 0.9009824974102256, + 0.6988691644215032 + ], + "xyz": [ + 21.872883947264263, + 13.726577785170427, + 16.489834893392302 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.2977417185443068, + 0.9050375335790211, + 0.8955151756350558 + ], + "xyz": [ + 24.6168325408872, + 16.31399347097929, + 16.444181434764754 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5058786138757636, + 0.09980412101994583, + 0.0959847504613748 + ], + "xyz": [ + 2.6767902088957487, + 8.228567581811774, + 8.280785328601857 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49999309745570525, + 0.09636265062802536, + 0.2977216039282509 + ], + "xyz": [ + 5.387848993127589, + 10.906211808675199, + 8.153268443766109 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5002498236848011, + 0.09719205778355353, + 0.49668121904604023 + ], + "xyz": [ + 8.119328543624375, + 13.62986176862837, + 8.16811786389668 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49806186161630667, + 0.09620221126900634, + 0.6997963844539709 + ], + "xyz": [ + 10.882749520977313, + 16.37690232578854, + 8.124671436954879 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49695264911396175, + 0.0974493413623401, + 0.9061185034985899 + ], + "xyz": [ + 13.720598932726558, + 19.182536245711333, + 8.126557021433712 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4999525211553232, + 0.3041389336324452, + 0.09421287053242669 + ], + "xyz": [ + 5.446194163217378, + 8.123322285384411, + 10.993393633396506 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.500346023894358, + 0.3054918943151362, + 0.2953234963390323 + ], + "xyz": [ + 8.214239874253472, + 10.87825046011727, + 11.017270966934927 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5058907740905522, + 0.29645109721941765, + 0.49751356158931903 + ], + "xyz": [ + 10.854941901594461, + 13.718363464634775, + 10.969473643013071 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5024493398586967, + 0.29684154488705916, + 0.7046715403282053 + ], + "xyz": [ + 13.692506628707756, + 16.50353939215689, + 10.927761103884718 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4972329399700741, + 0.3009716956105003, + 0.8962454394344099 + ], + "xyz": [ + 16.368137171249703, + 19.051385577109812, + 10.912910100823208 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5006675961013717, + 0.49389538591925747, + 0.10200906340851114 + ], + "xyz": [ + 8.147098368408372, + 8.239686807020405, + 13.597486068849276 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5021446615562607, + 0.4966728169870678, + 0.29628253078446193 + ], + "xyz": [ + 10.841142782769754, + 10.915952856787737, + 13.655652779498247 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.496723479629593, + 0.4959980351925811, + 0.5039996067444805 + ], + "xyz": [ + 13.671787760987957, + 13.681705906750784, + 13.572309860776095 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4975247405601758, + 0.5018238194403082, + 0.6956441715237252 + ], + "xyz": [ + 16.371566828221887, + 16.312790595606916, + 13.662913629585816 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49384372687649286, + 0.5029606118519014, + 0.902527389444703 + ], + "xyz": [ + 19.21557896588694, + 19.09093455554245, + 13.628129494313635 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5044973771919107, + 0.6956442986521302, + 0.09725608949309536 + ], + "xyz": [ + 10.840391384651655, + 8.227065080893398, + 16.408120966638073 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5010593391536025, + 0.6949393248310163, + 0.30506344684286196 + ], + "xyz": [ + 13.67185789382636, + 11.021165628042182, + 16.351478454238187 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4998391812434867, + 0.7032377868888018, + 0.5028350850081565 + ], + "xyz": [ + 16.489211211458272, + 13.708382086824539, + 16.448251754450382 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49841342655560733, + 0.6977490056017308, + 0.7063092025459987 + ], + "xyz": [ + 19.19603109131829, + 16.470750935003917, + 16.353717463217336 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5036557278825202, + 0.694891296954088, + 0.9032740790298682 + ], + "xyz": [ + 21.84982935068497, + 19.235291072740928, + 16.386319185101634 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5007908544397273, + 0.8952461819970426, + 0.10532979699204847 + ], + "xyz": [ + 13.679694681062635, + 8.286772444657979, + 19.08636707549696 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5060189061290841, + 0.8975321180142751, + 0.2966629746832418 + ], + "xyz": [ + 16.326820352243764, + 10.974122191727572, + 19.18909696290366 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5038921793767297, + 0.9012543155447293, + 0.5008570319137512 + ], + "xyz": [ + 19.169413962409802, + 13.736750361905422, + 19.2109099521971 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.4968745757879661, + 0.9040886482594764, + 0.6958749016945022 + ], + "xyz": [ + 21.8744136615318, + 16.307056161234357, + 19.153717025796304 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.49726086888049525, + 0.9057280272630046, + 0.8964175720127834 + ], + "xyz": [ + 24.6386102470907, + 19.05412078177354, + 19.181411650072622 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7027692878946746, + 0.09419699989457239, + 0.099573439604386 + ], + "xyz": [ + 2.649194570150649, + 10.969485348676205, + 10.895979632722781 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6990196730329666, + 0.09827743236915842, + 0.2965598866899117 + ], + "xyz": [ + 5.398144755458175, + 13.61138453621044, + 10.90050251157888 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.693992241261453, + 0.10021188430564253, + 0.5023663990202242 + ], + "xyz": [ + 8.23834182554025, + 16.356399985375838, + 10.858215848010726 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6952921284582546, + 0.09765735722715334, + 0.7028208778973151 + ], + "xyz": [ + 10.943994344539409, + 19.114749362552203, + 10.841062637383473 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6957026498082587, + 0.0970503300416583, + 0.9038129617670445 + ], + "xyz": [ + 13.683622770216058, + 21.86828952864746, + 10.838376044971692 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7059817365356182, + 0.2981285599618197, + 0.09964315642097182 + ], + "xyz": [ + 5.438263307476576, + 11.014358524021766, + 13.7280152338596 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6953990665423071, + 0.3052738913027274, + 0.3011281458866005 + ], + "xyz": [ + 8.290619500085796, + 13.624340673429785, + 13.681020558524898 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7047640390054879, + 0.3021833206175089, + 0.4975018576092066 + ], + "xyz": [ + 10.933151813383573, + 16.43716293065471, + 13.76680305024088 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6971550138201413, + 0.3026423961138729, + 0.7044832170425142 + ], + "xyz": [ + 13.769240100463755, + 19.162945597472667, + 13.669050225084053 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6984624979475533, + 0.2987836913634849, + 0.8965881607264833 + ], + "xyz": [ + 16.342908794840667, + 21.807245496272866, + 13.634170395946438 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7033876362705003, + 0.5031968736397402, + 0.09895777171138423 + ], + "xyz": [ + 8.23254992340441, + 10.969521995754887, + 16.496206234281022 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.694642588208982, + 0.4994808863878198, + 0.30484366167564053 + ], + "xyz": [ + 10.996580442704976, + 13.664796100897577, + 16.325841202462044 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6940033704001299, + 0.5000751651281139, + 0.5029932810377278 + ], + "xyz": [ + 13.713771243659076, + 16.36512275906113, + 16.32522680360575 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7036194020326735, + 0.5033025387991136, + 0.6948753379186361 + ], + "xyz": [ + 16.381272258467263, + 19.11996835556111, + 16.50081952910284 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7039271655860713, + 0.5031355206674316, + 0.8951832935015437 + ], + "xyz": [ + 19.11756312993168, + 21.862750356763232, + 16.502743775174363 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6961310923612305, + 0.7043954685776098, + 0.09664867950465544 + ], + "xyz": [ + 10.951731404634074, + 10.838742340591455, + 19.147747046374853 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6975373887094727, + 0.7024604182732147, + 0.30454978264294835 + ], + "xyz": [ + 13.767662205089614, + 13.700355431039455, + 19.140518017462043 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.699943091632154, + 0.6963696802684907, + 0.5059374460262621 + ], + "xyz": [ + 16.437726615419123, + 16.486581652369082, + 19.090136881126668 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.6969783903839745, + 0.7042219303141996, + 0.6958065124455353 + ], + "xyz": [ + 19.140936864291394, + 19.041904490202544, + 19.156958568527706 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7039935374201147, + 0.6943667242335123, + 0.8993244264228235 + ], + "xyz": [ + 21.788658547366303, + 21.920274604427156, + 19.11812979248129 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7055341584558602, + 0.89660086662773, + 0.09680657325511066 + ], + "xyz": [ + 13.581687704739016, + 10.969458062620683, + 21.904101678638327 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.702829618582311, + 0.8950505760802171, + 0.29799813192656777 + ], + "xyz": [ + 16.31114718710132, + 13.683136855962298, + 21.845930402991044 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.701849535886623, + 0.9023989700795507, + 0.4936746481108013 + ], + "xyz": [ + 19.086867214647217, + 16.344991449259663, + 21.93299680883845 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.702306709612561, + 0.8937739651830497, + 0.7028908532758015 + ], + "xyz": [ + 21.829313998302087, + 19.21160814424837, + 21.821327691284125 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7012766408248008, + 0.9004071861147801, + 0.9041723639975932 + ], + "xyz": [ + 24.671886784817342, + 21.9494098131109, + 21.8979329788291 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8948326369499483, + 0.10495938501772799, + 0.1011481245132584 + ], + "xyz": [ + 2.81786477095593, + 13.616869694187898, + 13.668976561778114 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.899095168750998, + 0.10599893815533065, + 0.29608944649522967 + ], + "xyz": [ + 5.497280019033223, + 16.34034892641568, + 13.741465712684082 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9041241633369734, + 0.09462638452166015, + 0.4987761896113737 + ], + "xyz": [ + 8.112893181083495, + 19.18020110344627, + 13.654737715224622 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8941599245388553, + 0.10408280022897506, + 0.7016465760010747 + ], + "xyz": [ + 11.015787000529517, + 21.817579230211823, + 13.647794849335316 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9006184741782708, + 0.10571114127472193, + 0.8973186925776727 + ], + "xyz": [ + 13.713243343059844, + 24.58107331519724, + 13.758357363142533 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9008862902989573, + 0.2959307423839269, + 0.10553414757003676 + ], + "xyz": [ + 5.4887557117703984, + 13.75959907086607, + 16.362667043774508 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9017710091241649, + 0.3017766939811965, + 0.3027490342775209 + ], + "xyz": [ + 8.264966942122097, + 16.467981219780036, + 16.45468755826994 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8957321335125554, + 0.29753897148508035, + 0.5015493929198623 + ], + "xyz": [ + 10.924992282238783, + 19.103381518709256, + 16.314187758728774 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.898621656615332, + 0.3049920551312985, + 0.6950190848381074 + ], + "xyz": [ + 13.67197230365652, + 21.78796936181796, + 16.45559001653182 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9034002895142831, + 0.2996224784153261, + 0.9028029034411694 + ], + "xyz": [ + 16.43934338417327, + 24.694084937512212, + 16.447510739035387 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.901360714246791, + 0.5053636191995168, + 0.09700588328788708 + ], + "xyz": [ + 8.235487411497337, + 13.64948841550656, + 19.232481876497896 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9041678931867517, + 0.5016663380285129, + 0.29422525749486683 + ], + "xyz": [ + 10.881286633508452, + 16.384215445351966, + 19.22031255901348 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8998908061616648, + 0.5060075994118222, + 0.4970655925966007 + ], + "xyz": [ + 13.713836127964594, + 19.09893643167123, + 19.22118993928771 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.904187676094516, + 0.5030843171694371, + 0.6962983548382968 + ], + "xyz": [ + 16.397744002808775, + 21.881556927427848, + 19.23996938294598 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8976841809706191, + 0.4955971499961268, + 0.9016013750139636 + ], + "xyz": [ + 19.10224673820345, + 24.599508250021135, + 19.048691566337773 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8997453686092336, + 0.6941408015919461, + 0.10260155492417779 + ], + "xyz": [ + 10.892918084664274, + 13.703906716102564, + 21.79132481947989 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9062827988621017, + 0.6985694342494437, + 0.2978956309818934 + ], + "xyz": [ + 13.623491008131097, + 16.46331074070973, + 21.94125085769909 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8945616013261557, + 0.6989696731852518, + 0.5022496679325853 + ], + "xyz": [ + 16.422854612281665, + 19.096952247277038, + 21.78647274949055 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9059538935594201, + 0.6963576922002855, + 0.6978165308672198 + ], + "xyz": [ + 19.060899026418777, + 21.92646056408462, + 21.906515584421257 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8972962947855266, + 0.701723794322365, + 0.9051125956287767 + ], + "xyz": [ + 21.968377892861813, + 24.642209916144076, + 21.86151483466705 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.8949390360166039, + 0.8986343044346464, + 0.10485188838675862 + ], + "xyz": [ + 13.71948260073954, + 13.668961556076377, + 24.52141186744821 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9059098675337341, + 0.8984201087046204, + 0.29600440159121916 + ], + "xyz": [ + 16.329956908352866, + 16.432355542907917, + 24.668474655735057 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9006630762763249, + 0.9017822148735997, + 0.4939351688884846 + ], + "xyz": [ + 19.081996841666136, + 19.066696180209146, + 24.64270758044936 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.903870995419128, + 0.8947969421093669, + 0.6983686856167308 + ], + "xyz": [ + 21.781473692458214, + 21.905532515979672, + 24.591064281660824 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9044767533480154, + 0.8966489465277943, + 0.9027230841706035 + ], + "xyz": [ + 24.600690516742965, + 24.7077108825838, + 24.624666366076088 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14851653831466793, + 0.15300285041325004, + 0.14470559695084434 + ], + "xyz": [ + 4.070216304841372, + 4.008880253365736, + 4.1223188091981235 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14431536963170555, + 0.14930465734534523, + 0.35277246152397945 + ], + "xyz": [ + 6.86430799530001, + 6.796095351750917, + 4.014320157225382 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14810340242010156, + 0.14888744081355884, + 0.5562022811942814 + ], + "xyz": [ + 9.63985976314123, + 9.629140531352792, + 4.060405350338822 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15282016095010764, + 0.15006934193461105, + 0.7531031313837401 + ], + "xyz": [ + 12.348011484163298, + 12.385620186595744, + 4.141050763329354 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14670916080762714, + 0.1491861702137912, + 0.9561500845259464 + ], + "xyz": [ + 15.111958314275839, + 15.078093087536455, + 4.045427704565247 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15158200187812595, + 0.3467547533770939, + 0.14641112133618026 + ], + "xyz": [ + 6.742475069222436, + 4.074108341823815, + 6.813170417233419 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.146137203865756, + 0.350863612316524, + 0.35558215445917346 + ], + "xyz": [ + 9.658399363119315, + 6.859416757533936, + 6.794905698697218 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15205726996045316, + 0.35453510245319303, + 0.5485706299300024 + ], + "xyz": [ + 12.347099014111217, + 9.578858534280327, + 6.926039729012335 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14456646058754583, + 0.3543517884647983, + 0.7490487796318593 + ], + "xyz": [ + 15.085493954915245, + 12.217346713536466, + 6.8211204957588185 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15520632901424025, + 0.34698621104540894, + 0.946173638000594 + ], + "xyz": [ + 17.679848687384123, + 15.05786866063275, + 6.865886013038312 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15584771316681048, + 0.5503203956002596, + 0.14721429142715084 + ], + "xyz": [ + 9.536568684795089, + 4.143409175647812, + 9.654603272803802 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15549745190539785, + 0.5482319748598062, + 0.35070404152996104 + ], + "xyz": [ + 12.290091407597947, + 6.920695701979407, + 9.621262051437052 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1468181965824402, + 0.548091654107766, + 0.5562042233891153 + ], + "xyz": [ + 15.09773446387941, + 9.611595981815512, + 9.500682394863373 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14959920177775185, + 0.5560746413824581, + 0.7467501312653452 + ], + "xyz": [ + 17.811985783181687, + 12.254726738485273, + 9.64784576239462 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15499491060706594, + 0.5465025428604764, + 0.9464947642339971 + ], + "xyz": [ + 20.411990443080363, + 15.059368566285542, + 9.590746914266614 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15299515340171027, + 0.754248060931845, + 0.14673206176549608 + ], + "xyz": [ + 12.318038061095962, + 4.097816534867315, + 12.403665922589788 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15007208370121802, + 0.753811051214332, + 0.35202268090378375 + ], + "xyz": [ + 15.118759735447096, + 6.864549244621955, + 12.357727521601113 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1438054492972204, + 0.750825686924979, + 0.5525566830944204 + ], + "xyz": [ + 17.819609154078623, + 9.52053772887468, + 12.231235860825388 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14437499400070236, + 0.7538364059977988, + 0.7525587755178279 + ], + "xyz": [ + 20.59516377054897, + 12.262717048778832, + 12.280184582727506 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15572238759752086, + 0.750394806600475, + 0.9459699139786181 + ], + "xyz": [ + 23.192393114107652, + 15.062138842534686, + 12.388271177980041 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15623803899061123, + 0.9486676722858917, + 0.14817083370681355 + ], + "xyz": [ + 14.995778623001186, + 4.161823313922106, + 15.106072001544316 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15346830261546676, + 0.9525180086760899, + 0.34994042184456 + ], + "xyz": [ + 17.806977219560828, + 6.882513467247082, + 15.120845770442129 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.14840552295813358, + 0.9524044056975004, + 0.54485965343102 + ], + "xyz": [ + 20.470324708874486, + 9.478196703860757, + 15.050075198792667 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.1447399090216303, + 0.9485481877722056, + 0.7541299243993433 + ], + "xyz": [ + 23.278708667549225, + 12.289186565961534, + 14.9472380675079 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.15055117816358782, + 0.9540231963708716, + 0.9440695416509475 + ], + "xyz": [ + 25.950382257541463, + 14.965457449574759, + 15.101542025247712 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34435890246462303, + 0.15435902544453842, + 0.1516039138403241 + ], + "xyz": [ + 4.183070232573568, + 6.780714351214302, + 6.818381741147031 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3514313916028459, + 0.1437086714622501, + 0.3522567406515034 + ], + "xyz": [ + 6.780749840645057, + 9.620697480317657, + 6.76946581701464 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3513849190121547, + 0.14625208994664043, + 0.5470136116342669 + ], + "xyz": [ + 9.478203884187879, + 12.282742999262357, + 6.803603611823033 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3491788938958887, + 0.1469599679558958, + 0.7561808044784987 + ], + "xyz": [ + 12.347578075384002, + 15.112278831428915, + 6.783121214242463 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3443099874214212, + 0.15297220330285433, + 0.9534320335172587 + ], + "xyz": [ + 15.126559573041956, + 17.74249531670986, + 6.798752600787964 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34455679696879815, + 0.3546161402235823, + 0.14935997084500702 + ], + "xyz": [ + 6.890270674829759, + 6.752741144532137, + 9.55896654616553 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3555770762293575, + 0.3497016671331091, + 0.3494068270429552 + ], + "xyz": [ + 9.558085492846198, + 9.63841302843647, + 9.642444029077838 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34921467755792035, + 0.35195276429658384, + 0.5543350048208862 + ], + "xyz": [ + 12.390603247575608, + 12.353168618540213, + 9.586235054895246 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.349396994501396, + 0.35578499912187206, + 0.7456422481796763 + ], + "xyz": [ + 15.058515068202253, + 14.971179418871936, + 9.641121284058467 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3473400929347639, + 0.34996925165103, + 0.9559715216942273 + ], + "xyz": [ + 17.854587183837154, + 17.818641799116932, + 9.533487843494948 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35477069738772915, + 0.544520528819198, + 0.1508359820674348 + ], + "xyz": [ + 9.506789052670083, + 6.912563512308699, + 12.29494777228039 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3482215485106176, + 0.5553450659271082, + 0.34544124532083925 + ], + "xyz": [ + 12.31538830584591, + 9.483632857960787, + 12.353400110601987 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34774879040112927, + 0.5541889757566167, + 0.5452228184454272 + ], + "xyz": [ + 15.030960156207387, + 12.208547101260526, + 12.331130790110794 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3455612594674993, + 0.5479672470527546, + 0.7511471359623393 + ], + "xyz": [ + 17.76125800399342, + 14.993999774805575, + 12.216160906013735 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3474933650642441, + 0.5455122077381055, + 0.9523538191021679 + ], + "xyz": [ + 20.478554703075385, + 17.77127672943003, + 12.209011450350618 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35290387365476616, + 0.7533112530609969, + 0.14961166694363429 + ], + "xyz": [ + 12.344599636177715, + 6.870302018264022, + 15.123974093735102 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.34947163623556154, + 0.7538537939766327, + 0.34428518256186125 + ], + "xyz": [ + 15.01355842221851, + 9.48491835037098, + 15.08446668328368 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3469312015179111, + 0.7548632870269998, + 0.5521703302212694 + ], + "xyz": [ + 17.86952834896723, + 12.292354303662362, + 15.063535924378083 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3451848655970367, + 0.7519609769871642, + 0.7547733563868138 + ], + "xyz": [ + 20.59980059370902, + 15.038430818483246, + 14.999980473559528 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3436761856590599, + 0.752452691751359, + 0.9519289942933679 + ], + "xyz": [ + 23.301999622900013, + 17.7132808113772, + 14.986076708757311 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35528593631006133, + 0.9475603015382498, + 0.15136573565665307 + ], + "xyz": [ + 15.024318973842014, + 6.926850461827964, + 17.812279251539294 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.35475183346033856, + 0.9449969806953956, + 0.3484142286436333 + ], + "xyz": [ + 17.68328524006552, + 9.613559831194323, + 17.769931832350647 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3456513721972913, + 0.9495064796367441, + 0.5490578999570528 + ], + "xyz": [ + 20.488102456218062, + 12.232304121225203, + 17.7071650218616 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3452943545254248, + 0.9555565296795471, + 0.7498185687286788 + ], + "xyz": [ + 23.315581377919546, + 14.972186766403917, + 17.784999135691216 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.3557953313351499, + 0.9475416076366465, + 0.9462941220128985 + ], + "xyz": [ + 25.89218120533724, + 17.801932630072912, + 17.818988028973383 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5439848137004042, + 0.15072673151182361, + 0.15146001372685122 + ], + "xyz": [ + 4.131442787289019, + 9.507996500516498, + 9.49797119806344 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5465323692109272, + 0.14638233746450172, + 0.35226073993966867 + ], + "xyz": [ + 6.817358398515884, + 12.288137605547298, + 9.47340514501926 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.544676951881593, + 0.15494938918910803, + 0.5507336844887674 + ], + "xyz": [ + 9.647971960370649, + 14.97625704654102, + 9.565165402377232 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5533140639478475, + 0.1448263857032754, + 0.7535775041500858 + ], + "xyz": [ + 12.28281626937498, + 17.867586278552686, + 9.544850562349215 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5474368631508879, + 0.14768520837329704, + 0.9485870697651352 + ], + "xyz": [ + 14.98803725769858, + 20.45336992651994, + 9.503583839905781 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5499261890872185, + 0.35597993650864035, + 0.14742966260847984 + ], + "xyz": [ + 6.882525425401425, + 9.534123680330282, + 12.385385486043972 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5527494063255551, + 0.34370368913067145, + 0.3517178900494842 + ], + "xyz": [ + 9.507678654666835, + 12.36571407192619, + 12.256145359520346 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5455273346050685, + 0.3543525810245569, + 0.5527565490468801 + ], + "xyz": [ + 12.401832746693271, + 15.015539566190382, + 12.302996228103424 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5480957965003882, + 0.3562992816433924, + 0.748319137719239 + ], + "xyz": [ + 15.102144198210409, + 17.72435162596258, + 12.364726717267702 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5530988979808423, + 0.3502647521631143, + 0.9439496012248751 + ], + "xyz": [ + 17.69426568093698, + 20.46737761241071, + 12.350625219311148 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5494735931264956, + 0.5534567245162919, + 0.15283482819177524 + ], + "xyz": [ + 9.656290976145206, + 9.60183432074756, + 15.079064775355013 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5482545636292736, + 0.5460900867242307, + 0.35592394243024766 + ], + "xyz": [ + 12.332173444074778, + 12.361765782714683, + 14.961683077596044 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5509826580450019, + 0.5454965380291338, + 0.5553697224841682 + ], + "xyz": [ + 15.05084535781097, + 15.125850603166317, + 14.990866202470288 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5562831729006281, + 0.5473331993374643, + 0.7486219559467621 + ], + "xyz": [ + 17.71806561111799, + 17.840428038678322, + 15.088444390292194 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5548265963973872, + 0.5457990305477883, + 0.9472012939020452 + ], + "xyz": [ + 20.41203169581972, + 20.535454951153582, + 15.047555458981588 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5457286514718239, + 0.7531123074932171, + 0.14705130271617978 + ], + "xyz": [ + 12.306874849333035, + 9.471562833266631, + 17.757519799597425 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5463629260401504, + 0.755446662256083, + 0.34697772334587845 + ], + "xyz": [ + 15.072147763560608, + 12.213592557088894, + 17.798106365460207 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5472360638076802, + 0.7520120181026774, + 0.5549327646924864 + ], + "xyz": [ + 17.868313820314572, + 15.068653832865147, + 17.763085911223662 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5528335160003067, + 0.7437699789749393, + 0.751031503736458 + ], + "xyz": [ + 20.436656807363335, + 17.826207854137493, + 17.726929594672466 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5502779696596227, + 0.7441627813477784, + 0.9513838823026461 + ], + "xyz": [ + 23.181208787029142, + 20.530450540894783, + 17.697360948438003 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5438286893965043, + 0.9527288366381383, + 0.15273174885423568 + ], + "xyz": [ + 15.113658141946347, + 9.52324893088523, + 20.460665115590945 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5509495766446937, + 0.9438774259117336, + 0.35165600277805603 + ], + "xyz": [ + 17.712299841029637, + 12.340261012863536, + 20.43700571009101 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5544566652753133, + 0.9452349805288534, + 0.547821325960678 + ], + "xyz": [ + 20.4127970721897, + 15.07014628614005, + 20.50351423693832 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.555185762735326, + 0.9449068795581855, + 0.7505293973910162 + ], + "xyz": [ + 23.179699599919633, + 17.851502640518525, + 20.508996588761274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.5536680325296794, + 0.948838670207487, + 0.9445303542206431 + ], + "xyz": [ + 25.885800495556996, + 20.483098667940794, + 20.542001188616045 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7446984113352636, + 0.15005936231024794, + 0.1550344481227993 + ], + "xyz": [ + 4.171187659354744, + 12.300985702595932, + 12.232967224882175 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7513344569585954, + 0.15308027722087805, + 0.343762410591386 + ], + "xyz": [ + 6.7927437960854675, + 14.971967255707186, + 12.364995451049607 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7530209710047588, + 0.1540524550592436, + 0.5452521160493357 + ], + "xyz": [ + 9.560766221373695, + 17.749755957047906, + 12.401344607930348 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7504293406972947, + 0.1459578833855876, + 0.7479044595330144 + ], + "xyz": [ + 12.2207250571614, + 20.484950016664744, + 12.255244777960831 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7528441843852564, + 0.1487789273629781, + 0.9445731674888427 + ], + "xyz": [ + 14.948113037437018, + 23.206784499699342, + 12.326828891661744 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7470341534732915, + 0.34571382375152726, + 0.15349233953224198 + ], + "xyz": [ + 6.825056807306302, + 12.31183611760291, + 14.939853649981819 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7553999857489815, + 0.35081476657081473, + 0.3454154742037511 + ], + "xyz": [ + 9.518734530426524, + 15.050150821690968, + 15.123968975060835 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7556909865113061, + 0.34780569685293056, + 0.5459951660288751 + ], + "xyz": [ + 12.219884513164727, + 17.796418774021898, + 15.086808025552836 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7439679343138385, + 0.35377994241931043, + 0.7507456702503424 + ], + "xyz": [ + 15.100875361809212, + 20.43545535315266, + 15.008211376077798 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7461441028557645, + 0.34750263397479825, + 0.9556477092492045 + ], + "xyz": [ + 17.816436925496784, + 23.266591332572954, + 14.952141329534824 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7495102976485276, + 0.553669158341321, + 0.14424240657861068 + ], + "xyz": [ + 9.54172129150362, + 12.219226096706672, + 17.81683494999113 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7522905483059811, + 0.554705734375108, + 0.3455977920909151 + ], + "xyz": [ + 12.308787759208702, + 15.010131770005092, + 17.869017917484964 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.744201474744573, + 0.5504838662761937, + 0.5509960973859017 + ], + "xyz": [ + 15.059235796794708, + 17.707708070604866, + 17.700704939074537 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7506155178977659, + 0.5454970124292642, + 0.755499521414365 + ], + "xyz": [ + 17.786990431334004, + 20.591333716768375, + 17.720217214375694 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.747896200740183, + 0.5549593924165614, + 0.951765982949334 + ], + "xyz": [ + 20.599678121434955, + 23.237475436210012, + 17.81240715563224 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7483594698917756, + 0.7461252067130505, + 0.14954951208921416 + ], + "xyz": [ + 12.245503534015176, + 12.276049978027332, + 20.43232549129939 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7513743180066107, + 0.7514960542561683, + 0.34380809445474453 + ], + "xyz": [ + 14.97480116642883, + 14.973136810337403, + 20.546973212909705 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7483556945641969, + 0.7544263359712449, + 0.5523058190876468 + ], + "xyz": [ + 17.865406812177252, + 17.782410095575546, + 20.54576542071506 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7450549608983396, + 0.7532736553129171, + 0.7537453493689974 + ], + "xyz": [ + 20.60369256859029, + 20.49132805791918, + 20.484879141689383 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7503395229878246, + 0.7440672699050278, + 0.9516686273042922 + ], + "xyz": [ + 23.183795954184323, + 23.269549069326768, + 20.431260679208357 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7489787428125797, + 0.9463754696372552, + 0.14854616580137903 + ], + "xyz": [ + 14.969571513822626, + 12.27079899608649, + 23.178577628855898 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7480253449924099, + 0.9452251086425055, + 0.354792900117371 + ], + "xyz": [ + 17.773612212523453, + 15.077532539856804, + 23.149815417014906 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7467091227713206, + 0.9464526459686884, + 0.555250086548443 + ], + "xyz": [ + 20.531009452482365, + 17.80015195716213, + 23.148602933095027 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7444096780812206, + 0.9528215850854882, + 0.7490981911955608 + ], + "xyz": [ + 23.26834083575477, + 20.418970757335682, + 23.20424032838787 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.7456566277901363, + 0.9473945721315142, + 0.9521136726320636 + ], + "xyz": [ + 25.969734810923576, + 23.211609948718237, + 23.14709125611282 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9528607865418113, + 0.15417240610090763, + 0.14522379376577696 + ], + "xyz": [ + 4.093290953261335, + 15.012814726740888, + 15.135158543836575 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9508986777687966, + 0.15395827384632552, + 0.34401985818349234 + ], + "xyz": [ + 6.808267385047904, + 17.70389313820322, + 15.105405368230658 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9495192325711499, + 0.151157200270994, + 0.544577485423535 + ], + "xyz": [ + 9.511959390572175, + 20.42702139101409, + 15.048250068059877 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9553888805248157, + 0.14974161697550895, + 0.7450650035259058 + ], + "xyz": [ + 12.23363505030365, + 23.248299421042333, + 15.109145238334888 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9480471372732044, + 0.14812004894379072, + 0.9475115183345911 + ], + "xyz": [ + 14.979277574147925, + 25.915736738911768, + 14.986600459865237 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9531580526772605, + 0.3445810780765087, + 0.1535393170973285 + ], + "xyz": [ + 6.81021238114557, + 15.13056723403162, + 17.742455802621993 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.945358255549388, + 0.34867637215711905, + 0.35049184387580284 + ], + "xyz": [ + 9.558901999323222, + 17.716629306323313, + 17.691808503770375 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9454298982439149, + 0.3476682410915054, + 0.5521550838977718 + ], + "xyz": [ + 12.302222531054898, + 20.474712310544355, + 17.679005003328786 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9441129630382189, + 0.3533554202065208, + 0.7497861774609486 + ], + "xyz": [ + 15.081953357822059, + 23.158684147059326, + 17.738754191413094 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.953576746523516, + 0.3481876693492278, + 0.9448831157961044 + ], + "xyz": [ + 17.678631021765653, + 25.95540151485863, + 17.797488776217296 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9459714983675117, + 0.5485029427222153, + 0.15590628859440173 + ], + "xyz": [ + 9.63055621689915, + 15.064674765341625, + 20.432185553179348 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9518558903184342, + 0.5472142190424097, + 0.3550399837473151 + ], + "xyz": [ + 12.335457054784614, + 17.86764514896959, + 20.49501670256177 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9508420036388977, + 0.5556380801760208, + 0.5468171622240539 + ], + "xyz": [ + 15.072569632150186, + 20.475726537028414, + 20.596324539502476 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9552987171994615, + 0.5464575293404794, + 0.7515021606060305 + ], + "xyz": [ + 17.745471248204492, + 23.33507437719868, + 20.531741086569692 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9516031273730684, + 0.5519316015293977, + 0.9527576189685734 + ], + "xyz": [ + 20.57184017858857, + 26.036077339048582, + 20.55605617730331 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.953101737548505, + 0.7539617530754711, + 0.14774035782855421 + ], + "xyz": [ + 12.32790895389987, + 15.050514976417984, + 23.338664772382685 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9501612016322825, + 0.7462586723974399, + 0.35585620592232187 + ], + "xyz": [ + 15.067916235709683, + 17.85563491295319, + 23.193147162157036 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9526934279377578, + 0.74980693463005, + 0.5441086189159127 + ], + "xyz": [ + 17.69018054328076, + 20.46400816021495, + 23.276278506961805 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9507588976624178, + 0.7519814187142847, + 0.7533860269028283 + ], + "xyz": [ + 20.581112750336956, + 23.298762662569622, + 23.279559112245327 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9512064107860795, + 0.755460557714564, + 0.946636069768628 + ], + "xyz": [ + 23.270758713557253, + 25.94696078249746, + 23.333243593286465 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9521715102041416, + 0.9442558736161951, + 0.15395505983741078 + ], + "xyz": [ + 15.014542204209677, + 15.122763362825495, + 25.92761383466255 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.946725952390455, + 0.946383499493028, + 0.35171887381365297 + ], + "xyz": [ + 17.747421989421746, + 17.752103943793845, + 25.882251666449637 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9443562995011371, + 0.9497555790132105, + 0.5544023339843887 + ], + "xyz": [ + 20.564576238078832, + 20.490758260460076, + 25.895956662910024 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.9489465364049484, + 0.9561273575040368, + 0.7464698987975502 + ], + "xyz": [ + 23.27760322064916, + 23.17942832713022, + 26.04582736422274 + ], + "label": "Si", + "properties": {} + }, + { + "species": [ + { + "element": "Si", + "occu": 1 + } + ], + "abc": [ + 0.953772673061662, + 0.952283975370427, + 0.944169167504682 + ], + "xyz": [ + 25.92796600782277, + 25.94831921469175, + 26.0592634071668 + ], + "label": "Si", + "properties": {} + } + ] + } + ], + "disps": [ + 0.01, + 0.020000000000000004, + 0.030000000000000006, + 0.04000000000000001, + 0.05000000000000001, + 0.06000000000000001, + 0.07, + 0.08, + 0.09000000000000001, + 0.1 + ], + "first_pass": true, + "static_user_incar_settings": { + "ADDGRID": true, + "LCHARG": false, + "ENCUT": 700, + "EDIFF": 1e-08, + "PREC": "Accurate", + "LAECHG": false, + "LREAL": false, + "LASPH": true + }, + "env_vars": { + "VASP_CMD": ">>vasp_cmd<<", + "DB_FILE": ">>db_file<<" + }, + "shengbte_t_range": false, + "shengbte_fworker": null, + "_fw_name": "{{atomate.vasp.firetasks.parse_outputs.CSLDForceConstantsToDB}}" + } + ], + "calc_locs": [ + { + "name": "perturbed supercell, idx: 0, disp_val: 0.010, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-01-06-49-396367" + }, + { + "name": "perturbed supercell, idx: 1, disp_val: 0.020, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-01-00-10-536875/launcher_2019-08-03-01-15-54-768794" + }, + { + "name": "perturbed supercell, idx: 2, disp_val: 0.030, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-01-53-25-787365" + }, + { + "name": "perturbed supercell, idx: 4, disp_val: 0.050, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-02-00-31-887278/launcher_2019-08-03-02-10-39-900305" + }, + { + "name": "perturbed supercell, idx: 3, disp_val: 0.040, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-01-00-10-536875/launcher_2019-08-03-02-03-16-191652" + }, + { + "name": "perturbed supercell, idx: 5, disp_val: 0.060, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-02-41-13-527053" + }, + { + "name": "perturbed supercell, idx: 6, disp_val: 0.070, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-02-00-31-887278/launcher_2019-08-03-02-51-25-930836" + }, + { + "name": "perturbed supercell, idx: 7, disp_val: 0.080, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-01-00-10-536875/launcher_2019-08-03-03-14-04-415140" + }, + { + "name": "perturbed supercell, idx: 8, disp_val: 0.090, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-03-00-15-983388/launcher_2019-08-03-03-20-49-969204" + }, + { + "name": "perturbed supercell, idx: 9, disp_val: 0.100, static", + "filesystem": null, + "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-03-29-56-163076" + } + ] + }, + "fw_id": 382, + "created_on": "2019-08-02T23:22:50.420334", + "updated_on": "2019-08-05T00:02:13.075974", + "launches": [ + { + "fworker": { + "name": "rees_the_fire_worker", + "category": "", + "query": "{\"spec._fworker\": \"rees_the_fire_worker\"}", + "env": { + "db_file": "/global/homes/r/rchang97/anywhere_called_anything/knl/db.json", + "vasp_cmd": "srun -n64 -c16 --cpu_bind=cores vasp_std", + "vasp_ncl": "srun -N 4 -n 32 -c16 --cpu_bind=cores vasp_ncl", + "vasp_vtst": "srun -n 32 vasp_vtst", + "shengbte_cmd": "srun -N 4 -n 32 --cpu_bind=cores ShengBTE", + "scratch_dir": null, + "incar_update": { + "KPAR": 4 + }, + "MAPI_KEY": "auNIrJ23VLXCqbpl", + "OMP_NUM_THREADS": 4 + } + }, + "fw_id": 382, + "launch_dir": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-04-23-48-07-539963/launcher_2019-08-05-00-02-10-420079", + "host": "nid02993", + "ip": "10.128.11.200", + "trackers": [], + "action": null, + "state": "RUNNING", + "state_history": [ + { + "state": "RUNNING", + "created_on": "2019-08-05T00:02:12.925440", + "updated_on": "2019-08-05T00:02:12.925456" + } + ], + "launch_id": 285 + } + ], + "state": "RUNNING", + "name": "Compressed Sensing Lattice Dynamics" +} \ No newline at end of file diff --git a/atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si b/atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si new file mode 100644 index 000000000..283220155 --- /dev/null +++ b/atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si @@ -0,0 +1,10 @@ +Si2 +1.0 +0.0000000000000000 2.7343639999999998 2.7343639999999998 +2.7343639999999998 0.0000000000000000 2.7343639999999998 +2.7343639999999998 2.7343639999999998 0.0000000000000000 +Si +2 +direct +0.5000000000000000 0.5000000000000000 0.5000000000000000 Si +0.7500000000000000 0.7500000000000000 0.7500000000000000 Si diff --git a/atomate/vasp/test_files/csld_wf/__init__.py b/atomate/vasp/test_files/csld_wf/__init__.py new file mode 100644 index 000000000..e69de29bb diff --git a/atomate/vasp/workflows/tests/test_csld_workflow.py b/atomate/vasp/workflows/tests/test_csld_workflow.py new file mode 100644 index 000000000..da3d3db8b --- /dev/null +++ b/atomate/vasp/workflows/tests/test_csld_workflow.py @@ -0,0 +1,89 @@ +# coding: utf-8 + +from __future__ import division, print_function, unicode_literals, absolute_import + +import os +import unittest + +from pymatgen import Structure +from atomate.vasp.workflows.base.csld import CompressedSensingLatticeDynamicsWF +from atomate.vasp.firetasks.parse_outputs import ( + CSLDForceConstantsToDB, + ShengBTEToDB, +) +from atomate.utils.testing import AtomateTest, DB_DIR + +import json + +module_dir = os.path.join(os.path.dirname(os.path.abspath(__file__))) +db_dir = os.path.join(module_dir, "..", "..", "..", "common", "test_files") +ref_dir = os.path.join(module_dir, "..", "..", "test_files", "csld_wf") + +__author__ = "Rees Chang" +__email__ = "rc564@cornell.edu" + + +class TestCompressedSensingLatticeDynamicsWorkflow(AtomateTest): + + # def test_CSLD(self): + # + # structure = Structure.from_file(os.path.join(ref_dir, "POSCAR-well_relaxed_Si")) + # wf = CompressedSensingLatticeDynamicsWF(structure, + # symmetrize=False, + # num_nn_dists=6, + # num_displacements=10, + # supercells_per_displacement_distance=1, + # force_diagonal_transformation=True + # ) + # + # tasks = self.get_task_collection() + # with + + def test_set_params(self): + # tasks = self.get_task_collection() + with open(os.path.join(ref_dir, "FW.json"), + "r") as f: + sample_task = json.load(f) + wf_uuid = sample_task["spec"]["_tasks"][0]["wf_uuid"] + parent_structure = Structure.from_dict( + sample_task["spec"]["_tasks"][0]["parent_structure"]) + trans_mat = sample_task["spec"]["_tasks"][0]["trans_mat"] + supercell_structure = sample_task["spec"]["_tasks"][0]["supercell_structure"] + supercell_smallest_dim = sample_task["spec"]["_tasks"][0]["supercell_smallest_dim"] + perturbed_supercells = sample_task["spec"]["_tasks"][0]["perturbed_supercells"] + disps = sample_task["spec"]["_tasks"][0]["disps"] + first_pass = sample_task["spec"]["_tasks"][0]["first_pass"] + static_user_incar_settings = sample_task["spec"]["_tasks"][0]["static_user_incar_settings"] + env_vars = sample_task["spec"]["_tasks"][0]["env_vars"] + shengbte_t_range = sample_task["spec"]["_tasks"][0]["shengbte_t_range"] + shengbte_fworker = sample_task["spec"]["_tasks"][0]["shengbte_fworker"] + + print(wf_uuid) + print(parent_structure) + print(trans_mat) + print(supercell_structure) + print(supercell_smallest_dim) + print(perturbed_supercells) + print(disps) + print(first_pass) + print(static_user_incar_settings) + print(env_vars) + print(shengbte_t_range) + print(shengbte_fworker) + + # csld_firetask = CSLDForceConstantsToDB( + # db_file=os.path.join(DB_DIR, "db.json"), # wot + # wf_uuid=wf_uuid, + # parent_structure=parent_structure, + # trans_mat=trans_mat, + # supercell_structure=supercell_structure, + # supercell_smallest_dim=supercell_smallest_dim, + # perturbed_supercells=perturbed_supercells, + # disps=disps, + # first_pass=first_pass, + # static_user_incar_settings=static_user_incar_settings, + # env_vars=env_vars, + # shengbte_t_range=shengbte_t_range, + # shengbte_fworker=shengbte_fworker + # ) + From 8d9b7d1f4df8bf63123843ddf18f438ae549bd56 Mon Sep 17 00:00:00 2001 From: rees-c Date: Wed, 7 Aug 2019 11:11:04 -0700 Subject: [PATCH 041/207] Delete --- .../vasp/workflows/base/CSLD_sc_enumerator.py | 167 ------------------ 1 file changed, 167 deletions(-) delete mode 100644 atomate/vasp/workflows/base/CSLD_sc_enumerator.py diff --git a/atomate/vasp/workflows/base/CSLD_sc_enumerator.py b/atomate/vasp/workflows/base/CSLD_sc_enumerator.py deleted file mode 100644 index b37f9ad54..000000000 --- a/atomate/vasp/workflows/base/CSLD_sc_enumerator.py +++ /dev/null @@ -1,167 +0,0 @@ -#!/usr/bin/env python3 - -import numpy as np - -""" -This module defines a script that generates perturbed supercells from a supercell structure -""" - -class CSLDPerturbedSupercellEnumerator: - """ - Uses a supercell Structure, a transformation matrix, a min/max displacement, - number of displacement values, and number of supercells per displacement - to generate a list of randomly perturbed supercells from a given supercell. - - Args: - original_supercell (Structure): supercell to displace, typically already relaxed - max_displacement_val (float): maximum displacement value for perturbing the supercell (in Angstroms) - min_displacement_val (float): minimum displacement value for perturbing the supercell (in Angstroms) - num_displacements (int): number of unique displacement values to try, bounded by - min_displacement and max_displacement. This argument is ignored if min_displacement - is not passed as an argument. - scs_per_displacement_val (int): number of perturbed supercells to generate for each unique - displacement value. - - floor_displacement (Optional float): If None (default), then for a given perturbed supercell, all atoms will - move the same distance from their original locations. If float, then for a given perturbed supercell, - the distances that atoms move will be uniformly distributed from a minimum value of 'floor_displacement' - to the displacement value 'displacement_val'. - - """ - - def __init__(self, original_supercell, - max_displacement_val, - min_displacement_val, - num_displacements, - scs_per_displacement_val, - floor_displacement=None): - - self.original_supercell = original_supercell - self.max_disp_val = max_displacement_val - self.min_disp_val = min_displacement_val - self.num_disps = num_displacements - self.scs_per_disp_val = scs_per_displacement_val - - if floor_displacement is not None: - self.floor_disp = float(floor_displacement) - else: - self.floor_disp = None - - self.disp_vals = np.linspace(min_displacement_val, max_displacement_val, num=num_displacements) - self.perturbed_supercells = self.generate_transformations() - - - def random_displacements(self, natom, rmax, rmin, dim=3): - #*** Adapted from csld.util.mathtool - - # Generate matrix of size (natom, 3) where each row is a Gaussian random vector - # If 'rmax'=None, then all vectors will have magnitude 'rmin'. - # Else, magnitudes are uniformly distributed between 'rmin' and 'rmax'. - - dx = np.random.normal(size=(natom, dim)) #Gaussian sampled displacements. Matrix size: (natom, 3) - dx_norms = np.linalg.norm(dx, axis=1) - veclen = np.full(natom, rmax) if rmin is None else np.random.uniform(rmin, rmax, natom) - - if not 0 in dx_norms: - return dx * (veclen / dx_norms)[:, None] - else: - self.random_displacements(natom, rmax, rmin, dim) - - - def perturb_supercell(self, structure, max_disp, floor_disp): - # *** Adapted from CSLD's 'polaron_main' file - - na = structure.num_sites - max_disp = float(max_disp) - if isinstance(max_disp, float): - # from csld.util.mathtool import random_displacements - dr = self.random_displacements(na, max_disp, floor_disp) #generate random displacements - - # Perturb structure with the random displacements - for i in range(len(structure._sites)): - structure.translate_sites([i], dr[i], frac_coords=False, to_unit_cell=True) - return structure - else: - print('displacement entered is not a float.') - - - def generate_transformations(self): - perturbed_supercells = [] - for disp_val in self.disp_vals: - for cell in range(self.scs_per_disp_val): - sc = self.original_supercell.copy() - sc = self.perturb_supercell(sc, disp_val, self.floor_disp) - perturbed_supercells += [sc] - return perturbed_supercells - - -#################################### -# BELOW IS FOR DEBUGGING PURPOSES # -#################################### -def main(): - # print('test') - # natom = 10 - # dim = 3 - # rmin = 0 - # rmax = 0.1 - # dx = np.random.normal(size=(natom, dim)) # Gaussian sampled displacements. Matrix size: (natom, 3) - # print(dx.shape) - # veclen = np.full(natom, rmin) if rmax is None else np.random.uniform(rmin, rmax, natom) # vector of length natom - # dx *= (veclen / np.linalg.norm(dx, axis=1))[:, None] - # test = (veclen / np.linalg.norm(dx, axis=1))[:, None] - # print(test.shape) - # - # x = np.array([[1, 1, 1], - # [1, 1, 1], - # [1, 1, 1], - # [1, 1, 1]]) - # y = np.array([[1], - # [2], - # [3], - # [4]]) - # print(x*y) - - from atomate.vasp.workflows.base.csld_sc_gen import gen_scaling_matrix - - from pymatgen.ext.matproj import MPRester - from pymatgen.analysis.structure_analyzer import get_max_bond_lengths - from pymatgen.transformations.standard_transformations import SupercellTransformation - - mpr = MPRester(api_key='auNIrJ23VLXCqbpl') - # structure = mpr.get_structure_by_material_id('mp-7814') #passed - structure = mpr.get_structure_by_material_id('mp-1101039') # passed - # structure = mpr.get_structure_by_material_id('mp-20012') - - print('structure loaded') - print(structure.num_sites) - # print('structure') - # print(structure) - # structure.to(fmt='poscar', filename='POSCAR-tlbise2-scraped') - - # # Find Primitive - # from pymatgen.symmetry.analyzer import SpacegroupAnalyzer - # sga = SpacegroupAnalyzer(structure) - # # print(sga.find_primitive().lattice) - # sga.find_primitive().to(fmt='poscar', filename='POSCAR-tlbise2-scraped-prim') - - T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150, max_atoms=1000) - # ***my function, pymatgen's SupercellTransformation, and CSLD all yield different supercell lattice vectors - - print('~~~~~~~~~~~~~~~~~~~~~~~~~') - print("FINISHED2") - # print(T) - - # Pymatgen version - superstructure = SupercellTransformation(T).apply_transformation(structure) - - enum = CSLDPerturbedSupercellEnumerator(superstructure, - max_displacement_val=0.05, - min_displacement_val=0.01, - num_displacements=2, - scs_per_displacement_val=1) - print('perturbed supercells list:') - print(enum.perturbed_supercells) - - -if __name__ == '__main__': - main() \ No newline at end of file From 685f2fb486f3269fa83206b6c09bc5c55ca925f2 Mon Sep 17 00:00:00 2001 From: rees-c Date: Wed, 7 Aug 2019 11:11:21 -0700 Subject: [PATCH 042/207] Delete --- atomate/vasp/workflows/base/csld_sc_gen.py | 257 --------------------- 1 file changed, 257 deletions(-) delete mode 100644 atomate/vasp/workflows/base/csld_sc_gen.py diff --git a/atomate/vasp/workflows/base/csld_sc_gen.py b/atomate/vasp/workflows/base/csld_sc_gen.py deleted file mode 100644 index 6fa54d80e..000000000 --- a/atomate/vasp/workflows/base/csld_sc_gen.py +++ /dev/null @@ -1,257 +0,0 @@ -#!/usr/bin/env python3 - -import math - -import numpy as np - -from pymatgen.ext.matproj import MPRester -from pymatgen.analysis.structure_analyzer import get_max_bond_lengths -from pymatgen.transformations.standard_transformations import SupercellTransformation - -""" -This module defines the Compressed Sensing Lattice Dynamics (CSLD) workflow. - -V3 added rounding of entries away from 0 if there are zero rows or columns in the transformation matrix. -""" - - -def round_away_from_zero(x): - aX = abs(x) - return math.ceil(aX)*(aX/x) if x is not 0 else 0 - -def gen_scaling_matrix(structure=None, max_atoms=np.Inf, min_atoms=-np.Inf, length_cutoff=5): - """ - Returns the transformation matrix of a Pymatgen structure into a suitable supercell for CSLD - - Args: - structure (Structure): input structure. - max_atoms (int): maximum number of atoms allowed in the supercell - min_atoms (int): minimum number of atoms allowed in the supercell - length_cutoff (int): number of multiples of the unit cell nearest neighbor distance to - force all directions of the supercell to be at least as large - - Returns: - Transformation matrix (numpy array) - """ - - if not structure: - print('No structure was passed into gen_scaling_matrix()') - else: - - # -------- Store relevant structure data ---------- - latVecs = structure.lattice.matrix #lattice vectors - bondLengths = get_max_bond_lengths(structure) #dictionary of bond lengths - bondMatrix = structure.distance_matrix #NxN matrix of bond distances (diagonal is 0) - # print(bondMatrix) - # print(structure.sites) - np.fill_diagonal(bondMatrix, np.Inf) - nnDist = np.amin(bondMatrix) #nearest neighbor bond length - print("nn Dist: " + str(nnDist)) - - # --------- Transform lattice vectors ------------- - SCnotFound = True # boolean indicator for whether a sufficiently large supercell has been created - hard_threshold = nnDist * length_cutoff - print("hard_threshold: " + str(hard_threshold)) - target_threshold = hard_threshold # target_threshold is used as the desired CUBE side lengths of - # the supercell (SC) - # note: if it is not possible to get a cubic SC, the real SC dimensions will be less - # than the target - while SCnotFound: - print('---------------------------------------------------------') - print('target threshold: ' + str(target_threshold)) - target_supercell = np.eye(3, 3) * target_threshold - - T = np.linalg.inv(latVecs) @ target_supercell - # T = target_supercell @ np.linalg.inv(latVecs) - print('T before rounding:') - print(T) - print('T after rounding:') - T_rounded = np.around(T) - print(T_rounded) - - - # Zero columns or rows make T singular, so make them non-singular - if (~T_rounded.any(axis=1)).any(): #Check for zero rows - zero_row_idxs = np.where(~T_rounded.any(axis=1))[0] - for zero_row_idx in zero_row_idxs: - # print(zero_row_idx) - zero_row = T[zero_row_idx, :] - # print('zero row:' + str(zero_row)) - col_idx_to_fix = np.where(np.absolute(zero_row) == np.amax(np.absolute(zero_row)))[0] - # print('amax:') - # print(np.amax(np.absolute(zero_row))) - # print('col idx to fix:') - # print(col_idx_to_fix) - for j in col_idx_to_fix: - T_rounded[zero_row_idx, j] = round_away_from_zero(T[zero_row_idx, j]) - if (~T_rounded.any(axis=1)).any(): #Check for zero columns - zero_col_idxs = np.where(~T_rounded.any(axis=1))[0] - for zero_col_idx in zero_col_idxs: - zero_col = T[:, zero_col_idx] - row_idx_to_fix = np.where(np.absolute(zero_col) == np.amax(np.absolute(zero_col)))[0] - for i in row_idx_to_fix: - T_rounded[i, zero_col_idx] = round_away_from_zero(T[i, zero_col_idx]) - - - T = T_rounded - print("proposed sc.txt:") - print(T) - - print("\nSupercell dimensions:") - scBases = latVecs @ T - print(scBases) - print("Supercell volume:") - vol = np.cross(scBases[0],scBases[1]).T @ scBases[2] - print(vol) - - # -------------------- Check how many nearest neighbors the supercell allows --------------------------- - def proj(b, a): - # Returns vector projection of b onto a - return (b.T @ (a / np.linalg.norm(a))) * (a / np.linalg.norm(a)) - - scBasesNorms = [np.linalg.norm(scBases[0]), np.linalg.norm(scBases[1]), np.linalg.norm(scBases[2])] - maxNorm = max(scBasesNorms) - maxIndex = scBasesNorms.index(maxNorm) - idx = list(range(3)) - idx.remove(maxIndex) - a = scBases[maxIndex] - b = scBases[idx[0]] - c = scBases[idx[1]] - projb_a = proj(b, a) - projc_a = proj(c, a) - - if np.linalg.norm(projb_a) > np.linalg.norm(projc_a): - length = np.linalg.norm(a - projb_a) - else: - length = np.linalg.norm(a - projc_a) - width = math.sqrt(np.linalg.norm(b) ** 2 - np.linalg.norm(projb_a) ** 2) - ab_normal = np.cross(a, b) # get normal direction from AB plane - height = np.linalg.norm(proj(c, ab_normal)) # project c onto AB plane normal - - cubeSide = min([length, width, height]) - print('smallest dimension of proposed SC: ' + str(cubeSide)) - - # Get number of atoms - superstructure = SupercellTransformation(T).apply_transformation(structure) - num_at = superstructure.num_sites - - if cubeSide >= hard_threshold and num_at >= min_atoms and num_at <= max_atoms: - print(T) - print("FINISHED") - return T - else: - # Increase threshold until - target_threshold += 1 - if num_at > max_atoms: - raise AttributeError('While trying to solve for the supercell, the max' - 'number of atoms was exceeded. Try lowering the number' - 'of nearest neighbor distances.') - return - - -def parallelipipedVol(a=[1, 0, 0], b=[0, 1, 0], c=[0, 0, 1]): - vol = np.cross(a,b).T @ c - return vol - - -def main(): - mpr = MPRester(api_key='auNIrJ23VLXCqbpl') - # structure = mpr.get_structure_by_material_id('mp-7814') #passed - structure = mpr.get_structure_by_material_id('mp-1101039') #passed - # structure = mpr.get_structure_by_material_id('mp-20012') - - print('structure loaded') - print(structure.num_sites) - # print('structure') - # print(structure) - # structure.to(fmt='poscar', filename='POSCAR-tlbise2-scraped') - - # # Find Primitive - # from pymatgen.symmetry.analyzer import SpacegroupAnalyzer - # sga = SpacegroupAnalyzer(structure) - # # print(sga.find_primitive().lattice) - # sga.find_primitive().to(fmt='poscar', filename='POSCAR-tlbise2-scraped-prim') - - - T = gen_scaling_matrix(structure, length_cutoff=5, min_atoms=150, max_atoms=1000) - #***my function, pymatgen's SupercellTransformation, and CSLD all yield different supercell lattice vectors - - print('~~~~~~~~~~~~~~~~~~~~~~~~~') - print("FINISHED2") - # print(T) - - # Pymatgen version - superstructure = SupercellTransformation(T).apply_transformation(structure) - print(superstructure.lattice) - # print(superstructure.volume) - # print(parallelipipedVol(superstructure.lattice.matrix[0], - # superstructure.lattice.matrix[1], - # superstructure.lattice.matrix[2])) - print(superstructure.num_sites) - - # # Find Primitive - # from pymatgen.symmetry.analyzer import SpacegroupAnalyzer - # sga = SpacegroupAnalyzer(superstructure) - # # print(sga.find_primitive().lattice) - # sga.find_primitive().to(fmt='poscar', filename='POSCAR-scTest-prim') - - superstructure.to(fmt='poscar', filename='POSCAR-scTest') - - - - # # CSLD version - # # *** Can't call CSLD Structure member functions because structure scraped is a Pymatgen Structure *** - # from csld.structure import Structure as CSLDStructure - # from csld.lattice import Lattice as CSLDLattice - # from csld.coord_utils import supercell_latticepoints - # - # def generate_supercell(CSLDStructure, scaling_matrix, scref=None): - # """ - # Create a supercell. - # - # Args: - # scaling_matrix: A scaling matrix for transforming the lattice - # vectors. Has to be all integers. Several options are possible: - # - # a. A full 3x3 scaling matrix defining the linear combination - # the old lattice vectors. E.g., [[2,1,0],[0,3,0],[0,0, - # 1]] generates a new structure with lattice vectors a' = - # 2a + b, b' = 3b, c' = c where a, b, and c are the lattice - # vectors of the original structure. - # b. An sequence of three scaling factors. E.g., [2, 1, 1] - # specifies that the supercell should have dimensions 2a x b x - # c. - # c. A number, which simply scales all lattice vectors by the - # same factor. - # """ - # scmat = np.array(scaling_matrix, np.int16) - # if scmat.shape != (3, 3): - # scmat= np.array(scmat* np.eye(3), np.int16) - # n_cell=int(round(np.linalg.det(scmat))) - # old_lattice = CSLDStructure._lattice - # new_lattice = CSLDLattice(np.dot(scmat, old_lattice.matrix)) - # tvects = supercell_latticepoints(scmat) - # inv=np.linalg.inv(scmat) - # if scref is None: - # sc_ref= supercell_latticepoints(scmat) - # else: - # sc_ref= scref - # return CSLDStructure(CSLDLattice(np.dot(scmat, CSLDStructure._lattice.matrix)), - # [s.species_and_occu for s in CSLDStructure for _ in range(n_cell)], - # (CSLDStructure.frac_coords[:,None,:]+sc_ref[None,:,:]).reshape((-1,3)).dot(inv), - # coords_are_cartesian=False, to_unit_cell=True, - # site_properties_T=[s.properties for s in CSLDStructure for _ in range(n_cell)], - # intensive_properties=CSLDStructure.intensive_properties,extensive_properties= - # {k:v*CSLDStructure.n_cell for k,v in CSLDStructure.extensive_properties.items()}) - # - # # csld_structure = csld.structure.Structure(structure.lattice, structure.species, structure.lattice.get_fractional_coords()) - # csld_supercell = SupercellStructure.from_scmat(csld_structure, T) - # print("here:") - # print(csld_supercell) - -if __name__ == '__main__': - main() - - - - From da91bdc5c8e04c5cb6da867e85a545f74d24378a Mon Sep 17 00:00:00 2001 From: rees-c Date: Wed, 7 Aug 2019 11:11:38 -0700 Subject: [PATCH 043/207] Delete --- atomate/vasp/workflows/base/sbte_IO.py | 180 ------------------------- 1 file changed, 180 deletions(-) delete mode 100644 atomate/vasp/workflows/base/sbte_IO.py diff --git a/atomate/vasp/workflows/base/sbte_IO.py b/atomate/vasp/workflows/base/sbte_IO.py deleted file mode 100644 index ffd465645..000000000 --- a/atomate/vasp/workflows/base/sbte_IO.py +++ /dev/null @@ -1,180 +0,0 @@ -#!/usr/bin/env python3 - -import f90nml -import numpy as np -""" -This module defines IO ShengBTE for making CONTROL file (i.e. a class that can read/write the ‘control’ file, f90ml) - -TO-DO: Test this thing -""" - -class ShengBTE_CONTROL_IO: - - """ - Args: - nelements (int): number of elements in the material - natoms (int): number of atoms in the cell - ngrid (3 length list of ints): q-point mesh - ***norientations (int): - ***lfactor (float): - lattvec1 (3 length list of floats): first lattice vector - lattvec2 (3 length list of floats): second lattice vector - lattvec3 (3 length list of floats): third lattice vector - elements (comma-separated list of strings): list of elements present - types (natoms length list of ints): atom types listed in the same order as in 'elements' (first atom should be '1') - positions (natoms x 3 matrix): atomic positions of each atom - scell (3 length list of ints): dimensions of supercell input - ***temperature (int): temperature in Kelvin? - scalebroad (float): Gaussian broadening of allowable energies that can scatter a phonon to a certain state - (higher broadening = more scattering allowed. Too high is unphysical. For complex - materials, make 'scalebroad' smaller since there will be more scattering candidates - for any given phonon. - ***onlyharmonic (bool): Whether to only consider harmonic scattering (2-phonon?) - ***isotopes (bool): Whether to consider scattering from isotopic disorder. - ***nonanalytic (bool): Used for Born effective charge and dielectric constant. - nanowires (bool): Whether the structure input is a nanowire. - - Returns: - IO reader/writer for ShengBTE's CONTROL file, composed of FORTRAN namelists - """ - - def read_CONTROL(self, filename): - nml = f90nml.read(filename) - return nml - - - - def file_writer_helper_func(self, dict, filename): - nelements = str(dict['allocations']['nelements']) - natoms = str(dict['allocations']['natoms']) - ngrid = dict['allocations']['ngrid'] - norientations = str(dict['allocations']['norientations']) - - lfactor = str(dict['crystal']['lfactor']) - lattvec1 = dict['crystal']['lattvec'][0] - lattvec2 = dict['crystal']['lattvec'][1] - lattvec3 = dict['crystal']['lattvec'][2] - elements = dict['crystal']['elements'] #string or list of strings, needs to be parsed - types = dict['crystal']['types'] #list of ints, needs to be parsed - positions = np.asarray(dict['crystal']['positions']) #numpy array, needs to be parsed - num_sites, _ = positions.shape - scell = dict['crystal']['scell'] #list of ints, needs to be parsed - - temperature = str(int(dict['parameters']['T'])) - scalebroad = str(dict['parameters']['scalebroad']) - - onlyharmonic = dict['flags']['onlyharmonic'] - isotopes = dict['flags']['isotopes'] - nonanalytic = dict['flags']['nonanalytic'] - nanowires = dict['flags']['nanowires'] - - def boolean_to_string(boolean): - if boolean is True: - return '.TRUE.' - else: - return '.FALSE.' - - indent = ' ' - types_string ='types=' - positions_string = '' - for line in range(num_sites): - if line != num_sites-1: - types_string += str(types[line])+' ' - else: - types_string += str(types[line])+',\n' - positions_string += 'positions(:,' + str(line+1) + ')=' + str(positions[line,0]) + ' ' \ - + str(positions[line,1]) + ' ' + str(positions[line,2]) + ',\n' + indent - - full_string = '&allocations\n'+indent+'nelements='+nelements+',\n' - full_string += indent+'natoms='+natoms+',\n' - full_string += indent+'ngrid(:)='+str(ngrid[0])+' '+str(ngrid[1])+' '+str(ngrid[2])+'\n' - full_string += indent+'norientations='+norientations+'\n' - full_string += '&end\n&crystal\n' - full_string += indent+'lfactor='+lfactor+',\n' - full_string += indent+'lattvec(:,1)='+str(lattvec1[0])+' '+str(lattvec1[1])+' '+str(lattvec1[2])+',\n' - full_string += indent+'lattvec(:,2)='+str(lattvec2[0])+' '+str(lattvec2[1])+' '+str(lattvec2[2])+',\n' - full_string += indent+'lattvec(:,3)='+str(lattvec3[0])+' '+str(lattvec3[1])+' '+str(lattvec3[2])+',\n' - full_string += indent+'elements=' - if isinstance(elements, list): - for i in range(len(elements)): - full_string += '\"'+elements[i]+str('\"') - if i != (len(elements)-1): - full_string += ' ' - else: - full_string += '\n' - else: - full_string += '\"'+elements+str('\"\n') - full_string += indent+types_string - full_string += indent+positions_string - full_string += 'scell(:)='+str(scell[0])+' '+str(scell[1])+' '+str(scell[2])+'\n' - full_string += '&end\n¶meters\n' - full_string += indent+'T='+temperature+'\n' - full_string += indent+'scalebroad='+scalebroad+'\n' - full_string += '&end\n&flags\n' - full_string += indent+'isotopes='+boolean_to_string(isotopes)+'\n' - full_string += indent+'onlyharmonic='+boolean_to_string(onlyharmonic)+'\n' - full_string += indent+'nonanalytic='+boolean_to_string(nonanalytic)+'\n' - full_string += indent+'nanowires='+boolean_to_string(nanowires)+'\n' - full_string += '&end' - - file = open(filename, 'w+') - file.write(full_string) - file.close() - - - def write_CONTROL_from_dict(self, dict, filename='CONTROL', overwrite=True): - with open(filename, 'w') as control_file: - new_dict = {'allocations': - {'nelements': dict.get('allocations', None).get('nelements', None), - 'natoms': dict.get('allocations', None).get('natoms', None), - 'ngrid': dict.get('allocations', [25, 25, 25]).get('ngrid', [25, 25, 25]), - 'norientations': dict.get('allocations', 0).get('norientations', 0)}, - 'crystal': - {'lfactor': dict.get('crystal', 0.1).get('lfactor', 0.1), - # 'lattvec(:,1)': dict.get('crystal', None).get('lattvec(:,1)', None), - # 'lattvec(:,2)': dict.get('crystal', None).get('lattvec(:,2)', None), - # 'lattvec(:,3)': dict.get('crystal', None).get('lattvec(:,3)', None), - 'lattvec': dict.get('crystal', None).get('lattvec', None), - 'elements': dict.get('crystal', None).get('elements', None), - 'types': dict.get('crystal', None).get('types', None), - 'positions': dict.get('crystal', None).get('positions', None), - 'scell': dict.get('crystal', [5, 5, 5]).get('scell', [5, 5, 5])}, - 'parameters': - {'T': dict.get('parameters', 300).get('t', 300), - 'scalebroad': dict.get('parameters', 0.5).get('scalebroad', 0.5)}, - 'flags': - {'onlyharmonic': dict.get('flags', False).get('onlyharmonic', False), - 'isotopes': dict.get('flags', False).get('isotopes', False), - 'nonanalytic': dict.get('flags', True).get('nonanalytic', True), - 'nanowires': dict.get('flags', False).get('nanowires', False)}} - - # nml = f90nml.namelist.Namelist(new_dict) #convert dict to namelist object - # nml.false_repr = '.FALSE.' - # nml.true_repr = '.TRUE.' - # nml.index_spacing = False - # nml.uppercase = False - # nml.indent = ' ' - # f90nml.write(nml, control_file, force=overwrite, sort=False) #force=True overwrites an existing file - self.file_writer_helper_func(new_dict, filename=filename) - - -def main(): - # Read the CONTROL file into a Fortran namelist object - sbte_io = ShengBTE_CONTROL_IO() - namelist = sbte_io.read_CONTROL('CONTROL') - print(namelist) - print('---------------------') - - # Convert the namelist object to a dict for easy access of contents - dict = namelist.todict() - print(dict) - print(dict['allocations']['nelements']) - print(dict['crystal']['lattvec']) - print(dict['crystal']['lattvec'][0]) - - # Write the dict back into a namelist file - sbte_io.write_CONTROL_from_dict(dict, filename='CONTROL_test2') - - -if __name__ == '__main__': - main() \ No newline at end of file From 8b2c4e223efa2e3fe82c79c0e2c9ac3a0f62f26d Mon Sep 17 00:00:00 2001 From: rees-c Date: Wed, 7 Aug 2019 11:11:50 -0700 Subject: [PATCH 044/207] Delete --- .../workflows/base/scrape_forces_from_DB.py | 85 ------------------- 1 file changed, 85 deletions(-) delete mode 100644 atomate/vasp/workflows/base/scrape_forces_from_DB.py diff --git a/atomate/vasp/workflows/base/scrape_forces_from_DB.py b/atomate/vasp/workflows/base/scrape_forces_from_DB.py deleted file mode 100644 index 90178a709..000000000 --- a/atomate/vasp/workflows/base/scrape_forces_from_DB.py +++ /dev/null @@ -1,85 +0,0 @@ -#!/usr/bin/env python3 - - -import numpy as np -from pymongo import MongoClient - - -# MongoDB database settings/details -host = "brmyvxghlvvkgkx-mongodb.services.clever-cloud.com" -port = 27017 -database_name = "brmyvxghlvvkgkx" -username = "usxrmfzwh9ed1plwi027" -password = "JJGXekEfnNYtXQSBYHv8" - -# Connect to the database -db = MongoClient(host, port)[database_name] -db.authenticate(username, password) -tasks = db.tasks #connects to the 'tasks' collection - -""" -This module defines IO ShengBTE for making CONTROL file (i.e. a class that can read/write the ‘control’ file, f90ml) - -TO-DO: Test this thing with csld_main -""" - -def scrape_forces_to_txt(task_id): - # Input a Firetask task_id (int) - # Output a .txt with all the atomic forces - - forces_list = tasks.find_one({'task_id': task_id})['calcs_reversed'][0]['output']['ionic_steps'][0]['forces'] - # print(forces_list) - # print(len(forces_list)) - - num_atoms = len(forces_list) - forces = np.empty((num_atoms,3)) - for atom in range(num_atoms): - forces[atom,:] = forces_list[atom][:] - # print(forces) - np.savetxt('forces.txt', forces, fmt='%.6f') - - -def main(): - scrape_forces_to_txt(2) - - -if __name__ == '__main__': - main() - -# def get_structure_from_task_id(task_id): -# # Input a Firetask task_id (int) -# # Return the corresponding Pymatgen structure (Structure) -# try: -# return Structure.from_dict(tasks.find_one({"task_id": task_id})["input"]["structure"]) -# except: -# print("No structure with task id '{}' was found.".format(task_id)) -# -# -# -# def get_structures_from_formulaV2(formula, task_label=None): -# # Required: -# # Input a Pymatgen 'pretty formula' (String) -# # Optional: -# # Input a 'task_label' or substring of a 'task_label' (String) -# # Return the corresponding Pymatgen Structures (list) -# -# structs = [] -# try: -# query = {"formula_pretty": formula} -# if task_label is not None and isinstance(task_label, str): -# # query["$and"] += [{"task_label": task_label}] -# query["task_label"] = {"$regex": task_label} -# dicts = list(tasks.find(query, ["input.structure"])) -# -# # dicts = list(tasks.find({"$and": [{"formula_pretty": formula}, -# # {"task_label": task_label}]}, -# # ["input.structure"])) -# for dict in dicts: -# struct = Structure.from_dict(dict["input"]["structure"]) -# structs += [struct] -# return structs -# except: -# if isinstance(formula, str): -# print("No structures with the formula '{}' found.".format(formula)) -# else: -# print("Entered formula is not a string.") From d8af0551edeeae1c4c563bea2917b7a29dd4cebf Mon Sep 17 00:00:00 2001 From: reeschang Date: Wed, 7 Aug 2019 22:52:14 -0700 Subject: [PATCH 045/207] updated script for creating workflows --- atomate/vasp/workflows/base/csld.py | 31 ++++++++++++++++++----------- 1 file changed, 19 insertions(+), 12 deletions(-) diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index e0edef612..0c89d13a1 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -246,11 +246,13 @@ def get_wf(self, c=None): # SCRIPT FOR CREATING THE WORKFLOW AND ADDING IT TO THE DATABASE if __name__ == "__main__": - from atomate.vasp.powerups import add_tags, set_execution_options + from fireworks import LaunchPad + from atomate.vasp.powerups import add_tags, set_execution_options, \ + add_modify_incar from pymatgen.symmetry.analyzer import SpacegroupAnalyzer from pymatgen.core.structure import Structure - prim = Structure.from_file('POSCAR-well_relaxed_InSb_csld_primitivized') + prim = Structure.from_file('POSCAR-well_relaxed_KSnBi') csld_class = CompressedSensingLatticeDynamicsWF( prim, @@ -258,7 +260,9 @@ def get_wf(self, c=None): num_nn_dists=6, num_displacements=10, supercells_per_displacement_distance=1, - force_diagonal_transformation=True + force_diagonal_transformation=True, + do_shengbte=True, + shengbte_fworker="rees_the_fire_worker_haswell" ) print("uuid") print(csld_class.uuid) @@ -272,15 +276,18 @@ def get_wf(self, c=None): print(csld_class.supercell_smallest_dim) print("supercell number of atoms") print(csld_class.supercell.num_sites) - csld_class.supercell.to("poscar", filename="SPOSCAR-InSb_diagonal") + csld_class.supercell.to("poscar", filename="SPOSCAR-KSnBi_diagonal") wf = add_tags(wf, ['csld', 'v1', 'rees', - 'pre-relaxed insb', 'diagonal supercell', - 'not symmetrized']) + 'pre-relaxed ksnbi', 'diagonal supercell', + 'not symmetrized', 'ismear manually set to 0']) wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") - # wf = add_modify_incar(wf, - # modify_incar_params={'incar_update': {'ENCUT': 500, - # 'ISPIN': 1}}) - - # lpad = LaunchPad.auto_load() - # lpad.add_wf(wf) + wf = add_modify_incar(wf, + modify_incar_params={ + 'incar_update': { + 'ENCUT': 500, + 'ISMEAR': 0, + 'ISPIN': 1}}) + + lpad = LaunchPad.auto_load() + lpad.add_wf(wf) From caeef025456446a61c4a112e7a3a9b012abd0f4c Mon Sep 17 00:00:00 2001 From: reeschang Date: Thu, 8 Aug 2019 17:12:57 -0700 Subject: [PATCH 046/207] More unit tests and minor bug fixes --- atomate/vasp/analysis/csld.py | 1 + atomate/vasp/firetasks/parse_outputs.py | 28 +- atomate/vasp/test_files/csld_wf/FW.json | 1095 ++++++++++++++++- atomate/vasp/workflows/base/csld.py | 25 +- .../workflows/tests/test_csld_workflow.py | 175 ++- 5 files changed, 1255 insertions(+), 69 deletions(-) diff --git a/atomate/vasp/analysis/csld.py b/atomate/vasp/analysis/csld.py index a1b367d63..799963108 100644 --- a/atomate/vasp/analysis/csld.py +++ b/atomate/vasp/analysis/csld.py @@ -172,6 +172,7 @@ def csld_main(options, settings): 'fval_out': 'fval_pred.txt', 'traindat0': 'fcc222/POSCAR fcc222/traj*' }, + 'export_potential': {}, 'DEFAULT': { "qpoint_fractional": False, "true_v_fit": 'true_fit.txt', diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 25cbb8137..2037ab6d5 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1918,7 +1918,7 @@ def collect_successful_static_calcs_results(self, tasks): "parent_structure"].composition.reduced_formula task_label = 'static' supercells_dicts = list( - tasks.find({"wf_meta.wf_uuid": uuid, # = 2)) and cls.is_small_in('" + "Si_supercell_iter0" + "/sc.txt')" + ) + self.assertEqual( + csld_firetask["csld_settings"]["training"]["traindat1"], + 'Si_supercell_iter0/SPOSCAR Si_supercell_iter0/disp0.10' + ) + self.assertEqual( + csld_firetask["csld_settings"]["fitting"]["submodel1"], + 'anh 0 1 2 3' + ) + self.assertEqual( + csld_firetask["csld_settings"]["export_potential"]["export_shengbte"], + '5 5 5 2 3' + ) + self.assertEqual( + csld_firetask["forces_paths"], + ['Si_supercell_iter0/disp0.10'] + ) + self.assertTrue( + os.path.isfile(csld_firetask["forces_paths"][0] + "/force.txt") + ) + self.assertTrue( + os.path.isfile('Si_supercell_iter0/POSCAR') + ) + self.assertTrue( + os.path.isfile('Si_supercell_iter0/SPOSCAR') + ) + self.assertTrue( + os.path.isfile('Si_supercell_iter0/sc.txt') + ) + shutil.rmtree('Si_supercell_iter0') + + def test_run_csld(self): + + + + + From 0bd0a6586ddc092504e9286a1938d7496eaec6fe Mon Sep 17 00:00:00 2001 From: reeschang Date: Thu, 8 Aug 2019 17:13:51 -0700 Subject: [PATCH 047/207] Junsoo's --- atomate/vasp/workflows/tests/test_csld_workflow.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/tests/test_csld_workflow.py b/atomate/vasp/workflows/tests/test_csld_workflow.py index b0432d12f..a50b7a9fa 100644 --- a/atomate/vasp/workflows/tests/test_csld_workflow.py +++ b/atomate/vasp/workflows/tests/test_csld_workflow.py @@ -164,7 +164,7 @@ def test_set_params(self): shutil.rmtree('Si_supercell_iter0') def test_run_csld(self): - + print('hi') From 2ce5a0357806922754cf72bf22e8f502b4dbda32 Mon Sep 17 00:00:00 2001 From: reeschang Date: Thu, 8 Aug 2019 19:29:10 -0700 Subject: [PATCH 048/207] debug --- atomate/vasp/firetasks/parse_outputs.py | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 2037ab6d5..fba355c9e 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -2036,6 +2036,7 @@ def set_params(self, iteration_number, disps, cluster_diam, # Create ConfigParser of all CSLD input settings csld_settings_dict = deepcopy(default_csld_settings) + # Update default settings if specified user_csld_settings = kwargs if user_csld_settings is not None: # recursively update settings dict @@ -2060,7 +2061,8 @@ def set_params(self, iteration_number, disps, cluster_diam, csld_settings_dict['fitting']['submodel1'] = submodel1 # e.g., '5 5 5 2 3' is a 5x5x5 supercell - csld_settings_dict['export_potential']['export_shengbte'] = export_sbte + csld_settings_dict['export_potential'] = {'export_shengbte': + export_sbte} csld_settings = ConfigParser() csld_settings.read_dict(csld_settings_dict) From e83cde83b92244adcf98194e463e95fdecc55d36 Mon Sep 17 00:00:00 2001 From: reeschang Date: Fri, 9 Aug 2019 10:21:33 -0700 Subject: [PATCH 049/207] last cleanup of the term --- atomate/vasp/firetasks/parse_outputs.py | 6 +++--- atomate/vasp/workflows/base/csld.py | 13 +++++-------- atomate/vasp/workflows/tests/test_csld_workflow.py | 5 ++++- 3 files changed, 12 insertions(+), 12 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index fba355c9e..794fecc97 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -2089,6 +2089,7 @@ def run_csld(self, iter): summary (dict): Summary of the results from CSLD """ # Perform csld minimization now + logger.info("Running CSLD...") from atomate.vasp.analysis.csld import csld_main rel_err, freq_matrix = csld_main(self["csld_options"], self["csld_settings"]) @@ -2104,10 +2105,9 @@ def run_csld(self, iter): # so we ignore these) imaginary_idx = freq_matrix < -1 imaginary_freqs = freq_matrix[imaginary_idx] - print('IMAGINARY FREQUENCIES') - print(imaginary_freqs) + logger.info('IMAGINARY FREQUENCIES: \n{}'.format(imaginary_freqs)) num_imaginary_bands = np.sum(np.any(imaginary_idx, axis=1)) - print(num_imaginary_bands) + logger.info('Number of imaginary bands: {}'.format(num_imaginary_bands)) if np.any(imaginary_freqs): most_imaginary_freq = np.amin(imaginary_freqs) else: diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py index b7ac5ad8b..dcaaa7b02 100644 --- a/atomate/vasp/workflows/base/csld.py +++ b/atomate/vasp/workflows/base/csld.py @@ -252,19 +252,16 @@ def get_wf(self, c=None): from pymatgen.symmetry.analyzer import SpacegroupAnalyzer from pymatgen.core.structure import Structure - prim = Structure.from_file('POSCAR-well_relaxed_Si') + prim = Structure.from_file('POSCAR-well_relaxed_KSnBi') - sga = SpacegroupAnalyzer(prim) - prim = sga.get_conventional_standard_structure() - prim.to("poscar", filename="POSCAR-well_relaxed_conventional_Si") + # sga = SpacegroupAnalyzer(prim) + # prim = sga.get_conventional_standard_structure() + # prim.to("poscar", filename="POSCAR-well_relaxed_KSnBi") csld_class = CompressedSensingLatticeDynamicsWF( prim, symmetrize=False, num_nn_dists=6, - num_displacements=2, - min_displacement=0.02, - max_displacement=0.05, supercells_per_displacement_distance=1, force_diagonal_transformation=True, do_shengbte=True, @@ -283,7 +280,7 @@ def get_wf(self, c=None): print("supercell number of atoms") print(csld_class.supercell.num_sites) csld_class.supercell.to("poscar", - filename="SPOSCAR-conventional_Si_diagonal") + filename="SPOSCAR-KSnBi_diagonal") wf = add_tags(wf, ['csld', 'v1', 'rees', 'pre-relaxed conventional si', 'diagonal supercell', diff --git a/atomate/vasp/workflows/tests/test_csld_workflow.py b/atomate/vasp/workflows/tests/test_csld_workflow.py index a50b7a9fa..07471c7ab 100644 --- a/atomate/vasp/workflows/tests/test_csld_workflow.py +++ b/atomate/vasp/workflows/tests/test_csld_workflow.py @@ -3,6 +3,7 @@ from __future__ import division, print_function, unicode_literals, absolute_import import os +from monty.os.path import which import unittest import numpy as np import shutil @@ -24,6 +25,7 @@ __author__ = "Rees Chang" __email__ = "rc564@cornell.edu" +csld_present = which("csld_main") class TestCompressedSensingLatticeDynamicsWorkflow(AtomateTest): @@ -64,7 +66,7 @@ def init(): env_vars=env_vars, shengbte_t_range=shengbte_t_range, shengbte_fworker=shengbte_fworker, - force_diagonal_transformation=True + force_diagonal_transformation=True, ) return csld_firetask @@ -163,6 +165,7 @@ def test_set_params(self): ) shutil.rmtree('Si_supercell_iter0') + @unittest.skipIf(not csld_present, "CSLD not present") def test_run_csld(self): print('hi') From 1a18f0819131bec40b648e339e1bc4ebad03b887 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Wed, 19 Feb 2020 14:40:45 -0800 Subject: [PATCH 050/207] Remove optional requirements --- requirements-optional.txt | 4 ---- 1 file changed, 4 deletions(-) delete mode 100644 requirements-optional.txt diff --git a/requirements-optional.txt b/requirements-optional.txt deleted file mode 100644 index a46c4ef70..000000000 --- a/requirements-optional.txt +++ /dev/null @@ -1,4 +0,0 @@ -nose==1.3.7 -coverage==4.5.3 -coveralls==1.7.0 -f90nml==1.1.2 \ No newline at end of file From 910b33fe25e0a104a4f540ba50d841e1e1fbeb90 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:01:59 -0800 Subject: [PATCH 051/207] Begin refactoring workflow --- .../analysis/{csld.py => lattice_dynamics.py} | 81 ++--- atomate/vasp/workflows/base/csld.py | 297 ------------------ .../vasp/workflows/base/lattice_dynamics.py | 264 ++++++++++++++++ 3 files changed, 306 insertions(+), 336 deletions(-) rename atomate/vasp/analysis/{csld.py => lattice_dynamics.py} (71%) delete mode 100644 atomate/vasp/workflows/base/csld.py create mode 100644 atomate/vasp/workflows/base/lattice_dynamics.py diff --git a/atomate/vasp/analysis/csld.py b/atomate/vasp/analysis/lattice_dynamics.py similarity index 71% rename from atomate/vasp/analysis/csld.py rename to atomate/vasp/analysis/lattice_dynamics.py index 799963108..f0ab19acc 100644 --- a/atomate/vasp/analysis/csld.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -2,59 +2,61 @@ from __future__ import division, print_function, unicode_literals, absolute_import +from typing import Optional, Tuple, List + import numpy as np +from pymatgen import Structure from pymatgen.transformations.standard_transformations import PerturbStructureTransformation -__author__ = 'Rees Chang' -__email__ = 'rc564@cornell.edu' +__author__ = 'Rees Chang, Alex Ganose' +__email__ = 'rc564@cornell.edu, aganose@lbl.gov' -def generate_perturbed_supercells(supercell, - min_displacement=0.01, max_displacement=0.1, - num_displacements=10, - supercells_per_displacement_distance=1, - min_random_distance=None): +def generate_perturbed_supercells( + supercell: Structure, + min_displacement: float = 0.01, + max_displacement: float = 0.1, + num_displacements: int = 10, + n_cells_per_displacement_distance: int = 1, + min_random_distance: Optional[float] = None +) -> Tuple[List[Structure], np.ndarray]: """ Generate a list of supercells with perturbed atomic sites. Args: - supercell (Structure): original structure whose atomic sites are to be - perturbed - max_displacement (float): maximum displacement distance for - perturbing the structure (Angstroms) - min_displacement (float): minimum displacement distance for - perturbing the structure (Angstroms) - num_displacements (int): number of unique displacement distances to - try, uniformly distributed between 'min_displacement' and - 'max_displacement'. - structures_per_displacement_distance (int): number of perturbed + supercell (Structure): Original structure whose atomic sites are to be + perturbed. + max_displacement: Maximum displacement distance for perturbing the + sites in Angstroms. + min_displacement: Minimum displacement distance for perturbing the + sites in Angstroms. + num_displacements: Number of unique displacement distances to + try, uniformly distributed between ``min_displacement`` and + ``max_displacement``. + n_cells_per_displacement_distance: Number of perturbed structures to generate for each unique displacement distance. - min_random_distance (Optional float): If None (default), then for a - given perturbed structure, all atoms will move the same distance - from their original locations. If float, then for a given - perturbed structure, the distances that atoms move will be - uniformly distributed from a minimum distance of - 'min_random_distance' to one of the displacement distances - uniformly sampled between 'min_displacement' and - 'max_displacement'. + min_random_distance: If None (default), then for a given perturbed + structure, all atoms will move the same distance from their original + locations. If float, then for a given perturbed structure, the + distances the atoms move will be uniformly distributed from a + minimum distance of ``min_random_distance`` to one of the + displacement distances uniformly sampled between + ``min_displacement`` and ``max_displacement``. + Returns: - (List of randomly displaced structures (List of Structures), - List of corresponding displacements) + A tuple of the ``(structures, displacements)``. Where ``structures`` is + a list of randomly displaced structures, and ``displacements`` is + the displacement distance for each structure. """ - displacements = np.repeat( - np.linspace(min_displacement, max_displacement, num_displacements), - supercells_per_displacement_distance - ) - # self.min_random_distance = min_random_distance - perturbed_supercells = [] # list of perturbed supercell structures + dists = np.linspace(min_displacement, max_displacement, num_displacements) + displacements = np.repeat(dists, n_cells_per_displacement_distance) + + perturbed_supercells = [] for displacement in displacements: - perturb_structure_transformer = PerturbStructureTransformation( - displacement, - min_random_distance) - perturbed_supercell = perturb_structure_transformer.apply_transformation( - supercell) - perturbed_supercells += [perturbed_supercell] + pst = PerturbStructureTransformation(displacement, min_random_distance) + perturbed_supercells.append(pst.apply_transformation(supercell)) + return perturbed_supercells, displacements @@ -67,6 +69,7 @@ def csld_main(options, settings): - Moved execution files to this main() function to be called from atomate - Rewrote 'add_common_parameter' in 'common_main' to treat 'options' as + a dictionary instead of ArgumentParser """ import matplotlib diff --git a/atomate/vasp/workflows/base/csld.py b/atomate/vasp/workflows/base/csld.py deleted file mode 100644 index dcaaa7b02..000000000 --- a/atomate/vasp/workflows/base/csld.py +++ /dev/null @@ -1,297 +0,0 @@ -# coding: utf-8 - -import numpy as np -from uuid import uuid4 - -from pymatgen.transformations.advanced_transformations import ( - CubicSupercellTransformation) -from pymatgen.io.vasp.sets import MPStaticSet - -from fireworks import Workflow, Firework -from atomate.utils.utils import get_logger -from atomate.vasp.config import VASP_CMD, DB_FILE -from atomate.vasp.fireworks.core import StaticFW -from atomate.vasp.firetasks.parse_outputs import CSLDForceConstantsToDB -from atomate.vasp.powerups import add_additional_fields_to_taskdocs -from atomate.vasp.analysis.csld import generate_perturbed_supercells - -__author__ = "Rees Chang" -__email__ = "rc564@cornell.edu" -__date__ = "July 2019" -__csld_wf_version__ = 1.0 - -logger = get_logger(__name__) - - -class CompressedSensingLatticeDynamicsWF: - """ - This workflow will use compressed sensing lattice dynamics (CSLD) - (doi: 10.1103/PhysRevLett.113.185501) to generate interatomic force - constants from an input structure and output a summary to a database. - - TODO: Implement 'tight_relaxation', 'dfpt_check', and 'nscf_check' options - - A summary of the workflow is as follows: - 1. Transform the input structure into a supercell - 2. Transform the supercell into a list of supercells with all atoms - randomly perturbed from their original sites - 3. Run static VASP calculations on each perturbed supercell to - calculate atomic forces. - 4. Aggregate the forces and conduct the CSLD minimization algorithm - to compute interatomic force constants. - 5. Output the interatomic force constants to the database. - - Args: - parent_structure (Structure): Structure to conduct CSLD on - symmetrize (bool): If True, the parent_structure will be primitized - before running CSLD. Else, the parent_structure will be used - for CSLD as is. - tight_relaxation (bool): If True, run a tight relaxation step on the - parent_structure. Else, do not. TODO: IMPLEMENT - dfpt_check (bool): If True, run a DFPT calculation at the gamma - point to check for dynamic instabilities. TODO: IMPLEMENT - nscf_check (bool): If True, run a nscf electronic bands calculation to - determine if parent_structure is a metal or not. If metal, set - ISMEAR=1 for the static perturbed supercell calculations. Else, set - ISMEAR=0. TODO: IMPLEMENT - symprec (float): symmetry precision parameter for - SpacegroupAnalyzer's 'get_primitive_standard_structure()' - function - min_atoms (int): Minimum number of atoms to constrain the supercell - max_atoms (int): Maximum number of atoms to constrain the supercell - num_nn_dists (int or float): Number of nearest neighbor distances - that the shortest direction of the supercell must be as long as - force_diagonal_transformation (bool): If True, the supercell - transformation will be constrained to have a diagonal - transformation matrix. If False, the supercell transformation - will not be constrained to be diagonal (resulting in a more - cubic supercell). - max_displacement (float): Maximum displacement distance for - perturbing the supercell structure (Angstroms) - min_displacement (float): Minimum displacement distance for - perturbing the supercell structure (Angstroms) - num_displacements (int): Number of unique displacement distances to - generate uniformly between 'min_displacement' and - 'max_displacement' - min_random_distance (Optional float): If None (default), then all - atoms in the supercell will move the same distance from their - original locations. If float, then for a given supercell, the - distances that atoms move will be uniformly distributed from a - minimum distance of 'min_random_distance' to one of the - displacement distances uniformly sampled between - 'min_displacement' and 'max_displacement'. - supercells_per_displacement_distance (int): number of supercells to - generate for each unique displacement distance. - dynamic_static_calcs (bool): If True and CSLD fails to return all real - harmonic phonon frequencies on the first try, then the CSLD firework - will dynamically create more static perturbed supercell calculations - with larger displacements with the aim of handling materials with - loosely bound atoms (e.g. rattling modes). - do_shengbte (bool): If True and CSLD successfully returns all real - harmonic phonon frequencies, then the CSLD firework will dynamically - create a ShengBTE firework for calculating the lattice thermal - conductivity matrix and storing it to a database. - shengbte_t_range (bool): If False (default), calculate the lattice - thermal conductivity with ShengBTE at 300 K. If True, do the - calculation from 100-1000 K with 100 K steps (much slower). - shengbte_fworker (None or str): If None, the ShengBTE firework's - fworker will be set to all the previous fireworks' fworker. If - str, the ShengBTE firework's fworker will be set to - shengbte_fworker. - """ - - def __init__( - self, - parent_structure, - symmetrize=False, - symprec=0.1, - min_atoms=-np.Inf, - max_atoms=np.Inf, - num_nn_dists=5, - force_diagonal_transformation=True, - max_displacement=0.1, - min_displacement=0.01, - num_displacements=10, - min_random_distance=None, - supercells_per_displacement_distance=1, - dynamic_static_calcs=False, - do_shengbte=False, - shengbte_t_range=False, - shengbte_fworker=None - ): - - if force_diagonal_transformation is True and num_nn_dists == 5: - num_nn_dists = 6 - - # default name is CompressedSensingLatticeDynamicsWF - self.uuid = str(uuid4()) - self.wf_meta = { - "wf_uuid": self.uuid, - "wf_name": self.__class__.__name__, - } - - # Create supercell - self.parent_structure = parent_structure - if symmetrize: - sga = SpacegroupAnalyzer(parent_structure, symprec=symprec) - self.parent_structure = sga.get_primitive_standard_structure() - - self.force_diagonal_transformation = force_diagonal_transformation - self.min_atoms = min_atoms - self.max_atoms = max_atoms - self.num_nn_dists = num_nn_dists - supercell_transform = CubicSupercellTransformation( - self.min_atoms, - self.max_atoms, - self.num_nn_dists, - force_diagonal_transformation=self.force_diagonal_transformation - ) - - self.supercell = supercell_transform.apply_transformation( - self.parent_structure) - self.nn_dist = supercell_transform.nn_dist - self.trans_mat = supercell_transform.trans_mat.tolist() - self.supercell_smallest_dim = supercell_transform.smallest_dim - - # Generate list of perturbed supercells - # perturbed_supercells: list of perturbed supercells (list[Structures]) - # disps: list of (non-unique) displacement values used in the - # perturbation (np.array) - self.perturbed_supercells, self.disps = generate_perturbed_supercells( - self.supercell, - min_displacement=min_displacement, - max_displacement=max_displacement, - num_displacements=num_displacements, - supercells_per_displacement_distance=supercells_per_displacement_distance, - min_random_distance=min_random_distance - ) - - self.dynamic_static_calcs = dynamic_static_calcs - self.do_shengbte = do_shengbte - self.shengbte_t_range = shengbte_t_range - self.shengbte_fworker = shengbte_fworker - - def get_wf(self, c=None): - fws = [] - c = c or {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} - - static_user_incar_settings = { - "ADDGRID": True, # Fast Fourier Transform grid - "LCHARG": False, - "ENCUT": 700, - "EDIFF": 1e-8, # may need to tune this - "PREC": 'Accurate', - "LAECHG": False, - "LREAL": False, - "LASPH": True} - static_user_incar_settings.update(c.get("user_incar_settings", {})) - - for idx, perturbed_supercell in enumerate(self.perturbed_supercells): - # Run static calculations on the perturbed supercells to compute - # forces on each atom - name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format( - idx, self.disps[idx]) - - static_vis = MPStaticSet( - perturbed_supercell, - user_incar_settings=static_user_incar_settings) - static_fw = StaticFW( - perturbed_supercell, - vasp_input_set=static_vis, - vasp_cmd=c["VASP_CMD"], - db_file=c["DB_FILE"], - name=name + " static" - ) - static_fw.spec["displacement_value"] = self.disps[idx] - fws.append(static_fw) - - logger.debug("Using {} displacements".format(len(self.disps))) - logger.debug("Displacements: {}".format(self.disps)) - - # Collect force constants from the DB and output on cluster - csld_fw = Firework( - CSLDForceConstantsToDB( - db_file=c["DB_FILE"], - wf_uuid=self.uuid, - parent_structure=self.parent_structure, - trans_mat=self.trans_mat, - supercell_structure=self.supercell, - supercell_smallest_dim=self.supercell_smallest_dim, - perturbed_supercells=self.perturbed_supercells, - disps=self.disps, - force_diagonal_transformation=self.force_diagonal_transformation, - first_pass=True, - static_user_incar_settings=static_user_incar_settings, - env_vars=c, - dynamic_static_calcs=self.dynamic_static_calcs, - do_shengbte=self.do_shengbte, - shengbte_t_range=self.shengbte_t_range, - shengbte_fworker=self.shengbte_fworker - ), - name="Compressed Sensing Lattice Dynamics", - parents=fws[-len(self.perturbed_supercells):] - ) - fws.append(csld_fw) - - formula = self.parent_structure.composition.reduced_formula - wf_name = "{} - compressed sensing lattice dynamics".format(formula) - wf = Workflow(fws, name=wf_name) - - wf = add_additional_fields_to_taskdocs( - wf, {"wf_meta": self.wf_meta}, task_name_constraint="VaspToDb") - - return wf - - -# SCRIPT FOR CREATING THE WORKFLOW AND ADDING IT TO THE DATABASE -if __name__ == "__main__": - - from fireworks import LaunchPad - from atomate.vasp.powerups import add_tags, set_execution_options, \ - add_modify_incar - from pymatgen.symmetry.analyzer import SpacegroupAnalyzer - from pymatgen.core.structure import Structure - - prim = Structure.from_file('POSCAR-well_relaxed_KSnBi') - - # sga = SpacegroupAnalyzer(prim) - # prim = sga.get_conventional_standard_structure() - # prim.to("poscar", filename="POSCAR-well_relaxed_KSnBi") - - csld_class = CompressedSensingLatticeDynamicsWF( - prim, - symmetrize=False, - num_nn_dists=6, - supercells_per_displacement_distance=1, - force_diagonal_transformation=True, - do_shengbte=True, - shengbte_fworker="rees_the_fire_worker_haswell" - ) - print("uuid") - print(csld_class.uuid) - - wf = csld_class.get_wf() - print("trans mat") - print(csld_class.trans_mat) - print("nn dist") - print(csld_class.nn_dist) - print("supercell shortest direction (Angstroms)") - print(csld_class.supercell_smallest_dim) - print("supercell number of atoms") - print(csld_class.supercell.num_sites) - csld_class.supercell.to("poscar", - filename="SPOSCAR-KSnBi_diagonal") - - wf = add_tags(wf, ['csld', 'v1', 'rees', - 'pre-relaxed conventional si', 'diagonal supercell', - 'not symmetrized', 'ismear manually set to 0']) - wf = set_execution_options(wf, fworker_name="rees_the_fire_worker") - wf = add_modify_incar(wf, - modify_incar_params={ - 'incar_update': { - 'ENCUT': 500, - 'ISMEAR': 0, - 'ISPIN': 1}}) - # - # lpad = LaunchPad.auto_load() - # lpad.add_wf(wf) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py new file mode 100644 index 000000000..43321a584 --- /dev/null +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -0,0 +1,264 @@ +# coding: utf-8 +from copy import deepcopy +from typing import List, Dict, Optional + +from uuid import uuid4 + +from pymatgen.transformations.advanced_transformations import ( + CubicSupercellTransformation +) +from pymatgen.io.vasp.sets import MPStaticSet +from pymatgen.core.structure import Structure +from pymatgen.symmetry.analyzer import SpacegroupAnalyzer + +from fireworks import Workflow, Firework +from atomate.utils.utils import get_logger +from atomate.vasp.config import VASP_CMD, DB_FILE +from atomate.vasp.fireworks.core import StaticFW +from atomate.vasp.firetasks.parse_outputs import CSLDForceConstantsToDB +from atomate.vasp.powerups import add_additional_fields_to_taskdocs +from atomate.vasp.analysis.csld import generate_perturbed_supercells + +__author__ = "Rees Chang, Alex Ganose" +__email__ = "rc564@cornell.edu, aganose@lbl.gov" +__date__ = "July 2019" +__csld_wf_version__ = 1.0 + +logger = get_logger(__name__) + +_static_uis = { + "ADDGRID": True, # Fast Fourier Transform grid + "LCHARG": False, + "ENCUT": 700, + "EDIFF": 1e-8, # may need to tune this + "PREC": 'Accurate', + "LAECHG": False, + "LREAL": False, + "LASPH": True +} + +# define shared constants +_MAX_DISPLACEMENT = 0.1 +_MIN_DISPLACEMENT = 0.01 +_NUM_DISPLACEMENTS = 10 +_MIN_RANDOM_DISPLACEMENTS = None +_CELLS_PER_DISPLACEMENT = 1 +_DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} + + +def get_lattice_dynamics_wf( + structure: Structure, + common_settings: Dict = None, + symprec: Optional[float] = None, + min_atoms: Optional[int] = None, + max_atoms: Optional[int] = None, + num_nn_dists: float = 5, + force_diagonal_transformation: bool = True, + max_displacement: float = _MAX_DISPLACEMENT, + min_displacement: float = _MIN_DISPLACEMENT, + num_displacements: int = _NUM_DISPLACEMENTS, + n_cells_per_displacement_distance: int = _CELLS_PER_DISPLACEMENT, + min_random_distance: Optional[float] = _MIN_RANDOM_DISPLACEMENTS, + dynamic_static_calcs: bool = False, + do_shengbte: bool = False, + shengbte_t_range: Optional[List[float]] = None, + shengbte_fworker: Optional[str] = None +): + """ + This workflow will calculate interatomic force constants and vibrational + properties using the hiPhive package. + + A summary of the workflow is as follows: + + 1. Transform the input structure into a supercell + 2. Transform the supercell into a list of supercells with all atoms + randomly perturbed from their original sites + 3. Run static VASP calculations on each perturbed supercell to + calculate atomic forces. + 4. Aggregate the forces and conduct the fit the force constants using + the minimization schemes in hiPhive. + 5. Output the interatomic force constants, and phonon band structure and + density of states to the database. + 6. Optional: Solve the lattice thermal conductivity using ShengBTE. + + Args: + structure: Initial structure. + common_settings: Common settings dict. + symprec: Symmetry precision for symmetrizing the structure. If set to + ``None`` (the default), the structure will not be symmetrized. + min_atoms: Minimum number of atoms to constrain the supercell. + max_atoms: Maximum number of atoms to constrain the supercell. + num_nn_dists: Number of nearest neighbor distances that the shortest + direction of the supercell must be as long as. + force_diagonal_transformation: If True, the supercell + transformation will be constrained to have a diagonal + transformation matrix. If False, the supercell transformation + will not be constrained to be diagonal (resulting in a more + cubic supercell). + max_displacement: Maximum displacement distance for perturbing the + sites in Angstroms. + min_displacement: Minimum displacement distance for perturbing the + sites in Angstroms. + num_displacements: Number of unique displacement distances to + try, uniformly distributed between ``min_displacement`` and + ``max_displacement``. + n_cells_per_displacement_distance: Number of perturbed + structures to generate for each unique displacement distance. + min_random_distance: If None (default), then for a given perturbed + structure, all atoms will move the same distance from their original + locations. If float, then for a given perturbed structure, the + distances the atoms move will be uniformly distributed from a + minimum distance of ``min_random_distance`` to one of the + displacement distances uniformly sampled between + ``min_displacement`` and ``max_displacement``. + dynamic_static_calcs: If True and hiPhive fails to return all real + harmonic phonon frequencies on the first try, then the workflow + will dynamically create more static perturbed supercell + calculations with larger displacements to improve the fitting. + do_shengbte: If True and force constant fitting does not return + imaginary modes, then the workflow will dynamically create a + ShengBTE firework for calculating the lattice thermal conductivity. + shengbte_t_range: A list of temperatures at which to calculate the + lattice thermal conductivity using ShengBTE. If None (default), + then 300 K will be used. + shengbte_fworker: If None, the ShengBTE firework's fworker will be set + to all the previous fireworks' fworker. If str, the ShengBTE + firework's fworker will be set to shengbte_fworker. + """ + common_settings = common_settings or _DEFAULT_SETTINGS + uis = deepcopy(_static_uis) + uis.update(common_settings.get("user_incar_settings", {})) + + if force_diagonal_transformation is True and num_nn_dists == 5: + num_nn_dists = 6 + + if symprec is not None: + sga = SpacegroupAnalyzer(structure, symprec=symprec) + structure = sga.get_primitive_standard_structure() + + st = CubicSupercellTransformation( + min_atoms, + max_atoms, + num_nn_dists, + force_diagonal_transformation=force_diagonal_transformation + ) + supercell = st.apply_transformation(structure) + + perturbed_supercells, disp_dists, fws = get_perturbed_supercell_fws( + supercell, + common_settings, + user_incar_settings=uis, + min_displacement=min_displacement, + max_displacement=max_displacement, + num_displacements=num_displacements, + min_random_distance=min_random_distance, + n_cells_per_displacement_distance=n_cells_per_displacement_distance, + ) + + logger.debug("Using {} displacements".format(len(disp_dists))) + logger.debug("Displacements: {}".format(disp_dists)) + + # Collect force constants from the DB and output on cluster + wf_meta = {"wf_uuid": str(uuid4()), "wf_name": "LatticeDynamicsWF"} + csld_fw = Firework( + CSLDForceConstantsToDB( + db_file=common_settings["DB_FILE"], + wf_uuid=wf_meta["wf_uuid"], + parent_structure=structure, + trans_mat=st.transformation_matrix.tolist(), + supercell_structure=supercell, + perturbed_supercells=perturbed_supercells, + disps=disp_dists, + force_diagonal_transformation=force_diagonal_transformation, + first_pass=True, + static_user_incar_settings=uis, + env_vars=common_settings, + dynamic_static_calcs=dynamic_static_calcs, + do_shengbte=do_shengbte, + shengbte_t_range=shengbte_t_range, + shengbte_fworker=shengbte_fworker + ), + name="Compressed Sensing Lattice Dynamics", + parents=fws[-len(perturbed_supercells):] + ) + fws.append(csld_fw) + + formula = structure.composition.reduced_formula + wf_name = "{} - compressed sensing lattice dynamics".format(formula) + + wf = Workflow(fws, name=wf_name) + wf = add_additional_fields_to_taskdocs( + wf, {"wf_meta": wf_meta}, task_name_constraint="VaspToDb" + ) + + return wf + + +def get_perturbed_supercell_fws( + supercell: Structure, + common_settings: Optional[Dict] = None, + user_incar_settings: Optional[Dict] = None, + max_displacement: float = _MAX_DISPLACEMENT, + min_displacement: float = _MIN_DISPLACEMENT, + num_displacements: int = _NUM_DISPLACEMENTS, + n_cells_per_displacement_distance: int = _CELLS_PER_DISPLACEMENT, + min_random_distance: Optional[float] = _MIN_RANDOM_DISPLACEMENTS, +) -> List[Firework]: + """ + Get static calculations to calculate the forces on each perturbed supercell. + + Args: + supercell: Parent supercell structure. + max_displacement: Maximum displacement distance for perturbing the + sites in Angstroms. + min_displacement: Minimum displacement distance for perturbing the + sites in Angstroms. + num_displacements: Number of unique displacement distances to + try, uniformly distributed between ``min_displacement`` and + ``max_displacement``. + n_cells_per_displacement_distance: Number of perturbed + structures to generate for each unique displacement distance. + min_random_distance: If None (default), then for a given perturbed + structure, all atoms will move the same distance from their original + locations. If float, then for a given perturbed structure, the + distances the atoms move will be uniformly distributed from a + minimum distance of ``min_random_distance`` to one of the + displacement distances uniformly sampled between + ``min_displacement`` and ``max_displacement``. + common_settings: Common settings dict + user_incar_settings: User incar settings override. + + Returns: + A list of static fireworks. + """ + user_incar_settings = user_incar_settings if user_incar_settings else {} + + # Generate list of perturbed supercells + perturbed_supercells, disp_dists = generate_perturbed_supercells( + supercell, + min_displacement=min_displacement, + max_displacement=max_displacement, + num_displacements=num_displacements, + n_cells_per_displacement_distance=n_cells_per_displacement_distance, + min_random_distance=min_random_distance + ) + + fws = [] + data = enumerate(zip(perturbed_supercells, disp_dists)) + for i, (supercell, dist) in data: + name = "perturbed supercell, idx: {}, disp_val: {:.3f} static".format( + i, dist + ) + + vis = MPStaticSet(supercell, user_incar_settings=user_incar_settings) + static_fw = StaticFW( + supercell, + vasp_input_set=vis, + vasp_cmd=common_settings["VASP_CMD"], + db_file=common_settings["DB_FILE"], + name=name + ) + static_fw.spec["displacement_value"] = dist + fws.append(static_fw) + + return fws From a74a2236f1f4c32cef2cb499e558a7994f215414 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:02:55 -0800 Subject: [PATCH 052/207] Remove old firetasks --- atomate/vasp/firetasks/parse_outputs.py | 765 +----------------------- 1 file changed, 11 insertions(+), 754 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 794fecc97..488838577 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1,9 +1,12 @@ +<<<<<<< HEAD +======= +# coding: utf-8 + +>>>>>>> 7a7f01df (Remove old firetasks) import json import os -import shutil import re from collections import defaultdict -from copy import deepcopy from datetime import datetime import numpy as np @@ -13,18 +16,19 @@ from monty.json import MontyEncoder, jsanitize from pydash.objects import has, get -from atomate.vasp.analysis.csld import default_csld_options, \ - default_csld_settings from atomate.vasp.config import DEFUSE_UNSUCCESSFUL >>>>>>> 816883c7 (Cleaned up code (made functions for CSLD firetask, adhered to PEP guidelines, etc.)) from fireworks import FiretaskBase, FWAction, explicit_serialize from fireworks.utilities.fw_serializers import DATETIME_HANDLER <<<<<<< HEAD +<<<<<<< HEAD from monty.json import MontyEncoder, jsanitize from monty.os.path import zpath from pydash.objects import get, has ======= from fireworks import Firework +======= +>>>>>>> 7a7f01df (Remove old firetasks) from pymatgen import Structure >>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) @@ -52,8 +56,11 @@ EnergyTrend from pymatgen.analysis.magnetism import CollinearMagneticStructureAnalyzer, Ordering, magnetic_deformation from pymatgen.command_line.bader_caller import bader_analysis_from_path +<<<<<<< HEAD from pymatgen.io.vasp.sets import MPStaticSet >>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) +======= +>>>>>>> 7a7f01df (Remove old firetasks) from atomate.common.firetasks.glue_tasks import get_calc_loc from atomate.utils.utils import env_chk, get_logger, get_meta_from_structure @@ -1788,756 +1795,6 @@ def split_abc(var, var_name): coll = vaspdb.db["polarization_tasks"] coll.insert_one(polarization_dict) -@explicit_serialize -class CSLDForceConstantsToDB(FiretaskBase): - """ - Used to aggregate atomic forces of perturbed supercells in compressed - sensing lattice dynamics (CSLD) workflow and generate/write interatomic - force constants up to 3rd order to file. The workflow uses a CSLD software - implemented by Zhou et al (https://github.com/LLNL/csld) and modified for - use in atomate (Aug 6, 2019: https://github.com/rees-c/csld). - - TODO: Update this class once Fei's CSLD is modified correctly - TODO: Add to the summary inside 'run_CSLD()' as needed - TODO: Rename this class to something more accurate - - Required parameters: - db_file (str): path to the db file that holds your tasks - collection specifying the database that the perturbed supercell - forces are stored and that CSLD results should be stored to - wf_uuid (str): auto-generated from CompressedSensingLatticeDynamicsWF, - used to make it easier to retrieve task docs - parent_structure (Structure): input (usually primitive) structure on - which CSLD is being done - perturbed_supercells (list of Structures): list of perturbed supercell - structures auto-generated from CompressedSensingLatticeDynamicsWF - trans_mat (3x3 nested list): supercell transformation matrix auto- - generated from CompressedSensingLatticeDynamicsWF - supercell_structure (Structure): supercell structure of parent_structure - auto-generated from CompressedSensingLatticeDynamicsWF - supercell_smallest_dim (float): length of shortest direction of the - supercell lattice, auto-generated from - CompressedSensingLatticeDynamicsWF - disps (list of floats): displacement values corresponding to - perturbed_supercells, auto-generated from - CompressedSensingLatticeDynamicsWF - force_diagonal_transformation (bool): Whether the transformation matrix - used to generate the supercell was diagonal (True) or not (False) - first_pass (boolean): indicator of whether this firetask has already - been attempted or if it is automatically running a second time - with larger perturbations - static_user_incar_settings (dict): incar settings used in static - calculations in CompressedSensingLatticeDynamicsWF - env_vars (dict): environmental variables used in static calculations in - CompressedSensingLatticeDynamicsWF - - Optional parameters: - dynamic_static_calcs (bool): If True, dynamically create more static - perturbed supercell calculations with larger displacements if CSLD - fails. Default: False. - do_shengbte (bool): If True, dynamically create a ShengBTE firework - for computing lattice thermal conductivity if CSLD yields a good - solution. Default: False. - shengbte_t_range (bool): If True, pass to the ShengBTEToDB firetask - that lattice thermal conductivity should be calculated for 100 K to - 1000 K in steps of 100 K. If False (default), only calculate at - 300 K. - shengbte_fworker (str): If None (default), set the ShengBTE fworker to - the previous f_worker. Else, set it to the specified fworker - (allowing the user to run ShengBTE with different Fireworks - configurations than used to run the VASP static calculations). - """ - - logger = get_logger(__name__) - - required_params = [ - "db_file", "wf_uuid", "parent_structure", - "perturbed_supercells", "trans_mat", "supercell_structure", - "supercell_smallest_dim", "disps", "force_diagonal_transformation", - "first_pass", "static_user_incar_settings", "env_vars" - ] - - optional_params = [ - "dynamic_static_calcs", "do_shengbte", "shengbte_t_range", - "shengbte_fworker" - ] - - @staticmethod - def random_search(max_iter): - """ - Generates a tuple of cluster diameter, max order, and submodel1 input - settings for CSLD using a random search. The length of each returned - list of settings is the number of total settings to try. - - Args: - max_iter (int): Number of settings to try - - Returns: - cluster_diam_settings (list[str]): List of cluster diameter settings - max_order_settings (list[int]): List of max order settings - submodel1_settings (list[str]): List of submodel1 settings - """ - import random - - if max_iter % 2 != 0 or max_iter <= 0: - raise AttributeError('maxIter must be even.') - - cluster_diam_settings = [] - for _ in range(max_iter): - pair_diam = random.uniform(8, 12) #self["supercell_smallest_dim"]) - triplet_diam = random.uniform(5.5, 7) - quadruplet_diam = random.uniform(triplet_diam * 0.6, triplet_diam) - - cluster_diam_settings += [ - str(pair_diam) + ' ' + str(triplet_diam) + ' ' + str( - quadruplet_diam)] - - max_order_settings = [3] * int(max_iter / 2) + [4] * int(max_iter / 2) - submodel1_settings = ['anh 0 1 2 3'] * int(max_iter / 2) + \ - ['anh 0 1 2 3 4'] * int(max_iter / 2) - - return cluster_diam_settings, max_order_settings, submodel1_settings - - def collect_successful_static_calcs_results(self, tasks): - """ - Search a database's tasks collection for successful static calculations - and return a list of forces for each supercell - - Args: - tasks (MongoDB collection): MongoDB collection containing static - perturbed supercells calculations - - Returns: - supercells_forces (list[np.array]): List of forces for each - successful static perturbed supercell calculation - successful_disps (list[float]): List of displacement distances for - each successful static perturbed supercell calculation - """ - uuid = self["wf_uuid"] - formula_pretty = self[ - "parent_structure"].composition.reduced_formula - task_label = 'static' - supercells_dicts = list( - tasks.find({"wf_meta.wf_uuid": uuid, - "task_label": {"$regex": task_label}, - "formula_pretty": formula_pretty, - "state": 'successful'}, - ['task_id', - 'task_label', - 'output.forces'])) - # list of dicts where each dict contains a task_id and a list of forces - # for each supercell - - supercells_forces = [] - supercells_task_labels = [] - successful_disps = [] # displacement values of successful static calcs - for supercell_dict in supercells_dicts: - # List of np.ndarrays where each np.ndarray is a matrix of forces - # for a perturbed supercell - supercells_forces += [ - np.asarray(supercell_dict['output']['forces'])] - - # Supercell task labels - # e.g. 'InSb-perturbed supercell, idx: 0, disp_val: 0.010, static' - supercells_task_labels += [supercell_dict['task_label']] - - # Store list of displacement values whose corresponding perturbed - # supercells successfully ran - successful_disp = re.search('disp_val: (\d+.\d+)', - supercell_dict['task_label']) - successful_disps += [successful_disp.group(1)] - - # Sort the forces by their task label so CSLD correctly matches forces - # with their corresponding perturbed supercell - supercells_zip = sorted( - zip(supercells_task_labels, supercells_forces), - key=lambda pair: pair[0]) - supercells_forces = [supercells_forces for - (supercells_task_labels, supercells_forces) in - supercells_zip] - - return supercells_forces, successful_disps - - def set_params(self, iteration_number, disps, cluster_diam, - max_order, submodel1, export_sbte, supercells_forces, - **kwargs): - """ - This function deals with creating all the files, directories, and input - parameters necessary for running CSLD. - - Specifically, it will save the transformation matrix (sc.txt) and parent - structure (POSCAR) in the current directory, create a folder for the - current iteration (e.g. Si_supercell_iter0) with subdirectories - (e.g. 'disp0.010') for each perturbed supercell. POSCARs of each - perturbed supercell is written inside the corresponding subdirectory. - Next, all of CSLD's input parameters are automatically generated in a - format readable by CSLD and then saved to the class' dictionary. - - Args: - disps (list of str or floats): list of displacement distances for - perturbed supercells that ran successfully - iteration_number (int): current iteration (0-indexed) of the CSLD - grid or random search - cluster_diam (str): Space-separated string containing the spherical - length cutoffs for pair, triplet, and quadruplet interactions - for CSLD (e.g. '11 6.5 5.0') - max_order (int): Max order of interatomic force constants to - consider (up to 6th order) - submodel1 (str): Anharmonicity orders to consider (e.g. - 'anh 0 1 2 3') - export_sbte (str): Space-separated parameters for exporting CSLD's - interatomic force constants into a format readable by ShengBTE. - The first 3 numbers are the size of the supercell for which - interatomic force constants are exported. The next numbers are - the force constant orders to consider. E.g. To output 2nd and - 3rd order force constants for a 5x5x5 supercell, the - corresponding string must be '5 5 5 2 3'. - supercells_forces (list[np.array]): List of numpy arrays containing - forces for each static perturbed supercell calculation - kwargs: Any other CSLD settings that the user desires to update - from the default values (as found in atomate.vasp.analysis.csld) - """ - from configparser import ConfigParser - supercell_folder = self["parent_structure"].composition.reduced_formula + \ - "_supercell_iter" + str(iteration_number) - - # Remove supercell_folder if it already exists, then make a new one - if os.path.exists(supercell_folder) and os.path.isdir(supercell_folder): - shutil.rmtree(supercell_folder) - os.mkdir(supercell_folder) - - # Save transformation matrix, supercell POSCAR, and parent structure - # POSCAR to file - np.savetxt(supercell_folder + "/sc.txt", self["trans_mat"], fmt="%.0f", - delimiter=" ") - self["supercell_structure"].to("poscar", - filename=supercell_folder + "/SPOSCAR") - self["parent_structure"].to("poscar", - filename=supercell_folder + "/POSCAR") - - # Create folders for perturbed supercell POSCARS and force.txt's - # (e.g. "Si_supercell_iter0/disp0.010") - disp_folders = [] - csld_traindat_disp_folders = '' - for idx, disp in enumerate(disps): - disp_folder = supercell_folder + '/disp{:.2f}'.format(float(disp)) - disp_folders += [disp_folder] # list of folder paths - csld_traindat_disp_folders += ' ' + str(disp_folder) - if os.path.exists(disp_folder) and os.path.isdir(disp_folder): - shutil.rmtree(disp_folder) - os.mkdir(disp_folder) - self["perturbed_supercells"][idx].to("poscar", - filename=disp_folder + "/POSCAR") - - # training>traindat1 setting for CSLD input - csld_traindat_string = supercell_folder + '/SPOSCAR' - csld_traindat_string += csld_traindat_disp_folders - - # Create ConfigParser of all CSLD input settings - csld_settings_dict = deepcopy(default_csld_settings) - - # Update default settings if specified - user_csld_settings = kwargs - if user_csld_settings is not None: - # recursively update settings dict - for k, v in user_csld_settings: - csld_settings_dict[k].update(v) - - # update CSLD settings with dynamic options - # original structure poscar - csld_settings_dict["structure"]["prim"] = supercell_folder + '/POSCAR' - csld_settings_dict["model"].update({ - 'max_order': max_order, - 'cluster_diameter': cluster_diam, - 'cluster_filter': - r"lambda cls: ((cls.order_uniq <= 2) or (cls.bond_counts(2.9) " - r">= 2)) and cls.is_small_in('" + supercell_folder + "/sc.txt')" - }) - - # directories of unperturbed followed by perturbed supercell poscars - # e.g., 'Si_supercell_iter0/SPOSCAR Si_supercell_iter0/disp0.01 - # Si_supercell_iter0/disp0.05' - csld_settings_dict["training"]['traindat1'] = csld_traindat_string - csld_settings_dict['fitting']['submodel1'] = submodel1 - - # e.g., '5 5 5 2 3' is a 5x5x5 supercell - csld_settings_dict['export_potential'] = {'export_shengbte': - export_sbte} - - csld_settings = ConfigParser() - csld_settings.read_dict(csld_settings_dict) - csld_options = deepcopy(default_csld_options) - - self["csld_settings"] = csld_settings - self["csld_options"] = csld_options - self["forces_paths"] = disp_folders # Paths to perturbed supercell folders - - # Create force.txt files for perturbed supercells - for supercell_idx, supercell_force in enumerate(supercells_forces): - path = self["forces_paths"][supercell_idx] - np.savetxt(path + "/force.txt", supercell_force, fmt='%.6f') - - def run_csld(self, iter): - """ - Run CSLD, check for imaginary frequencies, and generate a summary of the - results. - - Args: - iter (int): Current iteration of the grid/random search over CSLD - input parameters (0-indexed) - Return: - summary (dict): Summary of the results from CSLD - """ - # Perform csld minimization now - logger.info("Running CSLD...") - from atomate.vasp.analysis.csld import csld_main - rel_err, freq_matrix = csld_main(self["csld_options"], - self["csld_settings"]) - - freq_matrix = np.asarray(freq_matrix) - - # CHECK FOR IMAGINARY PHONON MODES - # For imaginary frequencies, w^2 is negative. - # CSLD handles these as w = sign(sqrt(abs(w^2)), w^2). - # i.e. if w < 0, it is imaginary. - # Here, we consider phonon frequencies < -1 meV to be imaginary - # (numerical noise can sometimes make frequencies slightly negative, - # so we ignore these) - imaginary_idx = freq_matrix < -1 - imaginary_freqs = freq_matrix[imaginary_idx] - logger.info('IMAGINARY FREQUENCIES: \n{}'.format(imaginary_freqs)) - num_imaginary_bands = np.sum(np.any(imaginary_idx, axis=1)) - logger.info('Number of imaginary bands: {}'.format(num_imaginary_bands)) - if np.any(imaginary_freqs): - most_imaginary_freq = np.amin(imaginary_freqs) - else: - most_imaginary_freq = 0 - print(most_imaginary_freq) - - if num_imaginary_bands == 0: - not_converged = False - - # Save to DB - summary = { - "date": datetime.now(), - "formula": self["parent_structure"].formula, - "formula_pretty": self[ - "parent_structure"].composition.reduced_formula, - "parent_structure": self["parent_structure"].as_dict(), - "supercell_structure": self["supercell_structure"].as_dict(), - "supercell_transformation_matrix": self["trans_mat"], - "wf_meta": {"wf_uuid": self["wf_uuid"]}, - - # Store relevant CSLD settings - "iteration": iter, - "cluster_diam": self["csld_settings"]["model"][ - "cluster_diameter"], - "max_order": self["csld_settings"]["model"]["max_order"], - "submodel1": self["csld_settings"]["fitting"]["submodel1"], - "export_potential": self["csld_settings"]["export_potential"][ - "export_shengbte"], - - # Store CSLD results - "cross_val_error": float(rel_err), - "num_imaginary_modes": int(num_imaginary_bands), - "most_imaginary_freq": float(most_imaginary_freq), - "imaginary_freq_sum": float(sum(imaginary_freqs)) - } - - # Store latest CSLD input settings tried - # TODO: If desired, store this information in a database to keep - # track of what settings work and what doesn't for different materials - latest_settings = {str(self["convergence_info"]["iteration"]): - {self["csld_settings"]["model"]["max_order"], - self["csld_settings"]["fitting"][ - "submodel1"], - self["csld_settings"]["export_potential"][ - "export_shengbte"]}} - self["convergence_info"]["iteration"] = iter - self["convergence_info"]["settings_tried"] += [latest_settings] - self["convergence_info"]["cross_val_errors"] += [rel_err] - self["convergence_info"]["most_imaginary_freqs"] += [ - most_imaginary_freq] - self["convergence_info"]["imaginary_freqs_sum"] += [ - sum(imaginary_freqs)] - - return summary - - def add_sbte_fw(self, fw_spec): - """ - This function dynamically creates a ShengBTE firework for calculating - the lattice thermal conductivity matrix. - - Args: - fw_spec (dict): The fw_spec for the CSLD firework. - - Returns: - FWAction: Dynamically adds a ShengBTE Firework to the workflow - """ - shengbte_fw = Firework( - ShengBTEToDB( - parent_structure=self["parent_structure"], - shengbte_cmd=">>shengbte_cmd<<", - db_file=self["db_file"], - wf_uuid=self["wf_uuid"], - t_range=self.get("shengbte_t_range", False), - trans_mat=self["trans_mat"] - ), - name="ShengBTE for Lattice Thermal Conductivity" - ) - - # Set the ShengBTE fworker - if isinstance(self["shengbte_fworker"], str): - shengbte_fw.spec["_fworker"] = self["shengbte_fworker"] - else: - shengbte_fw.spec["_fworker"] = fw_spec.get("_fworker", None) - - # Pass the CSLD launcher path to the ShengBTE FW - CSLD_path = self.get("path", os.getcwd()) - shengbte_fw.spec["successful_CSLD_path"] = CSLD_path - - # Add tags - if fw_spec.get("tags", None): - shengbte_fw.spec["tags"] = fw_spec["tags"] - - return FWAction(additions=shengbte_fw) - - def add_more_static_calcs(self, successful_disps, fw_spec): - """ - This function will dynamically create more static perturbed supercell - calculations with displacement distances of 0.12, 0.14, 0.16, 0.18, and - 0.20, and also append another CSLD Firework. A 'first_pass=False' - argument will be passed into the CSLD Firework to ensure that more - static perturbed supercell calculations will not be created. - - Args: - successful_disps (list[float]): List of displacement distances of - previous successful static perturbed supercell calculations - fw_spec (dict): Firework spec of the first CSLD Firework - - Returns: - FWAction: Dynamically adds a more static calculations and a CSLD - Firework to the workflow - """ - - new_fws = [] - - # Create new perturbed supercells - from atomate.vasp.analysis.csld import generate_perturbed_supercells - more_perturbed_supercells, more_disps = generate_perturbed_supercells( - self["supercell_structure"], - min_displacement=0.12, - max_displacement=0.2, - num_displacements=5 - ) - - # Create new static FWs - for idx, more_perturbed_supercell in enumerate( - more_perturbed_supercells): - name = "perturbed supercell, idx: {}, disp_val: {:.3f},".format( - idx + len(self["perturbed_supercells"]), - more_disps) - static_vis = MPStaticSet(more_perturbed_supercell, - user_incar_settings=self[ - "static_user_incar_settings"]) - - from atomate.vasp.fireworks.core import StaticFW - new_static_fw = StaticFW( - more_perturbed_supercell, - vasp_input_set=static_vis, - vasp_cmd=self["env_vars"]["VASP_CMD"], - db_file=self["env_vars"]["DB_FILE"], - name=name + " static" - ) - new_static_fw.spec["_fworker"] = fw_spec["_fworker"] - new_static_fw.spec["displacement_value"] = more_disps[idx] - if fw_spec.get("tags", None): - new_static_fw.spec["tags"] = fw_spec["tags"] - new_fws.append(new_static_fw) - - # Create new CSLD FW - # static_user_incar_settings and env_vars can be None since we - # are done trying more static calculations. - new_csld_fw = Firework( - CSLDForceConstantsToDB( - db_file=self["env_vars"]["DB_FILE"], - wf_uuid=self["wf_uuid"], - name='CSLDForceConstantsToDB', - parent_structure=self["parent_structure"], - trans_mat=self["trans_mat"], - supercell_structure=self["supercell_structure"], - supercell_smallest_dim=self["supercell_smallest_dim"], - perturbed_supercells=self[ - "perturbed_supercells"] + more_perturbed_supercells, - disps=successful_disps + more_disps, - force_diagonal_transformation=self.force_diagonal_transformation, - first_pass=False, - do_shengbte=self.get("do_shengbte", False), - shengbte_t_range=self.get("shengbte_t_range", False), - shengbte_fworker=self.get("shengbte_fworker", None), - static_user_incar_settings=None, - env_vars=None - ), - name="Compressed Sensing Lattice Dynamics", - parents=new_fws[-len(more_perturbed_supercells):] - ) - new_csld_fw.spec["_fworker"] = fw_spec.get("_fworker", None) - if fw_spec.get("tags", None): - new_csld_fw.spec["tags"] = fw_spec["tags"] - new_fws.append(new_csld_fw) - - # Dynamically add new fireworks to the workflow - return FWAction(additions=new_fws) - - def run_task(self, fw_spec): - # Connect to the database - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - tasks = mmdb.collection - - # Store information related to convergence of CSLD - iteration = 0 - not_converged = True - max_iter = 2 - summaries = [] - self['convergence_info'] = { - 'iteration': iteration, - 'settings_tried': [], - 'cross_val_errors': [], - 'most_imaginary_freqs': [], - 'imaginary_freqs_sum': [] - } - - # Set list of parameter settings to try (i.e. grid search settings) - # TODO: FILL THESE IN FURTHER WITH SETTINGS TO TRY, IN THE ORDER YOU WANT - # TO TRY THEM. (May want to generate this with a grid search, depending - # on what settings seem to work on many materials) - cluster_diam_settings = ['11 6.5 5.0', - '9 6.5 5.0'] - max_order_settings = [3] * len(cluster_diam_settings) - submodel1_settings = ['anh 0 1 2 3'] * len(cluster_diam_settings) - if self["force_diagonal_transformation"]: - export_sbte_string = str(self["trans_mat"][0][0]) + ' ' + \ - str(self["trans_mat"][1][1]) + ' ' + \ - str(self["trans_mat"][2][2]) + ' 2 3' - else: - export_sbte_string = '5 5 5 2 3' - export_sbte_settings = [export_sbte_string] * len(cluster_diam_settings) - if self["first_pass"] is False: - # If we are running CSLD a second time (i.e. with larger displaced - # supercells, then duplicate all the settings to try with 4th order - # instead of 3rd order anharmonicity - max_order_settings += [4] * len(cluster_diam_settings) - cluster_diam_settings += cluster_diam_settings - submodel1_settings += submodel1_settings - export_sbte_settings += export_sbte_settings - - logger.info('Cluster diameter settings to search over: ' - '{}'.format(cluster_diam_settings)) - logger.info('Max order settings to search over: ' - '{}'.format(max_order_settings)) - logger.info('"submodel1" settings to search over: ' - '{}'.format(submodel1_settings)) - - # Collect forces and successful displacement values from static - # perturbed supercell calculations - supercells_forces, successful_disps = \ - self.collect_successful_static_calcs_results(tasks) - - # Iterate over CSLD settings until real solutions are found or max - # iterations is reached. - while not_converged and iteration < max_iter: - # For the current iteration, set the CSLD parameters and create the - # necessary folders/files - self.set_params(iteration, - successful_disps, - cluster_diam_settings[iteration], - max_order_settings[iteration], - submodel1_settings[iteration], - export_sbte_settings[iteration], - supercells_forces) - self["csld_options"]["pdfout"] = 'plots' + str(iteration) + '.pdf' - - # Run CSLD, check for imaginary phonon frequencies, and generate a - # summary of results - summary = self.run_csld(iteration) - - if fw_spec.get("tags", None): - summary["tags"] = fw_spec["tags"] - summaries.append(summary) - - iteration += 1 - - # Store the summaries in a "compressed_sensing_lattice_dynamics" - # collection of the database (if it does not exist, it will be created) - mmdb.collection = mmdb.db["compressed_sensing_lattice_dynamics"] - mmdb.collection.insert(summaries) - - # Output lowest validation error and corresponding CSLD input settings - best_idx = self["convergence_info"]["cross_val_errors"].index( - min(self["convergence_info"]["cross_val_errors"])) - logger.info("The lowest error was {} percent.".format( - min(self["convergence_info"]["cross_val_errors"]))) - logger.info("The corresponding settings were: {}".format( - self["convergence_info"]["settings_tried"][best_idx])) - - if not_converged is False: - # If CSLD converged to 0 imaginary frequencies - logger.info("Compressed Sensing Lattice Dynamics calculation " - "complete.") - - # Dynamically create the ShengBTE Firework - if self.get("do_shengbte", False): - self.add_sbte_fw(fw_spec) - else: - logger.info("Compressed Sensing Lattice Dynamics calculation " - "failed. Max iterations was reached.") - if self["parent_structure"].num_sites > 5 and self["first_pass"] \ - and self.get("dynamic_static_calcs", False): - logger.info("Compressed Sensing Lattice Dynamics calculation " - "failed. Max iterations was reached. Creating " - "larger displacements and trying again.") - - self.add_more_static_calcs(successful_disps, fw_spec) - - else: - raise TimeoutError("The workflow was unable to find a solution " - "to CSLD for this material.") - -@explicit_serialize -class ShengBTEToDB(FiretaskBase): - #TODO: Rename this class to something more accurate (since this class only - # calculates the lattice thermal conductivity matrix even though ShengBTE - # has more capabilities) - """ - Run ShengBTE and output the lattice thermal conductivity matrix to database. - - Required parameters: - parent_structure (Structure): material that ShengBTE is being run on - db_file (str): path to the db file that holds your tasks - collection specifying the database that ShengBTE results should be - stored to - shengbte_cmd (str): should be set to "<>" - wf_uuid (str): passed from the CSLDForceConstantsToDB firetask, - used for storing task docs - Optional parameters: - t_range (bool): If True, run lattice thermal conductivity calculations - at 100 K through 1000 K at steps of 100 K. - """ - - required_params = ["parent_structure", "shengbte_cmd", "db_file", - "wf_uuid", "trans_mat", "force_diagonal_transformation"] - optional_params = ["t_range"] - - def run_task(self, fw_spec): - from atomate.utils.utils import env_chk - import subprocess - from pymatgen.io.vasp.inputs import Kpoints - import six - import shlex - - # Generate CONTROL file (a FORTRAN input file for ShengBTE) - from pymatgen.io.shengbte import Control - qpts = Kpoints.automatic_density(self["parent_structure"], 50000) - unique_elements = [ - str(self["parent_structure"].types_of_specie[i]) - for i in range(len(self["parent_structure"].types_of_specie)) - ] - nonunique_elements_list = [ - str(self["parent_structure"].species[i]) - for i in range(len(self["parent_structure"].species)) - ] - element_to_number = {ele: idx + 1 for (idx, ele) in - enumerate(unique_elements)} - shengbte_control_dict = { - 'nelements': self["parent_structure"].ntypesp, - 'natoms': self["parent_structure"].num_sites, - 'ngrid': qpts.kpts[0], - 'norientations': 0, - - 'lfactor': 0.1, # 0.1 nm = 1 Ang - 'lattvec': self["parent_structure"].lattice.matrix.tolist(), - 'elements': unique_elements, - 'types': [element_to_number[ele] for ele in - nonunique_elements_list], - 'positions': [ - self["parent_structure"].sites[i]._frac_coords.tolist() - for i in range(self["parent_structure"].num_sites) - ], - 't': 300, - 'scalebroad': 0.5, - 'nonanalytic': False, - 'isotopes': False, - } - if self["force_diagonal_transformation"]: - shengbte_control_dict['scell'] = [self["trans_mat"][0][0], - self["trans_mat"][1][1], - self["trans_mat"][2][2]] - else: - shengbte_control_dict['scell'] = [5, 5, 5] - if self["t_range"]: - shengbte_control_dict['t_min'] = 100 - shengbte_control_dict['t_max'] = 1000 - shengbte_control_dict['t_step'] = 100 - io = Control.from_dict(shengbte_control_dict) - io.to_file() # writes CONTROL file to current directory - - # Copy force constants from previous CSLD firework - force_constants_path = fw_spec["successful_CSLD_path"] - shutil.copy(force_constants_path+"/FORCE_CONSTANTS_2ND", os.getcwd()) - shutil.copy(force_constants_path+"/FORCE_CONSTANTS_3RD", os.getcwd()) - - # Run ShengBTE - shengbte_cmd = env_chk(self["shengbte_cmd"], fw_spec) - if isinstance(shengbte_cmd, six.string_types): - shengbte_cmd = os.path.expandvars(shengbte_cmd) - shengbte_cmd = shlex.split(shengbte_cmd) - shengbte_cmd = list(shengbte_cmd) - logger.info("Running command: {}".format(shengbte_cmd)) - with open("shengbte.out", 'w') as f_std, \ - open("shengbte_err.txt", "w", buffering=1) as f_err: - # use line buffering for stderr - return_code = subprocess.call(shengbte_cmd, stdout=f_std, stderr=f_err) - logger.info("Command {} finished running " - "with returncode: {}".format(shengbte_cmd, return_code)) - if return_code==1: - raise RuntimeError("Running ShengBTE failed. Check " - "'shengbte_err.txt' in the launch_dir for " - "details.") - - try: - # Store lattice thermal conductivity matrix in the database - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - if self["t_range"]: - temps = np.linspace(100, 1000, 10) - else: - temps = [300] - - # Save to DB - summaries = [] - for temp in temps: - # xx, xy, xz, yx, yy, yz, zx, zy, zz - flattened_kappa = np.loadtxt( - 'T'+str(int(temp))+'K/BTE.kappa_tensor')[1][1:] - flattened_kappa = flattened_kappa.reshape((3, 3)).tolist() - summary = { - "date": datetime.now(), - "temperature": temp, - "parent_structure": self["parent_structure"].as_dict(), - "wf_meta": {"wf_uuid": self["wf_uuid"]}, - str(temp)+" K": {"flattened_kappa": flattened_kappa} - } - if fw_spec.get("tags", None): - summary["tags"] = fw_spec["tags"] - summaries.append(summary) - - mmdb.collection = mmdb.db["sheng_bte"] - mmdb.collection.insert(summaries) - except: - raise FileNotFoundError('BTE.kappa_tensor was not output from ' - 'ShengBTE.') - # the following definitions for backward compatibility class VaspToDbTask(VaspToDb): From 1a4bb22c7a8b04be27b8b9ad59ada27659177b34 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:03:14 -0800 Subject: [PATCH 053/207] Add ShengBTE command to config --- atomate/vasp/config.py | 1 + 1 file changed, 1 insertion(+) diff --git a/atomate/vasp/config.py b/atomate/vasp/config.py index 8a842d353..d5285726a 100644 --- a/atomate/vasp/config.py +++ b/atomate/vasp/config.py @@ -11,6 +11,7 @@ VASP_CMD = ">>vasp_cmd<<" VDW_KERNEL_DIR = ">>vdw_kernel_dir<<" DB_FILE = ">>db_file<<" +SHENGBTE_CMD = ">>shengbte_cmd<<" ADD_WF_METADATA = True LOBSTER_CMD = ">>lobster_cmd<<" From 1db2992f6c587848b9387eb3908c7520c2ec7923 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:04:01 -0800 Subject: [PATCH 054/207] Add first pass at lattice_dynamics firetasks --- atomate/vasp/firetasks/lattice_dynamics.py | 437 +++++++++++++++++++++ 1 file changed, 437 insertions(+) create mode 100644 atomate/vasp/firetasks/lattice_dynamics.py diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py new file mode 100644 index 000000000..e99e21671 --- /dev/null +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -0,0 +1,437 @@ +import os +import shlex + +from pathlib import Path + +from uuid import uuid4 + +from datetime import datetime + +from monty.serialization import dumpfn, loadfn +from monty.dev import requires + +from atomate.utils.utils import get_logger, env_chk +from atomate.vasp.analysis.lattice_dynamics import ( + fit_force_constants, + get_cutoffs, +) +from atomate.vasp.analysis.phonopy import ( + get_phonon_dos, + get_phonon_band_structure, + get_line_mode_phonon_band_structure, +) +from atomate.vasp.database import VaspCalcDb +from atomate.vasp.workflows.base.lattice_dynamics import ( + MAX_N_IMAGINARY, + MAX_IMAGINARY_FREQ, + IMAGINARY_TOL, + FIT_METHOD, + DEFAULT_TEMPERATURE, + MESH_DENSITY) +from fireworks import explicit_serialize, FiretaskBase, FWAction +import numpy as np + +from pymatgen import Structure +from pymatgen.io.ase import AseAtomsAdaptor +from pymatgen.io.shengbte import Control +from pymatgen.transformations.standard_transformations import ( + SupercellTransformation, +) + +try: + import hiphive +except ImportError: + hiphive = False + + +__author__ = "Alex Ganose" +__email__ = "aganose@lbl.gov" + +logger = get_logger(__name__) + + +@explicit_serialize +class CollectPerturbedStructures(FiretaskBase): + """ + Aggregate the structures and forces of perturbed supercells. Requires a + wf_uuid from which all perturbed static calculations will be compiled. The + initial structure and supercell transformation matrix will be extracted from + the perturbed structure tasks. + + Required parameters: + db_file (str): Path to DB file for the database that contains the + perturbed structure calculations. + wf_uuid (str): Workflow unique identifier. + """ + + required_params = ["db_file", "wf_uuid"] + + def run_task(self, fw_spec): + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + tasks = mmdb.collection + + query = { + "wf_meta.wf_uuid": self["wf_uuid"], + "task_label": {"$regex": "perturbed static"}, + "state": "successful", + } + projection = ["output.structure", "output.forces", "transformations"] + + logger.info("Fetching structure and forces data") + results = list(tasks.find(query, projection)) + + logger.info("Found {} perturbed structures".format(len(results))) + all_structures = [] + all_forces = [] + for result in results: + structure = Structure.from_dict(result["output"]["structure"]) + forces = np.asarray(result["output"]["forces"]) + all_structures.append(structure) + all_forces.append(forces) + + if len(all_structures) == 0: + raise RuntimeError( + "Could not find any perturbed structures for workflow uuid: " + "{}".format(self["wf_uuid"]) + ) + else: + transformation = results[-1]["transformations"][0] + t_class = transformation["@class"] + if t_class != "SupercellTransformation": + raise ValueError( + "Expecting SupercellTransformation not {}".format(t_class) + ) + structure = Structure.from_dict(transformation["input_structure"]) + supercell_matrix = transformation["deformation"] + + # regenerate pure supercell structure + st = SupercellTransformation(supercell_matrix) + supercell_structure = st.apply_transformation(structure) + + structure_data = { + "structure": structure, + "supercell_structure": supercell_structure, + "supercell_matrix": supercell_matrix, + } + + logger.info("Writing structure and forces data.") + dumpfn(all_structures, "perturbed_structures.json") + dumpfn(all_forces, "perturbed_forces.json") + dumpfn(structure_data, "structure_data.json") + + +@requires(hiphive, "hiphive is required for lattice dynamics workflow") +@explicit_serialize +class FitForceConstants(FiretaskBase): + """ + Used to aggregate atomic forces of perturbed supercells in and fit + force constants using hiPhive. Requires "perturbed_structures.json", + "perturbed_forces.json", and "structure_data.json" files to be present + in the current working directory. + + Optional parameters: + cutoffs (Optional[list[list]]): A list of cutoffs to trial. If None, + a set of trial cutoffs will be generated based on the structure + (default). + imaginary_tol (float): Tolerance used to decide if a phonon mode + is imaginary, in THz. + max_n_imaginary (int): Maximum number of imaginary modes allowed in the + the final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + max_imaginary_freq (float): Maximum allowed imaginary frequency in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + fit_method (str): Method used for fitting force constants. This can be + any of the values allowed by the hiphive ``Optimizer`` class. + """ + + optional_params = [ + "cutoffs", + "imaginary_tol", + "max_n_imaginary", + "max_imaginary_freq", + "fit_method", + ] + + def run_task(self, fw_spec): + from hiphive.utilities import get_displacements + + max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) + max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) + imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) + fit_method = self.get("fit_method", FIT_METHOD) + + all_structures = loadfn("perturbed_structures.json") + all_forces = loadfn("all_forces.json") + structure_data = loadfn("structure_data.json") + parent_structure = structure_data["structure"] + supercell_matrix = structure_data["supercell_matrix"] + supercell_structure = structure_data["supercell_structure"] + + structures = [] + supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) + for structure, forces in zip(all_structures, all_forces): + atoms = AseAtomsAdaptor.get_atoms(structure) + displacements = get_displacements(atoms, supercell_atoms) + structure.new_array("displacements", displacements) + structure.new_array("forces", forces) + structure.positions = supercell_atoms.get_positions() + structures.append(structure) + + cutoffs = self.get("cutoffs", get_cutoffs(supercell_structure)) + force_constants, fitting_data = fit_force_constants( + parent_structure, + supercell_matrix, + structures, + cutoffs, + imaginary_tol, + max_n_imaginary, + max_imaginary_freq, + fit_method, + ) + + dumpfn(fitting_data, "fitting_data.json") + + if force_constants is not None: + # fitting failed + raise RuntimeError( + "Could not find a force constant solution with less than {}" + "imaginary modes.\n" + "Fitting results: {}".format(max_n_imaginary, fitting_data) + ) + + else: + logger.info("Writing force constants.") + force_constants.write("force_constants.fcs") + + atoms = AseAtomsAdaptor.get_atoms(parent_structure) + force_constants.write_to_shengBTE("FORCE_CONSTANTS_3ND", atoms) + force_constants.write_to_phonopy( + "FORCE_CONSTANTS_2ND", format="text" + ) + + +@requires(hiphive, "hiphive is required for lattice dynamics workflow") +@explicit_serialize +class ForceConstantsToDB(FiretaskBase): + """ + Add force constants, phonon band structure and density of states + to the database. + + Assumes you are in a directory with the force constants, fitting + data, and structure data written to files. + + Required parameters: + db_file (str): Path to DB file for the database that contains the + perturbed structure calculations. + + Optional parameters: + wf_uuid (str): Workflow unique identifier. + mesh_density (float): The density of the q-point mesh used to calculate + the phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + additional_fields (dict): Additional fields added to the document, such + as user-defined tags, name, ids, etc. + """ + + required_params = ["db_file"] + optional_params = ["wf_uuid", "mesh_density", "additional_fields"] + + def run_task(self, fw_spec): + from hiphive.force_constants import ForceConstants + + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + + force_constants = ForceConstants.read("force_constants.fcs") + fitting_data = loadfn("fitting_data.json") + structure_data = loadfn("structure_data.json") + structure = structure_data["structure"] + supercell_structure = structure_data["supercell_structure"] + supercell_matrix = structure_data["supercell_matrix"] + + phonopy_fc = force_constants.get_fc_array(order=2) + + logger.info("Getting uniform phonon band structure.") + uniform_bs = get_phonon_band_structure( + structure, supercell_matrix, phonopy_fc + ) + + logger.info("Getting line mode phonon band structure.") + lm_bs = get_line_mode_phonon_band_structure( + structure, supercell_matrix, phonopy_fc + ) + + logger.info("Getting phonon density of states.") + mesh_density = self.get("mesh_density", MESH_DENSITY) + dos = get_phonon_dos( + structure, supercell_matrix, phonopy_fc, mesh_density=mesh_density + ) + + logger.info("Inserting phonon objects into database.") + dos_fsid, _ = mmdb.insert_gridfs( + dos.to_json(), collection="phonon_dos_fs" + ) + uniform_bs_fsid, _ = mmdb.insert_gridfs( + uniform_bs.to_json(), collection="phonon_bandstructure_fs" + ) + lm_bs_fsid, _ = mmdb.insert_gridfs( + lm_bs.to_json(), collection="phonon_bandstructure_fs" + ) + + fc_uuid = str(uuid4()) # additional force constant identifier + + data = { + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix.tolist(), + "supercell_structure": supercell_structure.as_dict(), + "fitting_data": fitting_data, + "force_constants": force_constants.get_fc_dict(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + "wf_meta": {"wf_uuid": self["wf_uuid"], "fc_uuid": fc_uuid}, + "created_at": datetime.utcnow(), + } + data.update(self.get("additional_fields", {})) + + mmdb.collection = mmdb.db["lattice_dynamics"] + mmdb.collection.insert_one(data) + + return FWAction(update_spec={"fc_uuid": fc_uuid}) + + +@explicit_serialize +class RunShengBTE(FiretaskBase): + """ + Run ShengBTE to calculate lattice thermal conductivity. Presumes + the FORCE_CONSTANTS_3ND and FORCE_CONSTANTS_2ND files in the current + directory. In addition, presumes a "structure_data.json" file, with they + keys "structure", " and "supercell_matrix" is in the current directory. + + Required parameters: + shengbte_cmd (str): The name of the shengbte executable to run. Supports + env_chk. + + Optional parameters: + temperature (float or dict): The temperature to calculate the lattice + thermal conductivity for. Can be given as a single float, or a + dictionary with the keys "min", "max", "step". + shengbte_control_kwargs (dict): Options to be included in the ShengBTE + control file. + """ + + required_params = ["shengbte_cmd"] + optional_params = ["temperature", "shengbte_control_kwargs"] + + def run_task(self, fw_spec): + structure_data = loadfn("structure_data.json") + structure = structure_data["structure"] + supercell_matrix = structure_data["supercell_matrix"] + + control_dict = { + "scalebroad": 0.5, + "nonanalytic": False, + "isotopes": False, + "temperature": self.get("temperature", DEFAULT_TEMPERATURE), + "scell": np.diag(supercell_matrix), + } + control_dict.update(self.get("shengbte_control_kwargs", {})) + control = Control.from_structure(structure, **control_dict) + control.to_file() + + shengbte_cmd = env_chk(self["shengbte_cmd"], fw_spec) + + if isinstance(shengbte_cmd, str): + shengbte_cmd = os.path.expandvars(shengbte_cmd) + shengbte_cmd = shlex.split(shengbte_cmd) + + shengbte_cmd = list(shengbte_cmd) + logger.info("Running command: {}".format(shengbte_cmd)) + + with open("shengbte.out", "w") as f_std, open( + "shengbte_err.txt", "w", buffering=1 + ) as f_err: + # use line buffering for stderr + return_code = os.subprocess.call( + shengbte_cmd, stdout=f_std, stderr=f_err + ) + logger.info( + "Command {} finished running with returncode: {}".format( + shengbte_cmd, return_code + ) + ) + + if return_code == 1: + raise RuntimeError( + "Running ShengBTE failed. Check '{}/shengbte_err.txt' for " + "details.".format(os.getcwd()) + ) + + +@explicit_serialize +class ShengBTEToDB(FiretaskBase): + """ + Add lattice thermal conductivity results to database. + + Assumes you are in a directory with the ShengBTE results in. + + Required parameters: + db_file (str): Path to DB file for the database that contains the + perturbed structure calculations. + + Optional parameters: + wf_uuid (str): Workflow unique identifier. + fc_uuid (str): Force constant identifier, used if workflow has multiple + force constants calculated (i.e., using different fit_methods). + additional_fields (dict): Additional fields added to the document, such + as user-defined tags, name, ids, etc. + """ + + required_params = ["db_file"] + optional_params = ["wf_uuid", "fc_uuid", "additional_fields"] + + def run_task(self, fw_spec): + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + + control = Control.from_file("CONTROL") + structure = control.get_structure() + supercell_matrix = np.diag(control["scell"]) + + if Path("BTE.KappaTensorVsT_CONV").exists(): + filename = "BTE.KappaTensorVsT_CONV" + elif Path("BTE.KappaTensorVsT_RTA").exists(): + filename = "BTE.KappaTensorVsT_RTA" + else: + raise RuntimeError("Could not find ShengBTE output files.") + + bte_data = np.loadtxt(filename) + temperatures = bte_data[:, 0].tolist() + kappa = bte_data[:, 1:10].reshape(-1, 3, 3) + + wf_meta = {} + if self.get("wf_uuid"): + wf_meta["wf_uuid"] = self["wf_uuid"] + + if self.get("fc_uuid") or fw_spec.get("fc_uuid"): + wf_meta["fc_uuid"] = self.get("fc_uuid", fw_spec.get("fc_uuid")) + + data = { + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix.tolist(), + "temperatures": temperatures, + "lattice_thermal_conductivity": kappa, + "control": control.to_json(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "wf_meta": wf_meta, + "created_at": datetime.utcnow(), + } + data.update(self.get("additional_fields", {})) + + mmdb.collection = mmdb.db["lattice_thermal_conductivity"] + mmdb.collection.insert(data) From 91c553382e680465428f0bb7a815bcbc2b2f0cfb Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:04:24 -0800 Subject: [PATCH 055/207] Add first pass at lattice_dynamics fireworks --- atomate/vasp/fireworks/lattice_dynamics.py | 148 +++++++++++++++++++++ 1 file changed, 148 insertions(+) create mode 100644 atomate/vasp/fireworks/lattice_dynamics.py diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py new file mode 100644 index 000000000..25b82f224 --- /dev/null +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -0,0 +1,148 @@ +from typing import Optional, List, Union + +from atomate.common.firetasks.glue_tasks import PassCalcLocs +from atomate.vasp.firetasks.lattice_dynamics import CollectPerturbedStructures, \ + FitForceConstants, ForceConstantsToDB +from atomate.vasp.workflows.base.lattice_dynamics import IMAGINARY_TOL, \ + MAX_N_IMAGINARY, MAX_IMAGINARY_FREQ, FIT_METHOD, MESH_DENSITY +from fireworks import Firework + +__author__ = "Alex Ganose" +__email__ = "aganose@lbl.gov" + + +class FitForceConstantsFW(Firework): + + def __init__( + self, + wf_uuid, + name="fit force constants", + parents: Union[Firework, List[Firework]] = None, + db_file: str = None, + cutoffs: Optional[List[List[float]]] = None, + imaginary_tol: float = IMAGINARY_TOL, + max_n_imaginary: int = MAX_N_IMAGINARY, + max_imaginary_freq: float = MAX_IMAGINARY_FREQ, + fit_method: str = FIT_METHOD, + mesh_density: float = MESH_DENSITY, + additional_fields: dict = None, + **kwargs + ): + """ + Compile perturbed supercell calculations and fit force constants + using hiPhive. + + Args: + wf_uuid: Workflow identifier, from which the perturbed supercell + static calculations will be compiled. + parents: Parent(s) of this Firework. + name: Name of this FW. + db_file: Path to a db file. + cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs + will be generated based on the structure (default). + imaginary_tol: Tolerance used to decide if a phonon mode is + imaginary, in THz. + max_n_imaginary: Maximum number of imaginary modes allowed in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination the Firework will fizzle. + max_imaginary_freq: Maximum allowed imaginary frequency in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + fit_method: Method used for fitting force constants. This can be + any of the values allowed by the hiphive ``Optimizer`` class. + mesh_density: The density of the q-point mesh used to calculate the + phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + additional_fields: Additional fields added to the document, such as + user-defined tags, name, ids, etc. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ + fw_name = "{}-{}".format(wf_uuid, name) + additional_fields = additional_fields or {} + + collect_structures = CollectPerturbedStructures(db_file, wf_uuid) + fit_constants = FitForceConstants( + cutoffs=cutoffs, + imaginary_tol=imaginary_tol, + max_n_imaginary=max_n_imaginary, + max_imaginary_freq=max_imaginary_freq, + fit_method=fit_method + ) + fc_to_db = ForceConstantsToDB( + db_file=db_file, + wf_uuid=wf_uuid, + mesh_density=mesh_density, + additional_fields=additional_fields + ) + pass_locs = PassCalcLocs(name=name) + + tasks = [collect_structures, fit_constants, fc_to_db, pass_locs] + super().__init__(tasks, parents=parents, name=fw_name, **kwargs) + + +class LatticeThermalConductivityFW(Firework): + + def __init__( + self, + name="fit force constants", + parents: Union[Firework, List[Firework]] = None, + db_file: str = None, + cutoffs: Optional[List[List[float]]] = None, + imaginary_tol: float = IMAGINARY_TOL, + max_n_imaginary: int = MAX_N_IMAGINARY, + max_imaginary_freq: float = MAX_IMAGINARY_FREQ, + fit_method: str = FIT_METHOD, + mesh_density: float = MESH_DENSITY, + additional_fields: dict = None, + **kwargs + ): + """ + Compile perturbed supercell calculations and fit force constants + using hiPhive. + + Args: + wf_uuid: Workflow identifier, from which the perturbed supercell + static calculations will be compiled. + parents: Parent(s) of this Firework. + name: Name of this FW. + db_file: Path to a db file. + cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs + will be generated based on the structure (default). + imaginary_tol: Tolerance used to decide if a phonon mode is + imaginary, in THz. + max_n_imaginary: Maximum number of imaginary modes allowed in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination the Firework will fizzle. + max_imaginary_freq: Maximum allowed imaginary frequency in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + fit_method: Method used for fitting force constants. This can be + any of the values allowed by the hiphive ``Optimizer`` class. + mesh_density: The density of the q-point mesh used to calculate the + phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + additional_fields: Additional fields added to the document, such as + user-defined tags, name, ids, etc. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ + fw_name = "{}-{}".format(wf_uuid, name) + additional_fields = additional_fields or {} + + collect_structures = CollectPerturbedStructures(db_file, wf_uuid) + fit_constants = FitForceConstants( + cutoffs=cutoffs, + imaginary_tol=imaginary_tol, + max_n_imaginary=max_n_imaginary, + max_imaginary_freq=max_imaginary_freq, + fit_method=fit_method + ) + fc_to_db = ForceConstantsToDB( + db_file=db_file, + wf_uuid=wf_uuid, + mesh_density=mesh_density, + additional_fields=additional_fields + ) + pass_locs = PassCalcLocs(name=name) + + tasks = [collect_structures, fit_constants, fc_to_db, pass_locs] + super().__init__(tasks, parents=parents, name=fw_name, **kwargs) From 3ac59eb2000d0a0dceefabf6933b6cedb41de13d Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:04:39 -0800 Subject: [PATCH 056/207] Add methods for fitting force constants --- atomate/vasp/analysis/lattice_dynamics.py | 473 +++++++++++++--------- 1 file changed, 292 insertions(+), 181 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index f0ab19acc..c6d1a05ce 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -1,207 +1,318 @@ -# coding: utf-8 +import numpy as np -from __future__ import division, print_function, unicode_literals, absolute_import +from itertools import product +from typing import Optional, Tuple, List, Dict -from typing import Optional, Tuple, List +from pymatgen import Structure +from pymatgen.io.ase import AseAtomsAdaptor +from pymatgen.io.phonopy import get_phonopy_structure -import numpy as np +from atomate.utils.utils import get_logger +from atomate.vasp.workflows.base.lattice_dynamics import ( + MIN_NN_SCALE, + FIT_METHOD, + MAX_IMAGINARY_FREQ, + IMAGINARY_TOL, + MAX_N_IMAGINARY, +) -from pymatgen import Structure -from pymatgen.transformations.standard_transformations import PerturbStructureTransformation +__author__ = "Rees Chang, Alex Ganose" +__email__ = "rc564@cornell.edu, aganose@lbl.gov" -__author__ = 'Rees Chang, Alex Ganose' -__email__ = 'rc564@cornell.edu, aganose@lbl.gov' +logger = get_logger(__name__) -def generate_perturbed_supercells( - supercell: Structure, - min_displacement: float = 0.01, - max_displacement: float = 0.1, - num_displacements: int = 10, - n_cells_per_displacement_distance: int = 1, - min_random_distance: Optional[float] = None + +def generate_perturbed_structures( + structure: Structure, + rattle_stds: Optional[List[float]] = None, + n_configs_per_std: int = 1, + min_nn_scale: float = MIN_NN_SCALE, ) -> Tuple[List[Structure], np.ndarray]: """ - Generate a list of supercells with perturbed atomic sites. + Generate a list of structures with perturbed atomic sites. + + Rattling atom `i` is carried out as a Monte Carlo move that is accepted with + a probability determined from the minimum interatomic distance + :math:`d_{ij}`. If :math:`\\min(d_{ij})` is smaller than :math:`d_{min}` + the move is only accepted with a low probability. + + :math:`d_{min}` is calculated as the smallest nearest neighbor distance + times ``min_nn_fraction``. Args: - supercell (Structure): Original structure whose atomic sites are to be - perturbed. - max_displacement: Maximum displacement distance for perturbing the - sites in Angstroms. - min_displacement: Minimum displacement distance for perturbing the - sites in Angstroms. - num_displacements: Number of unique displacement distances to - try, uniformly distributed between ``min_displacement`` and - ``max_displacement``. - n_cells_per_displacement_distance: Number of perturbed - structures to generate for each unique displacement distance. - min_random_distance: If None (default), then for a given perturbed - structure, all atoms will move the same distance from their original - locations. If float, then for a given perturbed structure, the - distances the atoms move will be uniformly distributed from a - minimum distance of ``min_random_distance`` to one of the - displacement distances uniformly sampled between - ``min_displacement`` and ``max_displacement``. + structure: Structure whose atomic sites are to be perturbed. + rattle_stds: List of standard deviations (in normal distribution) to + to use when displacing the sites. + n_configs_per_std: Number of structures to generate per rattle standard + deviation. + min_nn_scale: Controls the minimum interatomic distance used for + computing the probability for each rattle move. Returns: A tuple of the ``(structures, displacements)``. Where ``structures`` is a list of randomly displaced structures, and ``displacements`` is the displacement distance for each structure. """ - dists = np.linspace(min_displacement, max_displacement, num_displacements) - displacements = np.repeat(dists, n_cells_per_displacement_distance) + from hiphive.structure_generation import generate_mc_rattled_structures + + if rattle_stds is None: + rattle_stds = np.linspace(0.01, 0.1, 5) + + min_distance = np.min(structure.distance_matrix) * min_nn_scale + atoms = AseAtomsAdaptor.get_atoms(structure) + + perturbed_structures = [] + for rattle_std in rattle_stds: + seed = np.random.randint(1, 10000000000) + structures = generate_mc_rattled_structures( + atoms, n_configs_per_std, rattle_std, min_distance, seed=seed + ) + perturbed_structures.extend(structures) + + return perturbed_structures, rattle_stds + + +def get_cutoffs(structure: Structure): + """ + Get a list of trial cutoffs based on a structure. + + An initial guess for the lower bound of the cutoffs is made based on the + period of the lightest element in the structure, according to: + + ====== === === === + . Cutoff + ------ ----------- + Period 2ND 3RD 4TH + ====== === === === + 1 5.5 3.0 3.0 + 2 5.5 3.0 3.0 + 3 6.5 4.0 3.5 + 4 7.5 5.0 4.0 + 5 8.5 6.0 4.5 + 6 9.5 7.0 5.0 + 7 9.5 7.0 5.0 + ====== === === === + + The maximum cutoff for each order is determined by the minimum cutoff and + the following table. A full grid of all possible cutoff combinations is + generated based on the step size in the table below + + ====== ==== ===== + Cutoff Max Step + ====== ==== ===== + 2ND +3.0 0.5 + 3RD +1.5 0.25 + 4TH +1.0 0.25 + ====== ==== ===== + + Args: + structure: A structure. + + Returns: + A list of trial cutoffs. + """ + # indexed as min_cutoffs[order][period] + min_cutoffs = { + 2: {1: 5.5, 2: 5.5, 3: 6.5, 4: 7.5, 5: 8.5, 6: 9.5, 7: 9.5}, + 3: {1: 3.0, 2: 3.0, 3: 4.0, 4: 5.0, 5: 6.0, 6: 7.0, 7: 7.0}, + 4: {1: 3.0, 2: 3.0, 3: 3.5, 4: 4.0, 5: 4.5, 6: 5.0, 7: 5.0}, + } + inc = {2: 3, 3: 1.5, 4: 1} + steps = {2: 0.5, 3: 0.25, 4: 0.25} - perturbed_supercells = [] - for displacement in displacements: - pst = PerturbStructureTransformation(displacement, min_random_distance) - perturbed_supercells.append(pst.apply_transformation(supercell)) + row = min([s.row for s in structure.species]) + mins = (min_cutoffs[row][2], min_cutoffs[row][3], min_cutoffs[row][4]) - return perturbed_supercells, displacements + range_two = np.arange(mins[0], mins[0] + inc[0] + steps[0], steps[0]) + range_three = np.arange(mins[1], mins[1] + inc[1] + steps[1], steps[1]) + range_four = np.arange(mins[2], mins[2] + inc[2] + steps[2], steps[2]) + return list(product(range_two, range_three, range_four)) -def csld_main(options, settings): + +def fit_force_constants( + parent_structure: Structure, + supercell_matrix: np.ndarray, + structures: List["Atoms"], + all_cutoffs: List[List[float]], + imaginary_tol: float = IMAGINARY_TOL, + max_n_imaginary: int = MAX_N_IMAGINARY, + max_imaginary_freq: float = MAX_IMAGINARY_FREQ, + fit_method: str = FIT_METHOD, +) -> Tuple["SortedForceConstants", Dict]: """ - Runs CSLD minimization. + Fit force constants using hiphive and select the optimum cutoff values. + + The optimum cutoffs will be determined according to: + 1. Number imaginary modes < ``max_n_imaginary``. + 2. Most negative imaginary frequency < ``max_imaginary_freq``. + 3. Least number of imaginary modes. + 4. Lowest free energy at 300 K. - Changes from original version: - - Made 'prim' an argument in 'phonon_step()' - - Moved execution files to this main() function to be called from - atomate - - Rewrote 'add_common_parameter' in 'common_main' to treat 'options' as + If criteria 1 and 2 are not satisfied, None will be returned as the + force constants. + + Args: + parent_structure: Initial input structure. + supercell_matrix: Supercell transformation matrix. + structures: A list of ase atoms objects with "forces" and + "displacements" arrays added, as required by hiPhive. + all_cutoffs: A nested list of cutoff values to trial. Each set of + cutoffs contains the radii for different orders starting with second + order. + imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, + in THz. + max_n_imaginary: Maximum number of imaginary modes allowed in the + the final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + max_imaginary_freq: Maximum allowed imaginary frequency in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + fit_method: Method used for fitting force constants. This can be + any of the values allowed by the hiphive ``Optimizer`` class. - a dictionary instead of ArgumentParser + Returns: + A tuple of the best fitted force constants as a hiphive + ``SortedForceConstants`` object and a dictionary of information on the + fitting process. """ - import matplotlib - matplotlib.use('Agg') - from matplotlib.backends.backend_pdf import PdfPages - import atexit - import csld - from csld.symmetry_structure import SymmetrizedStructure - - from csld.lattice_dynamics import init_ld_model - - from csld.common_main import upon_exit, \ - init_training - from csld.csld_main_functions import phonon_step, \ - save_pot, predict, fit_data - - - freq_matrix = None #Rees - pdfout = PdfPages( - options['pdfout'].strip()) if options['pdfout'].strip() else None - atexit.register(upon_exit, pdfout) - - prim = SymmetrizedStructure.init_structure(settings['structure'], - options['symm_step'], - options['symm_prim'], - options['log_level']) - model = init_ld_model(prim, settings['model'], settings[ - 'LDFF'] if 'LDFF' in settings.sections() else {}, options['clus_step'], - options['symC_step'], options['ldff_step']) - Amat, fval = init_training(model, settings['training'], options['train_step']) - ibest, solutions, rel_err = fit_data(model, Amat, fval, settings['fitting'], - options['fit_step'], pdfout) - if settings.has_section('phonon'): - phonon, freq_matrix = phonon_step(model, solutions, settings['phonon'], - options['phonon_step'], pdfout, prim, return_eigen=True) - if settings.has_section('export_potential'): - save_pot(model, solutions[ibest], settings['export_potential'], - options['save_pot_step'], phonon) - if settings.has_section('prediction'): - predict(model, solutions, settings['prediction'], options['pred_step']) - - #OUTPUT - # freq_matrix is (nbands, nkpoints) = frequencies. Check for negative entries - # rel_err is cross validation error in percent - return rel_err, freq_matrix # also want to return force constants - - -default_csld_settings = { - "structure": {"sym_tol": "1e-3"}, - "model": { - 'model_type': 'LD', - 'cluster_in': 'clusters.out', - 'cluster_out': 'clusters.out', - 'symC_in': 'Cmat.mtx', - 'symC_out': 'Cmat.mtx', - 'fractional_distance': False, - }, - "training":{ - 'interface': 'VASP', - 'corr_type': 'f', - 'corr_in': 'Amat.mtx', - 'corr_out': 'Amat.mtx', - 'fval_in': 'fval.txt', - 'fval_out': 'fval.txt' - }, - "fitting": { - 'solution_in': 'solution_all', - 'solution_out': 'solution_all', - 'nsubset': 5, - 'holdsize': 0.1, - ## 1 FPC 2 FPC sparse 3 split 4 sparse split - ## 5 split+ right preconditioning 6 sparse split + r preconditioning - ## 101 Bayesian CS - 'method': 5, - # For weight of L1 or L2 regularization - 'mulist': '1E-5 1E-6 1E-7 1E-9', - 'maxIter': 300, - 'tolerance': 1E-6, - 'subsetsize': 0.85, - 'lambda': 0.5, - 'uscale_list': '0.03', - }, - "phonon": { - 'qpoint_fractional': False, - # 'Auto' or something like - # "[[10, [0,0,0],'\\Gamma', [0.5,0.5,0.5], 'X', [0.5,0.5,0], 'K']]" - 'wavevector': 'Auto', - 'unit': 'cm', # THz, meV, eV, cm - 'dos_grid': '15 15 15', # number of grid points - 'nE_dos': 500, # number of points in DOS - 'ismear': -1, # 0 (Gaussian), 1 (Lorentzian), -1 (tetrahedron method) - 'epsilon': 0.05, # width in THz of Gaussian/Lorentzian smearing - 'pdos': True, - 'thermal_T_range': '50 800 50', - 'thermal_out': 'thermal_out.txt' - }, - 'prediction': { - 'interface': 'VASP', - 'corr_type': 'f', - 'corr_in': 'Amat_pred.mtx', - 'corr_out': 'Amat_pred.mtx', - 'fval_in': 'fval_pred.txt', - 'fval_out': 'fval_pred.txt', - 'traindat0': 'fcc222/POSCAR fcc222/traj*' - }, - 'export_potential': {}, - 'DEFAULT': { - "qpoint_fractional": False, - "true_v_fit": 'true_fit.txt', - 'epsilon': '0.05', - "bcs_reweight": 'True', - "bcs_penalty": 'arctan', - "bcs_jcutoff": '1E-8' + from hiphive.fitting import Optimizer + from hiphive import ForceConstantPotential, enforce_rotational_sum_rules + + logger.info("Starting fitting force constants.") + + fitting_data = { + "cutoffs": [], + "rmse_test": [], + "n_imaginary": [], + "min_frequency": [], + "300K_free_energy": [], + "fit_method": fit_method, + "imaginary_tol": imaginary_tol, + "max_n_imaginary": max_n_imaginary, + "max_imaginary_freq": max_imaginary_freq, + } + + supercell_atoms = structures[0] + + best_fit = { + "n_imaginary": np.inf, + "free_energy": np.inf, + "force_constants": None, + "cutoffs": None, } -} - -default_csld_options = { - 'pdfout': 'plots.pdf', - 'ldff_step': 0, - 'phonon_step': 1, - 'phonon': False, - 'save_pot_step': 1, - 'pot': False, - 'log_level': 1, - 'symm_step': 2, - 'symm_prim': True, - 'clus_step': 3, - 'symC_step': 3, - 'train_step': 3, - 'fit_step': 3, - 'pred_step': 0, - 'refit': False, - 'cont': False, - 'predict': False -} \ No newline at end of file + n_cutoffs = len(all_cutoffs) + for i, cutoffs in enumerate(all_cutoffs): + logger.info( + "Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs) + ) + sc = get_structure_container(cutoffs, structures) + opt = Optimizer(sc.get_fit_data(), fit_method) + opt.train() + + parameters = enforce_rotational_sum_rules( + sc.cluster_space, opt.parameters, ["Huang", "Born-Huang"] + ) + fcp = ForceConstantPotential(sc.cluster_space, parameters) + fcs = fcp.get_force_constants(supercell_atoms) + + phonopy_fcs = fcs.get_fc_array(order=2) + n_imaginary, min_freq, free_energy = evaluate_force_constants( + parent_structure, supercell_matrix, phonopy_fcs, imaginary_tol + ) + + fitting_data["cutoffs"].append(cutoffs) + fitting_data["rmse_train"].append(opt.rmse_test) + fitting_data["n_imaginary"].append(n_imaginary) + fitting_data["min_frequency"].append(min_freq) + fitting_data["300K_free_energy"].append(free_energy) + fitting_data["force_constants"].append(fcs) + + if ( + min_freq < -np.abs(max_imaginary_freq) + and n_imaginary <= max_n_imaginary + and n_imaginary < best_fit["n_imaginary"] + and free_energy < best_fit["free_energy"] + ): + + best_fit.update( + { + "n_imaginary": n_imaginary, + "free_energy": free_energy, + "force_constants": fcs, + "cutoffs": cutoffs, + } + ) + fitting_data["best"] = cutoffs + + logger.info("Finished fitting force constants.") + + return best_fit["force_constants"], fitting_data + + +def get_structure_container( + cutoffs: List[float], structures: List["Atoms"] +) -> "StructureContainer": + """ + Get a hiPhive StructureContainer from cutoffs and a list of atoms objects. + + Args: + cutoffs: Cutoff radii for different orders starting with second order. + structures: A list of ase atoms objects with the "forces" and + "displacements" arrays included. + + Returns: + A hiPhive StructureContainer. + """ + from hiphive import ClusterSpace, StructureContainer + + cs = ClusterSpace(structures[0], cutoffs) + logger.debug(cs.__repr__()) + + sc = StructureContainer(cs) + for structure in structures: + sc.add_structure(structure) + logger.debug(sc.__repr__()) + + return sc + + +def evaluate_force_constants( + structure: Structure, + supercell_matrix: np.ndarray, + force_constants: np.ndarray, + imaginary_tol: float = IMAGINARY_TOL, +) -> Tuple[int, float, float]: + """ + Uses the force constants to extract phonon properties. Used for comparing + the accuracy of force constant fits. + + Args: + structure: The parent structure. + supercell_matrix: The supercell transformation matrix. + force_constants: The force constants in numpy format. + imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, + in THz. + + Returns: + A tuple of the number of imaginary modes at Gamma, the minimum phonon + frequency at Gamma, and the free energy at 300 K. + """ + from phonopy import Phonopy + + parent_phonopy = get_phonopy_structure(structure) + phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) + + phonopy.set_force_constants(force_constants) + phonopy.run_mesh(is_gamma_center=True) + phonopy.run_thermal_properties(temperatures=[300]) + free_energy = phonopy.get_thermal_properties_dict()["free_energy"][0] + + # find imaginary modes at gamma + phonopy.run_qpoints([0, 0, 0]) + gamma_eigs = phonopy.get_qpoints_dict()["frequencies"] + n_imaginary = int(np.sum(gamma_eigs < -np.abs(imaginary_tol))) + min_frequency = np.min(gamma_eigs) + + return n_imaginary, min_frequency, free_energy From 7919b9a014753f391f15adf85d3fcd27118f83a4 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:04:56 -0800 Subject: [PATCH 057/207] Add methods for generating phonon band structure & DOS --- atomate/vasp/analysis/phonopy.py | 182 +++++++++++++++++++++++++++++-- 1 file changed, 174 insertions(+), 8 deletions(-) diff --git a/atomate/vasp/analysis/phonopy.py b/atomate/vasp/analysis/phonopy.py index af386899b..3923895ab 100644 --- a/atomate/vasp/analysis/phonopy.py +++ b/atomate/vasp/analysis/phonopy.py @@ -1,7 +1,32 @@ +<<<<<<< HEAD +======= +# coding: utf-8 + +>>>>>>> 728556b6 (Add methods for generating phonon band structure & DOS) import numpy as np +from monty.dev import requires +<<<<<<< HEAD __author__ = "Kiran Mathew" __email__ = "kmathew@lbl.gov" +======= +from pymatgen import Structure +from pymatgen.io.phonopy import get_phonopy_structure +from pymatgen.phonon.bandstructure import ( + PhononBandStructure, + PhononBandStructureSymmLine, +) +from pymatgen.phonon.dos import PhononDos, CompletePhononDos +from pymatgen.symmetry.bandstructure import HighSymmKpath + +try: + import phonopy +except ImportError: + phonopy = False + +__author__ = "Kiran Mathew, Alex Ganose" +__email__ = "kmathew@lbl.gov, aganose@lbl.gov" +>>>>>>> 728556b6 (Add methods for generating phonon band structure & DOS) # TODO: @matk86 - unit tests? @@ -30,8 +55,9 @@ def get_phonopy_gibbs( t_step (float): temperature step t_max (float): max temperature mesh (list/tuple): reciprocal space density - eos (str): equation of state used for fitting the energies and the volumes. - options supported by phonopy: vinet, murnaghan, birch_murnaghan + eos (str): equation of state used for fitting the energies and the + volumes. options supported by phonopy: vinet, murnaghan, + birch_murnaghan pressure (float): in GPa, optional. Returns: @@ -59,6 +85,10 @@ def get_phonopy_gibbs( return G, T +<<<<<<< HEAD +======= +@requires(phonopy, "phonopy is required to calculate the QHA") +>>>>>>> 728556b6 (Add methods for generating phonon band structure & DOS) def get_phonopy_qha( energies, volumes, @@ -83,8 +113,9 @@ def get_phonopy_qha( t_step (float): temperature step t_max (float): max temperature mesh (list/tuple): reciprocal space density - eos (str): equation of state used for fitting the energies and the volumes. - options supported by phonopy: vinet, murnaghan, birch_murnaghan + eos (str): equation of state used for fitting the energies and the + volumes. options supported by phonopy: vinet, murnaghan, + birch_murnaghan pressure (float): in GPa, optional. Returns: @@ -117,7 +148,10 @@ def get_phonopy_qha( cv.append(c) # add pressure contribution - energies = np.array(energies) + np.array(volumes) * pressure / EVAngstromToGPa + energies = ( + np.array(energies) + np.array(volumes) * pressure / EVAngstromToGPa + ) + # quasi-harmonic approx return PhonopyQHA( volumes, @@ -155,12 +189,14 @@ def get_phonopy_thermal_expansion( t_step (float): temperature step t_max (float): max temperature mesh (list/tuple): reciprocal space density - eos (str): equation of state used for fitting the energies and the volumes. - options supported by phonopy: vinet, murnaghan, birch_murnaghan + eos (str): equation of state used for fitting the energies and the + volumes. options supported by phonopy: vinet, murnaghan, + birch_murnaghan pressure (float): in GPa, optional. Returns: - (numpy.ndarray, numpy.ndarray): thermal expansion coefficient, Temperature + (numpy.ndarray, numpy.ndarray): thermal expansion coefficient, + Temperature """ # quasi-harmonic approx @@ -182,3 +218,133 @@ def get_phonopy_thermal_expansion( alpha = phonopy_qha.get_thermal_expansion()[:max_t_index] T = phonopy_qha._qha._temperatures[:max_t_index] return alpha, T + + +@requires(phonopy, "phonopy is required to calculate phonon density of states") +def get_phonon_dos( + structure: Structure, + supercell_matrix: np.ndarray, + force_constants: np.ndarray, + mesh_density: float = MESH_DENSITY, + num_dos_steps: int = 200, +) -> CompletePhononDos: + """ + Get a projected phonon density of states. + + Args: + structure: A structure. + supercell_matrix: The supercell matrix used to generate the force + constants. + force_constants: The force constants in phonopy format. + mesh_density: The density of the q-point mesh. See the docstring + for the ``mesh`` argument in Phonopy.init_mesh() for more details. + num_dos_steps: Number of frequency steps in the energy grid. + + Returns: + The density of states. + """ + from phonopy import Phonopy + + structure_phonopy = get_phonopy_structure(structure) + phonon = Phonopy(structure_phonopy, supercell_matrix=supercell_matrix) + phonon.set_force_constants(force_constants) + phonon.run_mesh( + mesh_density, + is_mesh_symmetry=False, + with_eigenvectors=True, + is_gamma_center=True, + ) + + # get min, max, step frequency + frequencies = phonon.get_mesh_dict()["frequencies"] + freq_min = frequencies.min() + freq_max = frequencies.max() + freq_pitch = (freq_max - freq_min) / num_dos_steps + + phonon.run_projected_dos( + freq_min=freq_min, freq_max=freq_max, freq_pitch=freq_pitch + ) + + dos_raw = phonon.projected_dos.get_partial_dos() + pdoss = {s: dos for s, dos in zip(structure, dos_raw[1])} + + total_dos = PhononDos(dos_raw[0], dos_raw[1].sum(axis=0)) + return CompletePhononDos(structure, total_dos, pdoss) + + +@requires(phonopy, "phonopy is required to calculate phonon band structures") +def get_phonon_band_structure( + structure: Structure, + supercell_matrix: np.ndarray, + force_constants: np.ndarray, + mesh_density: float = 100.0, +) -> PhononBandStructure: + """ + Get a uniform phonon band structure. + + Args: + structure: A structure. + supercell_matrix: The supercell matrix used to generate the force + constants. + force_constants: The force constants in phonopy format. + mesh_density: The density of the q-point mesh. See the docstring + for the ``mesh`` argument in Phonopy.init_mesh() for more details. + + Returns: + The uniform phonon band structure. + """ + from phonopy import Phonopy + + structure_phonopy = get_phonopy_structure(structure) + phonon = Phonopy(structure_phonopy, supercell_matrix=supercell_matrix) + phonon.set_force_constants(force_constants) + phonon.run_mesh(mesh_density, is_mesh_symmetry=False, is_gamma_center=True) + mesh = phonon.get_mesh_dict() + + return PhononBandStructure( + mesh["qpoints"], mesh["frequencies"], structure.lattice + ) + + +@requires(phonopy, "phonopy is required to calculate phonon band structures") +def get_line_mode_phonon_band_structure( + structure: Structure, + supercell_matrix: np.ndarray, + force_constants: np.ndarray, + line_density: float = 20.0, + symprec: float = 0.01, +) -> PhononBandStructureSymmLine: + """ + Get a projected phonon density of states. + + Args: + structure: A structure. + supercell_matrix: The supercell matrix used to generate the force + constants. + force_constants: The force constants in phonopy format. + line_density: The density along the high symmetry path. + symprec: Symmetry precision for determining the band structure path. + + Returns: + The line mode band structure. + """ + from phonopy import Phonopy + + structure_phonopy = get_phonopy_structure(structure) + phonon = Phonopy(structure_phonopy, supercell_matrix=supercell_matrix) + phonon.set_force_constants(force_constants) + + kpath = HighSymmKpath(structure, symprec=symprec) + + kpoints, labels = kpath.get_kpoints( + line_density=line_density, coords_are_cartesian=False + ) + + phonon.run_qpoints(kpoints) + frequencies = phonon.qpoints.get_frequencies().T + + labels_dict = dict([(a, k) for a, k in zip(labels, kpoints) if a != ""]) + + return PhononBandStructureSymmLine( + kpoints, frequencies, structure.lattice, labels_dict=labels_dict + ) From 8f1a9aeed262f61b48eb83d20de16fae61153957 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:05:38 -0800 Subject: [PATCH 058/207] Rewrite lattice dynamics workflow --- .../vasp/workflows/base/lattice_dynamics.py | 304 +++++++++++------- 1 file changed, 186 insertions(+), 118 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 43321a584..3c0417831 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -1,28 +1,40 @@ -# coding: utf-8 +import math + +import numpy as np + from copy import deepcopy -from typing import List, Dict, Optional + +from monty.dev import requires +from typing import List, Dict, Optional, Union from uuid import uuid4 -from pymatgen.transformations.advanced_transformations import ( - CubicSupercellTransformation -) +from atomate.vasp.firetasks.lattice_dynamics import FitForceConstants, \ + ForceConstantsToDB, RunShengBTE, ShengBTEToDB from pymatgen.io.vasp.sets import MPStaticSet from pymatgen.core.structure import Structure from pymatgen.symmetry.analyzer import SpacegroupAnalyzer +from pymatgen.transformations.advanced_transformations import ( + CubicSupercellTransformation, +) from fireworks import Workflow, Firework + from atomate.utils.utils import get_logger -from atomate.vasp.config import VASP_CMD, DB_FILE +from atomate.vasp.config import VASP_CMD, DB_FILE, SHENGBTE_CMD from atomate.vasp.fireworks.core import StaticFW -from atomate.vasp.firetasks.parse_outputs import CSLDForceConstantsToDB from atomate.vasp.powerups import add_additional_fields_to_taskdocs -from atomate.vasp.analysis.csld import generate_perturbed_supercells +from atomate.vasp.analysis.lattice_dynamics import generate_perturbed_structures + +try: + import hiphive +except ImportError: + hiphive = False __author__ = "Rees Chang, Alex Ganose" __email__ = "rc564@cornell.edu, aganose@lbl.gov" __date__ = "July 2019" -__csld_wf_version__ = 1.0 +__lattice_dynamics_wf_version__ = 1.0 logger = get_logger(__name__) @@ -31,38 +43,42 @@ "LCHARG": False, "ENCUT": 700, "EDIFF": 1e-8, # may need to tune this - "PREC": 'Accurate', + "PREC": "Accurate", "LAECHG": False, "LREAL": False, - "LASPH": True + "LASPH": True, } # define shared constants -_MAX_DISPLACEMENT = 0.1 -_MIN_DISPLACEMENT = 0.01 -_NUM_DISPLACEMENTS = 10 -_MIN_RANDOM_DISPLACEMENTS = None -_CELLS_PER_DISPLACEMENT = 1 +MIN_NN_SCALE = 0.85 +MAX_IMAGINARY_FREQ = 10 # in THz +IMAGINARY_TOL = 0.025 # in THz +MAX_N_IMAGINARY = 3 +DEFAULT_TEMPERATURE = 300 +FIT_METHOD = "least-squares" +MESH_DENSITY = 100. # should always be a float _DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} +@requires(hiphive, "hiphive is required for lattice dynamics workflow") def get_lattice_dynamics_wf( structure: Structure, common_settings: Dict = None, - symprec: Optional[float] = None, + symmetrize: bool = False, + symprec: float = 0.01, min_atoms: Optional[int] = None, max_atoms: Optional[int] = None, - num_nn_dists: float = 5, + num_nn_dists: float = 5., force_diagonal_transformation: bool = True, - max_displacement: float = _MAX_DISPLACEMENT, - min_displacement: float = _MIN_DISPLACEMENT, - num_displacements: int = _NUM_DISPLACEMENTS, - n_cells_per_displacement_distance: int = _CELLS_PER_DISPLACEMENT, - min_random_distance: Optional[float] = _MIN_RANDOM_DISPLACEMENTS, + rattle_stds: Optional[List[float]] = None, + min_nn_scale: float = MIN_NN_SCALE, + min_num_equivalent_sites: int = 100, + max_num_supercells: int = 30, dynamic_static_calcs: bool = False, - do_shengbte: bool = False, - shengbte_t_range: Optional[List[float]] = None, - shengbte_fworker: Optional[str] = None + calculate_lattice_thermal_conductivity: bool = False, + thermal_conductivity_temperature: Union[float, Dict] = 300, + shengbte_cmd: str = SHENGBTE_CMD, + shengbte_fworker: Optional[str] = None, ): """ This workflow will calculate interatomic force constants and vibrational @@ -84,8 +100,10 @@ def get_lattice_dynamics_wf( Args: structure: Initial structure. common_settings: Common settings dict. - symprec: Symmetry precision for symmetrizing the structure. If set to - ``None`` (the default), the structure will not be symmetrized. + symmetrize: Whether to symmetrize the structure before running the + workflow. + symprec: Symmetry precision for determining the symmetry of the + structure. min_atoms: Minimum number of atoms to constrain the supercell. max_atoms: Maximum number of atoms to constrain the supercell. num_nn_dists: Number of nearest neighbor distances that the shortest @@ -94,153 +112,163 @@ def get_lattice_dynamics_wf( transformation will be constrained to have a diagonal transformation matrix. If False, the supercell transformation will not be constrained to be diagonal (resulting in a more - cubic supercell). - max_displacement: Maximum displacement distance for perturbing the - sites in Angstroms. - min_displacement: Minimum displacement distance for perturbing the - sites in Angstroms. - num_displacements: Number of unique displacement distances to - try, uniformly distributed between ``min_displacement`` and - ``max_displacement``. - n_cells_per_displacement_distance: Number of perturbed - structures to generate for each unique displacement distance. - min_random_distance: If None (default), then for a given perturbed - structure, all atoms will move the same distance from their original - locations. If float, then for a given perturbed structure, the - distances the atoms move will be uniformly distributed from a - minimum distance of ``min_random_distance`` to one of the - displacement distances uniformly sampled between - ``min_displacement`` and ``max_displacement``. + cubic supercell). A diagonal supercell is required to calculate + lattice thermal conductivity. + rattle_stds: List of standard deviations (in normal distribution) to + to use when displacing the sites. + min_nn_scale: Controls the minimum interatomic distance used for + computing the probability for each rattle move. + min_num_equivalent_sites: The minimum number of equivalent sites for + each species. The aim is to have each equivalent site represented at + least ``min_num_equivalent_sites`` times. For example, if a symmetry + inequivalent site appears 26 times in the supercell structure, + and ``min_num_equivalent_sites`` is 100, then at least 4 supercells + are required for that site to appear over 100 times. + max_num_supercells: The maximum number of supercells per displacement. + For very unsymmetric structures, this imposes a hard limit on + the number of sites generated due to ``min_num_equivalent_sites``. dynamic_static_calcs: If True and hiPhive fails to return all real harmonic phonon frequencies on the first try, then the workflow will dynamically create more static perturbed supercell calculations with larger displacements to improve the fitting. - do_shengbte: If True and force constant fitting does not return - imaginary modes, then the workflow will dynamically create a - ShengBTE firework for calculating the lattice thermal conductivity. - shengbte_t_range: A list of temperatures at which to calculate the - lattice thermal conductivity using ShengBTE. If None (default), - then 300 K will be used. + calculate_lattice_thermal_conductivity: If True and force constant + fitting does not return imaginary modes, then use ShengBTE to + calculate the lattice thermal conductivity. + thermal_conductivity_temperature: The temperature to calculate the + lattice thermal conductivity for. Can be given as a single float, or + a dictionary with the keys "min", "max", "step". + shengbte_cmd: Command to run ShengBTE. Supports env_chk. shengbte_fworker: If None, the ShengBTE firework's fworker will be set to all the previous fireworks' fworker. If str, the ShengBTE firework's fworker will be set to shengbte_fworker. """ - common_settings = common_settings or _DEFAULT_SETTINGS + common_settings = _get_common_settings(common_settings) uis = deepcopy(_static_uis) uis.update(common_settings.get("user_incar_settings", {})) - if force_diagonal_transformation is True and num_nn_dists == 5: - num_nn_dists = 6 + if not force_diagonal_transformation and calculate_lattice_thermal_conductivity: + raise ValueError( + "Diagonal transformation required to calculate lattice thermal " + "conductivity" + ) - if symprec is not None: - sga = SpacegroupAnalyzer(structure, symprec=symprec) + sga = SpacegroupAnalyzer(structure, symprec=symprec) + if symmetrize: structure = sga.get_primitive_standard_structure() st = CubicSupercellTransformation( min_atoms, max_atoms, num_nn_dists, - force_diagonal_transformation=force_diagonal_transformation + force_diagonal_transformation=force_diagonal_transformation, ) supercell = st.apply_transformation(structure) - perturbed_supercells, disp_dists, fws = get_perturbed_supercell_fws( + n_cells = _get_n_cells(sga, min_num_equivalent_sites, max_num_supercells) + perturbed_supercells, disp_dists, fws = get_perturbed_structure_fws( supercell, - common_settings, + common_settings=common_settings, user_incar_settings=uis, - min_displacement=min_displacement, - max_displacement=max_displacement, - num_displacements=num_displacements, - min_random_distance=min_random_distance, - n_cells_per_displacement_distance=n_cells_per_displacement_distance, + rattle_stds=rattle_stds, + min_nn_scale=min_nn_scale, + n_configs_per_std=n_cells, ) + logger.debug("Generating {} supercells per displacement".format(n_cells)) logger.debug("Using {} displacements".format(len(disp_dists))) logger.debug("Displacements: {}".format(disp_dists)) - # Collect force constants from the DB and output on cluster - wf_meta = {"wf_uuid": str(uuid4()), "wf_name": "LatticeDynamicsWF"} - csld_fw = Firework( - CSLDForceConstantsToDB( - db_file=common_settings["DB_FILE"], - wf_uuid=wf_meta["wf_uuid"], - parent_structure=structure, - trans_mat=st.transformation_matrix.tolist(), - supercell_structure=supercell, - perturbed_supercells=perturbed_supercells, - disps=disp_dists, - force_diagonal_transformation=force_diagonal_transformation, - first_pass=True, - static_user_incar_settings=uis, - env_vars=common_settings, - dynamic_static_calcs=dynamic_static_calcs, - do_shengbte=do_shengbte, - shengbte_t_range=shengbte_t_range, - shengbte_fworker=shengbte_fworker - ), - name="Compressed Sensing Lattice Dynamics", - parents=fws[-len(perturbed_supercells):] + wf_meta = { + "wf_uuid": str(uuid4()), + "wf_name": "LatticeDynamicsWF", + "wf_version": __lattice_dynamics_wf_version__, + } + + # Add tasks to fit force constants + fit_forces = FitForceConstants( + db_file=common_settings["DB_FILE"], + wf_uuid=wf_meta["wf_uuid"], + parent_structure=structure, + supercell_structure=supercell, + supercell_matrix=st.transformation_matrix.tolist(), + ) + forces_to_db = ForceConstantsToDB( + db_file=common_settings["DB_FILE"], wf_uuid=wf_meta["wf_uuid"], + ) + fws.append( + Firework( + [fit_forces, forces_to_db], + name="Force Constant Fitting", + parents=fws[-len(perturbed_supercells):], + ) + ) + + # Add ShengBTE tasks + run_shengbte = RunShengBTE( + db_file=common_settings["DB_FILE"], + wf_uuid=wf_meta["wf_uuid"], + structure=structure, + supercell_matrix=st.transformation_matrix.tolist(), + shengbte_cmd=shengbte_cmd, + temperature=thermal_conductivity_temperature, + ) + shengbte_to_db = ShengBTEToDB( + db_file=common_settings["DB_FILE"], + wf_uuid=wf_meta["wf_uuid"], + ) + fws.append( + Firework( + [run_shengbte, shengbte_to_db], + name="Lattice Thermal Conductivity", + parents=fws[-1] + ) ) - fws.append(csld_fw) formula = structure.composition.reduced_formula - wf_name = "{} - compressed sensing lattice dynamics".format(formula) + wf_name = "{} - lattice dynamics".format(formula) wf = Workflow(fws, name=wf_name) wf = add_additional_fields_to_taskdocs( - wf, {"wf_meta": wf_meta}, task_name_constraint="VaspToDb" + wf, {"wf_meta": wf_meta}, task_name_constraint="VaspToDb" ) return wf -def get_perturbed_supercell_fws( +def get_perturbed_structure_fws( supercell: Structure, common_settings: Optional[Dict] = None, user_incar_settings: Optional[Dict] = None, - max_displacement: float = _MAX_DISPLACEMENT, - min_displacement: float = _MIN_DISPLACEMENT, - num_displacements: int = _NUM_DISPLACEMENTS, - n_cells_per_displacement_distance: int = _CELLS_PER_DISPLACEMENT, - min_random_distance: Optional[float] = _MIN_RANDOM_DISPLACEMENTS, + rattle_stds: Optional[List[float]] = None, + n_configs_per_std: int = 1, + min_nn_scale: float = MIN_NN_SCALE, ) -> List[Firework]: """ Get static calculations to calculate the forces on each perturbed supercell. Args: supercell: Parent supercell structure. - max_displacement: Maximum displacement distance for perturbing the - sites in Angstroms. - min_displacement: Minimum displacement distance for perturbing the - sites in Angstroms. - num_displacements: Number of unique displacement distances to - try, uniformly distributed between ``min_displacement`` and - ``max_displacement``. - n_cells_per_displacement_distance: Number of perturbed - structures to generate for each unique displacement distance. - min_random_distance: If None (default), then for a given perturbed - structure, all atoms will move the same distance from their original - locations. If float, then for a given perturbed structure, the - distances the atoms move will be uniformly distributed from a - minimum distance of ``min_random_distance`` to one of the - displacement distances uniformly sampled between - ``min_displacement`` and ``max_displacement``. common_settings: Common settings dict user_incar_settings: User incar settings override. + rattle_stds: List of standard deviations (in normal distribution) to + to use when displacing the sites. + n_configs_per_std: Number of structures to generate per rattle standard + deviation. + min_nn_scale: Controls the minimum interatomic distance used for + computing the probability for each rattle move. Returns: A list of static fireworks. """ user_incar_settings = user_incar_settings if user_incar_settings else {} + common_settings = _get_common_settings(common_settings) # Generate list of perturbed supercells - perturbed_supercells, disp_dists = generate_perturbed_supercells( + perturbed_supercells, disp_dists = generate_perturbed_structures( supercell, - min_displacement=min_displacement, - max_displacement=max_displacement, - num_displacements=num_displacements, - n_cells_per_displacement_distance=n_cells_per_displacement_distance, - min_random_distance=min_random_distance + rattle_stds=rattle_stds, + n_configs_per_std=n_configs_per_std, + min_nn_scale=min_nn_scale ) fws = [] @@ -256,9 +284,49 @@ def get_perturbed_supercell_fws( vasp_input_set=vis, vasp_cmd=common_settings["VASP_CMD"], db_file=common_settings["DB_FILE"], - name=name + name=name, ) static_fw.spec["displacement_value"] = dist fws.append(static_fw) return fws + + +def _get_common_settings(common_settings: Optional[Dict]): + common_settings = common_settings or {} + for k, v in _DEFAULT_SETTINGS.items(): + if k not in common_settings: + common_settings[k] = v + return common_settings + + +def _get_n_cells( + spacegroup_analyzer: SpacegroupAnalyzer, + min_num_equivalent_sites: int, + max_num_structure: int, +) -> int: + """ + Get the number of supercells to run per rattle standard deviation. + + The aim is to have each equivalent site represented at least + ``min_num_equivalent_sites`` times. For example, if a symmetry inequivalent + site appears 26 times in the supercell structure, `n_configs` would be 4. + I.e., 4 * 26 > 100. + + Args: + spacegroup_analyzer: A spacegroup analyzer object. + min_num_equivalent_sites: The minimum number of equivalent sites. + max_num_structure: The maximum number of cells. + + Returns: + The number of supercells needed for all symmetry inequivalent sites to + be represented at least `min_num_equivalent_sites` times. + """ + # get the equivalent sites in the structure and calculate the smallest + # site degeneracy + equiv_idxs = spacegroup_analyzer.get_symmetry_dataset()["equivalent_atoms"] + equiv_counts = np.unique(equiv_idxs, return_counts=True) + min_count = np.min(equiv_counts) + + n_cells = math.ceil(min_num_equivalent_sites / min_count) + return min(n_cells, max_num_structure) From dee5cc49b8f17f980572cca300a5ee3287dd40b4 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 11:05:49 -0800 Subject: [PATCH 059/207] Add optional requirements --- requirements-optional.txt | 2 ++ 1 file changed, 2 insertions(+) create mode 100644 requirements-optional.txt diff --git a/requirements-optional.txt b/requirements-optional.txt new file mode 100644 index 000000000..8218f9e81 --- /dev/null +++ b/requirements-optional.txt @@ -0,0 +1,2 @@ +f90nml==1.1.2 +ase==3.19.0 From 4b482d629afea843b37bd2a8da8fafebc0ba909a Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 15:43:45 -0800 Subject: [PATCH 060/207] Refactor firetasks to not rely on wf_uuid --- atomate/vasp/firetasks/lattice_dynamics.py | 130 +++++++++------------ 1 file changed, 52 insertions(+), 78 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index e99e21671..eb59783ba 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -3,12 +3,11 @@ from pathlib import Path -from uuid import uuid4 - from datetime import datetime from monty.serialization import dumpfn, loadfn from monty.dev import requires +from pymongo import ReturnDocument from atomate.utils.utils import get_logger, env_chk from atomate.vasp.analysis.lattice_dynamics import ( @@ -53,57 +52,31 @@ @explicit_serialize class CollectPerturbedStructures(FiretaskBase): """ - Aggregate the structures and forces of perturbed supercells. Requires a - wf_uuid from which all perturbed static calculations will be compiled. The - initial structure and supercell transformation matrix will be extracted from - the perturbed structure tasks. + Aggregate the structures and forces of perturbed supercells. - Required parameters: - db_file (str): Path to DB file for the database that contains the - perturbed structure calculations. - wf_uuid (str): Workflow unique identifier. - """ + Requires a ``perturbed_tasks`` key to be set in the fw_spec, containing a + list of dictionaries, each with the keys: - required_params = ["db_file", "wf_uuid"] + - "parent_structure": The original structure. + - "supercell_matrix": The supercell transformation matrix. + - "structure": The perturbed supercell structure. + - "forces": The forces on each site in the supercell. + """ def run_task(self, fw_spec): - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - tasks = mmdb.collection - - query = { - "wf_meta.wf_uuid": self["wf_uuid"], - "task_label": {"$regex": "perturbed static"}, - "state": "successful", - } - projection = ["output.structure", "output.forces", "transformations"] + results = fw_spec.get("perturbed_tasks", []) - logger.info("Fetching structure and forces data") - results = list(tasks.find(query, projection)) + if len(results) == 0: + # can happen if all parents fizzled + raise RuntimeError("No perturbed tasks found in firework spec") logger.info("Found {} perturbed structures".format(len(results))) - all_structures = [] - all_forces = [] - for result in results: - structure = Structure.from_dict(result["output"]["structure"]) - forces = np.asarray(result["output"]["forces"]) - all_structures.append(structure) - all_forces.append(forces) - - if len(all_structures) == 0: - raise RuntimeError( - "Could not find any perturbed structures for workflow uuid: " - "{}".format(self["wf_uuid"]) - ) - else: - transformation = results[-1]["transformations"][0] - t_class = transformation["@class"] - if t_class != "SupercellTransformation": - raise ValueError( - "Expecting SupercellTransformation not {}".format(t_class) - ) - structure = Structure.from_dict(transformation["input_structure"]) - supercell_matrix = transformation["deformation"] + + structure = Structure.from_dict(results[0]["parent_structure"]) + supercell_matrix = results[0]["supercell_matrix"] + + structures = [Structure.from_dict(r["structure"]) for r in results] + forces = [np.asarray(r["forces"]) for r in results] # regenerate pure supercell structure st = SupercellTransformation(supercell_matrix) @@ -116,19 +89,19 @@ def run_task(self, fw_spec): } logger.info("Writing structure and forces data.") - dumpfn(all_structures, "perturbed_structures.json") - dumpfn(all_forces, "perturbed_forces.json") + dumpfn(structures, "perturbed_structures.json") + dumpfn(forces, "perturbed_forces.json") dumpfn(structure_data, "structure_data.json") @requires(hiphive, "hiphive is required for lattice dynamics workflow") @explicit_serialize -class FitForceConstants(FiretaskBase): +class RunHiPhive(FiretaskBase): """ - Used to aggregate atomic forces of perturbed supercells in and fit - force constants using hiPhive. Requires "perturbed_structures.json", - "perturbed_forces.json", and "structure_data.json" files to be present - in the current working directory. + Fit force constants using hiPhive. + + Requires "perturbed_structures.json", "perturbed_forces.json", and + "structure_data.json" files to be present in the current working directory. Optional parameters: cutoffs (Optional[list[list]]): A list of cutoffs to trial. If None, @@ -214,7 +187,7 @@ def run_task(self, fw_spec): @requires(hiphive, "hiphive is required for lattice dynamics workflow") @explicit_serialize -class ForceConstantsToDB(FiretaskBase): +class ForceConstantsToDb(FiretaskBase): """ Add force constants, phonon band structure and density of states to the database. @@ -227,7 +200,6 @@ class ForceConstantsToDB(FiretaskBase): perturbed structure calculations. Optional parameters: - wf_uuid (str): Workflow unique identifier. mesh_density (float): The density of the q-point mesh used to calculate the phonon density of states. See the docstring for the ``mesh`` argument in Phonopy.init_mesh() for more details. @@ -236,7 +208,7 @@ class ForceConstantsToDB(FiretaskBase): """ required_params = ["db_file"] - optional_params = ["wf_uuid", "mesh_density", "additional_fields"] + optional_params = ["mesh_density", "additional_fields"] def run_task(self, fw_spec): from hiphive.force_constants import ForceConstants @@ -247,6 +219,9 @@ def run_task(self, fw_spec): force_constants = ForceConstants.read("force_constants.fcs") fitting_data = loadfn("fitting_data.json") structure_data = loadfn("structure_data.json") + forces = loadfn("perturbed_forces.json") + structures = loadfn("perturbed_structures.json") + structure = structure_data["structure"] supercell_structure = structure_data["supercell_structure"] supercell_matrix = structure_data["supercell_matrix"] @@ -280,12 +255,12 @@ def run_task(self, fw_spec): lm_bs.to_json(), collection="phonon_bandstructure_fs" ) - fc_uuid = str(uuid4()) # additional force constant identifier - data = { "structure": structure.as_dict(), "supercell_matrix": supercell_matrix.tolist(), "supercell_structure": supercell_structure.as_dict(), + "perturbed_structures": [s.to_json() for s in structures], + "perturbed_forces": [f.tolist() for f in forces], "fitting_data": fitting_data, "force_constants": force_constants.get_fc_dict(), "tags": fw_spec.get("tags", None), @@ -293,24 +268,32 @@ def run_task(self, fw_spec): "phonon_dos_fs_id": dos_fsid, "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, "phonon_bandstructure_line_fs_id": lm_bs_fsid, - "wf_meta": {"wf_uuid": self["wf_uuid"], "fc_uuid": fc_uuid}, "created_at": datetime.utcnow(), } data.update(self.get("additional_fields", {})) + # Get an id for the force constants mmdb.collection = mmdb.db["lattice_dynamics"] + fc_id = mmdb.db.counter.find_one_and_update( + {"_id": "taskid"}, {"$inc": {"c": 1}}, + return_document=ReturnDocument.AFTER + )["c"] + metadata = {"fc_id": fc_id, "fc_dir": os.getcwd()} + data.update(metadata) + mmdb.collection.insert_one(data) + logger.info("Finished inserting force constants") - return FWAction(update_spec={"fc_uuid": fc_uuid}) + return FWAction(update_spec=metadata) @explicit_serialize class RunShengBTE(FiretaskBase): """ Run ShengBTE to calculate lattice thermal conductivity. Presumes - the FORCE_CONSTANTS_3ND and FORCE_CONSTANTS_2ND files in the current - directory. In addition, presumes a "structure_data.json" file, with they - keys "structure", " and "supercell_matrix" is in the current directory. + the FORCE_CONSTANTS_3ND and FORCE_CONSTANTS_2ND, and a "structure_data.json" + file, with the keys "structure", " and "supercell_matrix" is in the current + directory. Required parameters: shengbte_cmd (str): The name of the shengbte executable to run. Supports @@ -373,7 +356,7 @@ def run_task(self, fw_spec): @explicit_serialize -class ShengBTEToDB(FiretaskBase): +class ShengBTEToDb(FiretaskBase): """ Add lattice thermal conductivity results to database. @@ -384,15 +367,11 @@ class ShengBTEToDB(FiretaskBase): perturbed structure calculations. Optional parameters: - wf_uuid (str): Workflow unique identifier. - fc_uuid (str): Force constant identifier, used if workflow has multiple - force constants calculated (i.e., using different fit_methods). - additional_fields (dict): Additional fields added to the document, such - as user-defined tags, name, ids, etc. + additional_fields (dict): Additional fields added to the document. """ required_params = ["db_file"] - optional_params = ["wf_uuid", "fc_uuid", "additional_fields"] + optional_params = ["additional_fields"] def run_task(self, fw_spec): db_file = env_chk(self.get("db_file"), fw_spec) @@ -413,13 +392,6 @@ def run_task(self, fw_spec): temperatures = bte_data[:, 0].tolist() kappa = bte_data[:, 1:10].reshape(-1, 3, 3) - wf_meta = {} - if self.get("wf_uuid"): - wf_meta["wf_uuid"] = self["wf_uuid"] - - if self.get("fc_uuid") or fw_spec.get("fc_uuid"): - wf_meta["fc_uuid"] = self.get("fc_uuid", fw_spec.get("fc_uuid")) - data = { "structure": structure.as_dict(), "supercell_matrix": supercell_matrix.tolist(), @@ -428,7 +400,9 @@ def run_task(self, fw_spec): "control": control.to_json(), "tags": fw_spec.get("tags", None), "formula_pretty": structure.composition.reduced_formula, - "wf_meta": wf_meta, + "shengbte_dir": os.getcwd(), + "fc_id": fw_spec.get("fc_id", None), + "fc_dir": fw_spec.get("fc_dir", None), "created_at": datetime.utcnow(), } data.update(self.get("additional_fields", {})) From c21dcc51ff145f9711061008b8fc9d84db6b9e92 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 15:44:22 -0800 Subject: [PATCH 061/207] Refactor lattice dynamics fireworks to remove wf_uuid --- atomate/vasp/fireworks/lattice_dynamics.py | 30 ++++++---------------- 1 file changed, 8 insertions(+), 22 deletions(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 25b82f224..827232d25 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -2,7 +2,7 @@ from atomate.common.firetasks.glue_tasks import PassCalcLocs from atomate.vasp.firetasks.lattice_dynamics import CollectPerturbedStructures, \ - FitForceConstants, ForceConstantsToDB + RunHiPhive, ForceConstantsToDb from atomate.vasp.workflows.base.lattice_dynamics import IMAGINARY_TOL, \ MAX_N_IMAGINARY, MAX_IMAGINARY_FREQ, FIT_METHOD, MESH_DENSITY from fireworks import Firework @@ -15,8 +15,7 @@ class FitForceConstantsFW(Firework): def __init__( self, - wf_uuid, - name="fit force constants", + name="Fit Force Constants", parents: Union[Firework, List[Firework]] = None, db_file: str = None, cutoffs: Optional[List[List[float]]] = None, @@ -25,7 +24,6 @@ def __init__( max_imaginary_freq: float = MAX_IMAGINARY_FREQ, fit_method: str = FIT_METHOD, mesh_density: float = MESH_DENSITY, - additional_fields: dict = None, **kwargs ): """ @@ -33,8 +31,6 @@ def __init__( using hiPhive. Args: - wf_uuid: Workflow identifier, from which the perturbed supercell - static calculations will be compiled. parents: Parent(s) of this Firework. name: Name of this FW. db_file: Path to a db file. @@ -53,31 +49,21 @@ def __init__( mesh_density: The density of the q-point mesh used to calculate the phonon density of states. See the docstring for the ``mesh`` argument in Phonopy.init_mesh() for more details. - additional_fields: Additional fields added to the document, such as - user-defined tags, name, ids, etc. **kwargs: Other kwargs that are passed to Firework.__init__. """ - fw_name = "{}-{}".format(wf_uuid, name) - additional_fields = additional_fields or {} - - collect_structures = CollectPerturbedStructures(db_file, wf_uuid) - fit_constants = FitForceConstants( + collect_structures = CollectPerturbedStructures(db_file) + fit_constants = RunHiPhive( cutoffs=cutoffs, imaginary_tol=imaginary_tol, max_n_imaginary=max_n_imaginary, max_imaginary_freq=max_imaginary_freq, fit_method=fit_method ) - fc_to_db = ForceConstantsToDB( - db_file=db_file, - wf_uuid=wf_uuid, - mesh_density=mesh_density, - additional_fields=additional_fields - ) + fc_to_db = ForceConstantsToDb(db_file=db_file,mesh_density=mesh_density) pass_locs = PassCalcLocs(name=name) tasks = [collect_structures, fit_constants, fc_to_db, pass_locs] - super().__init__(tasks, parents=parents, name=fw_name, **kwargs) + super().__init__(tasks, parents=parents, name=name, **kwargs) class LatticeThermalConductivityFW(Firework): @@ -129,14 +115,14 @@ def __init__( additional_fields = additional_fields or {} collect_structures = CollectPerturbedStructures(db_file, wf_uuid) - fit_constants = FitForceConstants( + fit_constants = RunHiPhive( cutoffs=cutoffs, imaginary_tol=imaginary_tol, max_n_imaginary=max_n_imaginary, max_imaginary_freq=max_imaginary_freq, fit_method=fit_method ) - fc_to_db = ForceConstantsToDB( + fc_to_db = ForceConstantsToDb( db_file=db_file, wf_uuid=wf_uuid, mesh_density=mesh_density, From 960bf83d510a9593f7220c025f078a1d25ce19a1 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 15:44:59 -0800 Subject: [PATCH 062/207] Rewrite lattice dynamics workflow with chaining in mind --- .../vasp/workflows/base/lattice_dynamics.py | 340 +++++++++--------- 1 file changed, 166 insertions(+), 174 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 3c0417831..a21daf112 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -1,30 +1,29 @@ +import warnings import math import numpy as np from copy import deepcopy - -from monty.dev import requires from typing import List, Dict, Optional, Union -from uuid import uuid4 -from atomate.vasp.firetasks.lattice_dynamics import FitForceConstants, \ - ForceConstantsToDB, RunShengBTE, ShengBTEToDB -from pymatgen.io.vasp.sets import MPStaticSet +from pymatgen.io.vasp.sets import MPStaticSet, VaspInputSet from pymatgen.core.structure import Structure from pymatgen.symmetry.analyzer import SpacegroupAnalyzer from pymatgen.transformations.advanced_transformations import ( CubicSupercellTransformation, ) -from fireworks import Workflow, Firework +from monty.dev import requires +from fireworks import Workflow from atomate.utils.utils import get_logger from atomate.vasp.config import VASP_CMD, DB_FILE, SHENGBTE_CMD -from atomate.vasp.fireworks.core import StaticFW +from atomate.vasp.fireworks.core import TransmuterFW from atomate.vasp.powerups import add_additional_fields_to_taskdocs -from atomate.vasp.analysis.lattice_dynamics import generate_perturbed_structures +from atomate.vasp.firetasks import pass_vasp_result +from atomate.vasp.fireworks.lattice_dynamics import FitForceConstantsFW, \ + LatticeThermalConductivityFW try: import hiphive @@ -34,11 +33,10 @@ __author__ = "Rees Chang, Alex Ganose" __email__ = "rc564@cornell.edu, aganose@lbl.gov" __date__ = "July 2019" -__lattice_dynamics_wf_version__ = 1.0 logger = get_logger(__name__) -_static_uis = { +_static_user_incar_settings = { "ADDGRID": True, # Fast Fourier Transform grid "LCHARG": False, "ENCUT": 700, @@ -58,23 +56,17 @@ FIT_METHOD = "least-squares" MESH_DENSITY = 100. # should always be a float _DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} +_WF_VERSION = 1.0 @requires(hiphive, "hiphive is required for lattice dynamics workflow") def get_lattice_dynamics_wf( structure: Structure, common_settings: Dict = None, - symmetrize: bool = False, - symprec: float = 0.01, - min_atoms: Optional[int] = None, - max_atoms: Optional[int] = None, - num_nn_dists: float = 5., - force_diagonal_transformation: bool = True, - rattle_stds: Optional[List[float]] = None, - min_nn_scale: float = MIN_NN_SCALE, - min_num_equivalent_sites: int = 100, - max_num_supercells: int = 30, - dynamic_static_calcs: bool = False, + vasp_input_set: Optional[VaspInputSet] = None, + supercell_matrix_kwargs: Optional[dict] = None, + num_supercell_kwargs: Optional[dict] = None, + perturbed_structure_kwargs: Optional[dict] = None, calculate_lattice_thermal_conductivity: bool = False, thermal_conductivity_temperature: Union[float, Dict] = 300, shengbte_cmd: str = SHENGBTE_CMD, @@ -99,38 +91,21 @@ def get_lattice_dynamics_wf( Args: structure: Initial structure. - common_settings: Common settings dict. - symmetrize: Whether to symmetrize the structure before running the - workflow. - symprec: Symmetry precision for determining the symmetry of the - structure. - min_atoms: Minimum number of atoms to constrain the supercell. - max_atoms: Maximum number of atoms to constrain the supercell. - num_nn_dists: Number of nearest neighbor distances that the shortest - direction of the supercell must be as long as. - force_diagonal_transformation: If True, the supercell - transformation will be constrained to have a diagonal - transformation matrix. If False, the supercell transformation - will not be constrained to be diagonal (resulting in a more - cubic supercell). A diagonal supercell is required to calculate - lattice thermal conductivity. - rattle_stds: List of standard deviations (in normal distribution) to - to use when displacing the sites. - min_nn_scale: Controls the minimum interatomic distance used for - computing the probability for each rattle move. - min_num_equivalent_sites: The minimum number of equivalent sites for - each species. The aim is to have each equivalent site represented at - least ``min_num_equivalent_sites`` times. For example, if a symmetry - inequivalent site appears 26 times in the supercell structure, - and ``min_num_equivalent_sites`` is 100, then at least 4 supercells - are required for that site to appear over 100 times. - max_num_supercells: The maximum number of supercells per displacement. - For very unsymmetric structures, this imposes a hard limit on - the number of sites generated due to ``min_num_equivalent_sites``. - dynamic_static_calcs: If True and hiPhive fails to return all real - harmonic phonon frequencies on the first try, then the workflow - will dynamically create more static perturbed supercell - calculations with larger displacements to improve the fitting. + common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", + and "user_incar_settings" keys. + vasp_input_set: Vasp input set for perturbed structure calculations. + supercell_matrix_kwargs: Options that control the size of the supercell + that will be perturbed. Will be passed directly to + CubicSupercellTransformation in + pymatgen.transformations.advanced_transformations. Note, a diagonal + supercell is required to calculate lattice thermal conductivity. + num_supercell_kwargs: Options that control the number of supercells + generated per perturbation standard deviation distance. See the + docstring of ``get_num_supercells`` for more details. + perturbed_structure_kwargs: Options that control the number of + and magnitude of atomic displacements. Currently, the options are + "rattle_std", "n_configs_per_std", and "min_nn_scale". See the + docstring for ``get_perturbed_structure_wf`` for more details. calculate_lattice_thermal_conductivity: If True and force constant fitting does not return imaginary modes, then use ShengBTE to calculate the lattice thermal conductivity. @@ -142,168 +117,170 @@ def get_lattice_dynamics_wf( to all the previous fireworks' fworker. If str, the ShengBTE firework's fworker will be set to shengbte_fworker. """ + supercell_matrix_kwargs = supercell_matrix_kwargs or {} + num_supercell_kwargs = num_supercell_kwargs or {} + perturbed_structure_kwargs = perturbed_structure_kwargs or {} common_settings = _get_common_settings(common_settings) - uis = deepcopy(_static_uis) - uis.update(common_settings.get("user_incar_settings", {})) - - if not force_diagonal_transformation and calculate_lattice_thermal_conductivity: - raise ValueError( - "Diagonal transformation required to calculate lattice thermal " - "conductivity" - ) + db_file = common_settings["DB_FILE"] - sga = SpacegroupAnalyzer(structure, symprec=symprec) - if symmetrize: - structure = sga.get_primitive_standard_structure() + if calculate_lattice_thermal_conductivity: + if supercell_matrix_kwargs.get("force_diagonal", True): + warnings.warn( + "Diagonal transformation required to calculate lattice thermal " + "conductivity. Forcing diagonal matrix" + ) + supercell_matrix_kwargs["force_diagonal"] = True - st = CubicSupercellTransformation( - min_atoms, - max_atoms, - num_nn_dists, - force_diagonal_transformation=force_diagonal_transformation, - ) + st = CubicSupercellTransformation(**supercell_matrix_kwargs) supercell = st.apply_transformation(structure) + supercell_matrix = st.transformation_matrix - n_cells = _get_n_cells(sga, min_num_equivalent_sites, max_num_supercells) - perturbed_supercells, disp_dists, fws = get_perturbed_structure_fws( - supercell, + if "n_supercells" not in perturbed_structure_kwargs: + n_supercells = get_num_supercells(supercell, **num_supercell_kwargs) + perturbed_structure_kwargs["n_supercells"] = n_supercells + + wf = get_perturbed_structure_wf( + structure, + supercell_matrix=supercell_matrix, + name="ld perturbed structure", + vasp_input_set=vasp_input_set, common_settings=common_settings, - user_incar_settings=uis, - rattle_stds=rattle_stds, - min_nn_scale=min_nn_scale, - n_configs_per_std=n_cells, + pass_forces=True, + **perturbed_structure_kwargs, ) - logger.debug("Generating {} supercells per displacement".format(n_cells)) - logger.debug("Using {} displacements".format(len(disp_dists))) - logger.debug("Displacements: {}".format(disp_dists)) - - wf_meta = { - "wf_uuid": str(uuid4()), - "wf_name": "LatticeDynamicsWF", - "wf_version": __lattice_dynamics_wf_version__, - } - - # Add tasks to fit force constants - fit_forces = FitForceConstants( - db_file=common_settings["DB_FILE"], - wf_uuid=wf_meta["wf_uuid"], - parent_structure=structure, - supercell_structure=supercell, - supercell_matrix=st.transformation_matrix.tolist(), - ) - forces_to_db = ForceConstantsToDB( - db_file=common_settings["DB_FILE"], wf_uuid=wf_meta["wf_uuid"], - ) - fws.append( - Firework( - [fit_forces, forces_to_db], - name="Force Constant Fitting", - parents=fws[-len(perturbed_supercells):], - ) + allow_fizzled = {"_allow_fizzled_parents": True} + fw_fit_force_constant = FitForceConstantsFW( + parents=wf.fws[wf.leaf_fw_ids], db_file=db_file, spec=allow_fizzled ) + wf.fws.append(fw_fit_force_constant) - # Add ShengBTE tasks - run_shengbte = RunShengBTE( - db_file=common_settings["DB_FILE"], - wf_uuid=wf_meta["wf_uuid"], - structure=structure, - supercell_matrix=st.transformation_matrix.tolist(), - shengbte_cmd=shengbte_cmd, - temperature=thermal_conductivity_temperature, - ) - shengbte_to_db = ShengBTEToDB( - db_file=common_settings["DB_FILE"], - wf_uuid=wf_meta["wf_uuid"], - ) - fws.append( - Firework( - [run_shengbte, shengbte_to_db], - name="Lattice Thermal Conductivity", - parents=fws[-1] + if calculate_lattice_thermal_conductivity: + fw_lattice_conductivity = LatticeThermalConductivityFW( + parents=wf.fws[-1], db_file=db_file ) - ) + wf.fws.append(fw_lattice_conductivity) formula = structure.composition.reduced_formula - wf_name = "{} - lattice dynamics".format(formula) + wf.name = "{} - lattice dynamics".format(formula) - wf = Workflow(fws, name=wf_name) - wf = add_additional_fields_to_taskdocs( - wf, {"wf_meta": wf_meta}, task_name_constraint="VaspToDb" - ) + # Add workflow meta data to all relevant *ToDb tasks. + wf_meta = {"wf_name": "LatticeDynamicsWF", "wf_version": _WF_VERSION} + for task_name in ["VaspToDb", "ShengBTEToDb", "ForceConstantsToDb"]: + wf = add_additional_fields_to_taskdocs( + wf, {"wf_meta": wf_meta}, task_name_constraint=task_name + ) return wf -def get_perturbed_structure_fws( - supercell: Structure, +def get_perturbed_structure_wf( + structure: Structure, + supercell_matrix: Optional[np.ndarray], + name: str = "perturbed structure", + vasp_input_set: Optional[VaspInputSet] = None, common_settings: Optional[Dict] = None, - user_incar_settings: Optional[Dict] = None, rattle_stds: Optional[List[float]] = None, n_configs_per_std: int = 1, min_nn_scale: float = MIN_NN_SCALE, -) -> List[Firework]: + pass_forces: bool = True, +) -> Workflow: """ Get static calculations to calculate the forces on each perturbed supercell. Args: - supercell: Parent supercell structure. - common_settings: Common settings dict - user_incar_settings: User incar settings override. + structure: Input structure. + supercell_matrix: Supercell transformation matrix + name: Transmuter firework name. + vasp_input_set: Vasp input set for perturbed structure calculations. + common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", + and "user_incar_settings" keys. rattle_stds: List of standard deviations (in normal distribution) to to use when displacing the sites. n_configs_per_std: Number of structures to generate per rattle standard deviation. min_nn_scale: Controls the minimum interatomic distance used for computing the probability for each rattle move. + pass_forces: Whether to append the force and supercell structure + information into the perturbed_tasks key of the child fireworks. Returns: - A list of static fireworks. + The workflow. """ - user_incar_settings = user_incar_settings if user_incar_settings else {} common_settings = _get_common_settings(common_settings) + vasp_cmd = common_settings["VASP_CMD"] + db_file = common_settings["DB_FILE"] + user_incar_settings = common_settings["user_incar_settings"] - # Generate list of perturbed supercells - perturbed_supercells, disp_dists = generate_perturbed_structures( - supercell, - rattle_stds=rattle_stds, - n_configs_per_std=n_configs_per_std, - min_nn_scale=min_nn_scale - ) + if supercell_matrix is None: + supercell_matrix = np.eye(3) - fws = [] - data = enumerate(zip(perturbed_supercells, disp_dists)) - for i, (supercell, dist) in data: - name = "perturbed supercell, idx: {}, disp_val: {:.3f} static".format( - i, dist - ) + supercell_matrix = np.asarray(supercell_matrix).tolist() + + if rattle_stds is None: + rattle_stds = np.linspace(0.01, 0.1, 5) + + if vasp_input_set is None: + vasp_input_set = MPStaticSet(structure) + else: + # ensure we don't override the user_incar_settings in the input set + user_incar_settings.update(vasp_input_set.user_incar_settings) + vasp_input_set.user_incar_settings = user_incar_settings - vis = MPStaticSet(supercell, user_incar_settings=user_incar_settings) - static_fw = StaticFW( - supercell, - vasp_input_set=vis, - vasp_cmd=common_settings["VASP_CMD"], - db_file=common_settings["DB_FILE"], + min_distance = np.min(structure.distance_matrix) * min_nn_scale + all_rattle_stds = np.repeat(rattle_stds, n_configs_per_std) + + logger.debug("Using {} supercells / displacement".format(n_configs_per_std)) + logger.debug("Using {} rattle stds".format(len(rattle_stds))) + logger.debug("Rattle stds: {}".format(rattle_stds)) + + fws = [] + for i, rattle_std in all_rattle_stds: + name = "{} : i = {}; rattle_std : {:.3f}".format(name, i, rattle_std) + transformations = [ + "SupercellTransformation", "MonteCarloRattleTransformation" + ] + transformation_params = [ + {"scaling_matrix": supercell_matrix}, + {"rattle_std": rattle_std, "min_distance": min_distance} + ] + + fw = TransmuterFW( name=name, + structure=structure, + transformations=transformations, + transformation_params=transformation_params, + vasp_input_set=vasp_input_set, + copy_vasp_outputs=True, + vasp_cmd=vasp_cmd, + db_file=db_file, ) - static_fw.spec["displacement_value"] = dist - fws.append(static_fw) - return fws + if pass_forces: + pass_dict = { + 'parent_structure': structure.to_json(), + 'supercell_matrix': supercell_matrix, + 'forces': '>>output.ionic_steps.-1.forces', + 'structure': '>>output.ionic_steps.-1.structure', + } + pass_task = pass_vasp_result( + pass_dict=pass_dict, + mod_spec_cmd="_push", + mod_spec_key="perturbed_tasks" + ) + fw.tasks.append(pass_task) + fws.append(fw) -def _get_common_settings(common_settings: Optional[Dict]): - common_settings = common_settings or {} - for k, v in _DEFAULT_SETTINGS.items(): - if k not in common_settings: - common_settings[k] = v - return common_settings + wfname = "{}: {}".format(structure.composition.reduced_formula, name) + return Workflow(fws, name=wfname) -def _get_n_cells( - spacegroup_analyzer: SpacegroupAnalyzer, - min_num_equivalent_sites: int, - max_num_structure: int, +def get_num_supercells( + supercell_structure: Structure, + symprec: float = 0.01, + min_num_equivalent_sites: int = 100, + max_num_supercells: int = 30, ) -> int: """ Get the number of supercells to run per rattle standard deviation. @@ -314,9 +291,10 @@ def _get_n_cells( I.e., 4 * 26 > 100. Args: - spacegroup_analyzer: A spacegroup analyzer object. + supercell_structure: The ideal supercell structure. + symprec: The symmetry precision for determining if sites are equivalent. min_num_equivalent_sites: The minimum number of equivalent sites. - max_num_structure: The maximum number of cells. + max_num_supercells: The maximum number of cells. Returns: The number of supercells needed for all symmetry inequivalent sites to @@ -324,9 +302,23 @@ def _get_n_cells( """ # get the equivalent sites in the structure and calculate the smallest # site degeneracy - equiv_idxs = spacegroup_analyzer.get_symmetry_dataset()["equivalent_atoms"] + sga = SpacegroupAnalyzer(supercell_structure, symprec=symprec) + equiv_idxs = sga.get_symmetry_dataset()["equivalent_atoms"] equiv_counts = np.unique(equiv_idxs, return_counts=True) min_count = np.min(equiv_counts) n_cells = math.ceil(min_num_equivalent_sites / min_count) - return min(n_cells, max_num_structure) + return min(n_cells, max_num_supercells) + + +def _get_common_settings(common_settings: Optional[Dict]): + common_settings = common_settings or {} + for k, v in _DEFAULT_SETTINGS.items(): + if k not in common_settings: + common_settings[k] = v + + user_incar_settings = deepcopy(_static_user_incar_settings) + user_incar_settings.update(common_settings.get("user_incar_settings", {})) + common_settings["user_incar_settings"] = user_incar_settings + + return common_settings From 6c56cea16ed8cb317016aed5c29c0ce68e34f3ff Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 15:45:12 -0800 Subject: [PATCH 063/207] Add pymongo to requirements --- requirements.txt | 16 ++++++++++++++++ 1 file changed, 16 insertions(+) create mode 100644 requirements.txt diff --git a/requirements.txt b/requirements.txt new file mode 100644 index 000000000..a8b26d3e4 --- /dev/null +++ b/requirements.txt @@ -0,0 +1,16 @@ +numpy==1.16.4 +scipy==1.2.0 +FireWorks==1.9.0 +pymatgen_diffusion==2019.2.28 +monty==2.0.4 +paramiko==2.4.2 +tqdm==4.32.1 +six==1.12.0 +pybtex==0.22.2 +ruamel.yaml==0.15.96 +pandas==0.24.2 +pymatgen==2019.5.8 +custodian==2019.2.10 +networkx==2.2 +pydash==4.7.4 +pymongo==3.10.1 From 294602dff6d2b1eea7c08a70ed62e2a504873a57 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 15:55:52 -0800 Subject: [PATCH 064/207] Remove circular imports --- atomate/vasp/analysis/lattice_dynamics.py | 68 ++----------------- atomate/vasp/analysis/phonopy.py | 2 + atomate/vasp/firetasks/lattice_dynamics.py | 12 ++-- .../vasp/workflows/base/lattice_dynamics.py | 15 ++-- 4 files changed, 16 insertions(+), 81 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index c6d1a05ce..bdb425160 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -1,76 +1,22 @@ import numpy as np from itertools import product -from typing import Optional, Tuple, List, Dict +from typing import Tuple, List, Dict from pymatgen import Structure -from pymatgen.io.ase import AseAtomsAdaptor from pymatgen.io.phonopy import get_phonopy_structure from atomate.utils.utils import get_logger -from atomate.vasp.workflows.base.lattice_dynamics import ( - MIN_NN_SCALE, - FIT_METHOD, - MAX_IMAGINARY_FREQ, - IMAGINARY_TOL, - MAX_N_IMAGINARY, -) __author__ = "Rees Chang, Alex Ganose" __email__ = "rc564@cornell.edu, aganose@lbl.gov" - logger = get_logger(__name__) - -def generate_perturbed_structures( - structure: Structure, - rattle_stds: Optional[List[float]] = None, - n_configs_per_std: int = 1, - min_nn_scale: float = MIN_NN_SCALE, -) -> Tuple[List[Structure], np.ndarray]: - """ - Generate a list of structures with perturbed atomic sites. - - Rattling atom `i` is carried out as a Monte Carlo move that is accepted with - a probability determined from the minimum interatomic distance - :math:`d_{ij}`. If :math:`\\min(d_{ij})` is smaller than :math:`d_{min}` - the move is only accepted with a low probability. - - :math:`d_{min}` is calculated as the smallest nearest neighbor distance - times ``min_nn_fraction``. - - Args: - structure: Structure whose atomic sites are to be perturbed. - rattle_stds: List of standard deviations (in normal distribution) to - to use when displacing the sites. - n_configs_per_std: Number of structures to generate per rattle standard - deviation. - min_nn_scale: Controls the minimum interatomic distance used for - computing the probability for each rattle move. - - Returns: - A tuple of the ``(structures, displacements)``. Where ``structures`` is - a list of randomly displaced structures, and ``displacements`` is - the displacement distance for each structure. - """ - from hiphive.structure_generation import generate_mc_rattled_structures - - if rattle_stds is None: - rattle_stds = np.linspace(0.01, 0.1, 5) - - min_distance = np.min(structure.distance_matrix) * min_nn_scale - atoms = AseAtomsAdaptor.get_atoms(structure) - - perturbed_structures = [] - for rattle_std in rattle_stds: - seed = np.random.randint(1, 10000000000) - structures = generate_mc_rattled_structures( - atoms, n_configs_per_std, rattle_std, min_distance, seed=seed - ) - perturbed_structures.extend(structures) - - return perturbed_structures, rattle_stds +MAX_IMAGINARY_FREQ = 10 # in THz +IMAGINARY_TOL = 0.025 # in THz +MAX_N_IMAGINARY = 3 +FIT_METHOD = "least-squares" def get_cutoffs(structure: Structure): @@ -204,9 +150,7 @@ def fit_force_constants( } n_cutoffs = len(all_cutoffs) for i, cutoffs in enumerate(all_cutoffs): - logger.info( - "Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs) - ) + logger.info("Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs)) sc = get_structure_container(cutoffs, structures) opt = Optimizer(sc.get_fit_data(), fit_method) opt.train() diff --git a/atomate/vasp/analysis/phonopy.py b/atomate/vasp/analysis/phonopy.py index 3923895ab..451a05b08 100644 --- a/atomate/vasp/analysis/phonopy.py +++ b/atomate/vasp/analysis/phonopy.py @@ -28,6 +28,8 @@ __email__ = "kmathew@lbl.gov, aganose@lbl.gov" >>>>>>> 728556b6 (Add methods for generating phonon band structure & DOS) +MESH_DENSITY = 100. # should always be a float + # TODO: @matk86 - unit tests? diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index eb59783ba..afac7df2d 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -13,20 +13,13 @@ from atomate.vasp.analysis.lattice_dynamics import ( fit_force_constants, get_cutoffs, -) + MAX_N_IMAGINARY, MAX_IMAGINARY_FREQ, IMAGINARY_TOL, FIT_METHOD) from atomate.vasp.analysis.phonopy import ( get_phonon_dos, get_phonon_band_structure, get_line_mode_phonon_band_structure, ) from atomate.vasp.database import VaspCalcDb -from atomate.vasp.workflows.base.lattice_dynamics import ( - MAX_N_IMAGINARY, - MAX_IMAGINARY_FREQ, - IMAGINARY_TOL, - FIT_METHOD, - DEFAULT_TEMPERATURE, - MESH_DENSITY) from fireworks import explicit_serialize, FiretaskBase, FWAction import numpy as np @@ -48,6 +41,9 @@ logger = get_logger(__name__) +# define shared constants +DEFAULT_TEMPERATURE = 300 + @explicit_serialize class CollectPerturbedStructures(FiretaskBase): diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index a21daf112..a3d186df4 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -6,7 +6,7 @@ from copy import deepcopy from typing import List, Dict, Optional, Union - +from atomate.vasp.firetasks.lattice_dynamics import DEFAULT_TEMPERATURE from pymatgen.io.vasp.sets import MPStaticSet, VaspInputSet from pymatgen.core.structure import Structure from pymatgen.symmetry.analyzer import SpacegroupAnalyzer @@ -47,14 +47,7 @@ "LASPH": True, } -# define shared constants -MIN_NN_SCALE = 0.85 -MAX_IMAGINARY_FREQ = 10 # in THz -IMAGINARY_TOL = 0.025 # in THz -MAX_N_IMAGINARY = 3 -DEFAULT_TEMPERATURE = 300 -FIT_METHOD = "least-squares" -MESH_DENSITY = 100. # should always be a float + _DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} _WF_VERSION = 1.0 @@ -68,7 +61,7 @@ def get_lattice_dynamics_wf( num_supercell_kwargs: Optional[dict] = None, perturbed_structure_kwargs: Optional[dict] = None, calculate_lattice_thermal_conductivity: bool = False, - thermal_conductivity_temperature: Union[float, Dict] = 300, + thermal_conductivity_temperature: Union[float, Dict] = DEFAULT_TEMPERATURE, shengbte_cmd: str = SHENGBTE_CMD, shengbte_fworker: Optional[str] = None, ): @@ -182,7 +175,7 @@ def get_perturbed_structure_wf( common_settings: Optional[Dict] = None, rattle_stds: Optional[List[float]] = None, n_configs_per_std: int = 1, - min_nn_scale: float = MIN_NN_SCALE, + min_nn_scale: float = 0.85, pass_forces: bool = True, ) -> Workflow: """ From 95b2a6070abe9d42cee4ee6088262fa567a71cbe Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 16:37:12 -0800 Subject: [PATCH 065/207] Use proper name for 3rd order fc --- atomate/vasp/firetasks/lattice_dynamics.py | 14 +++++++------- 1 file changed, 7 insertions(+), 7 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index afac7df2d..3af069f71 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -18,7 +18,7 @@ get_phonon_dos, get_phonon_band_structure, get_line_mode_phonon_band_structure, -) + MESH_DENSITY) from atomate.vasp.database import VaspCalcDb from fireworks import explicit_serialize, FiretaskBase, FWAction import numpy as np @@ -175,7 +175,7 @@ def run_task(self, fw_spec): force_constants.write("force_constants.fcs") atoms = AseAtomsAdaptor.get_atoms(parent_structure) - force_constants.write_to_shengBTE("FORCE_CONSTANTS_3ND", atoms) + force_constants.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms) force_constants.write_to_phonopy( "FORCE_CONSTANTS_2ND", format="text" ) @@ -287,7 +287,7 @@ def run_task(self, fw_spec): class RunShengBTE(FiretaskBase): """ Run ShengBTE to calculate lattice thermal conductivity. Presumes - the FORCE_CONSTANTS_3ND and FORCE_CONSTANTS_2ND, and a "structure_data.json" + the FORCE_CONSTANTS_3RD and FORCE_CONSTANTS_2ND, and a "structure_data.json" file, with the keys "structure", " and "supercell_matrix" is in the current directory. @@ -299,12 +299,12 @@ class RunShengBTE(FiretaskBase): temperature (float or dict): The temperature to calculate the lattice thermal conductivity for. Can be given as a single float, or a dictionary with the keys "min", "max", "step". - shengbte_control_kwargs (dict): Options to be included in the ShengBTE - control file. + control_kwargs (dict): Options to be included in the ShengBTE control + file. """ required_params = ["shengbte_cmd"] - optional_params = ["temperature", "shengbte_control_kwargs"] + optional_params = ["temperature", "control_kwargs"] def run_task(self, fw_spec): structure_data = loadfn("structure_data.json") @@ -318,7 +318,7 @@ def run_task(self, fw_spec): "temperature": self.get("temperature", DEFAULT_TEMPERATURE), "scell": np.diag(supercell_matrix), } - control_dict.update(self.get("shengbte_control_kwargs", {})) + control_dict.update(self.get("control_kwargs", {})) control = Control.from_structure(structure, **control_dict) control.to_file() From a3ad5f2c11cd7c336a74fa7fbc8aed53658c346b Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 16:37:44 -0800 Subject: [PATCH 066/207] Refactor lattice dynamics fireworks --- atomate/vasp/fireworks/lattice_dynamics.py | 103 ++++++++++----------- 1 file changed, 47 insertions(+), 56 deletions(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 827232d25..f0beb661f 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -1,10 +1,14 @@ from typing import Optional, List, Union -from atomate.common.firetasks.glue_tasks import PassCalcLocs +from atomate.common.firetasks.glue_tasks import PassCalcLocs, \ + CopyFilesFromCalcLoc, CopyFiles +from atomate.vasp.analysis.lattice_dynamics import IMAGINARY_TOL, \ + MAX_N_IMAGINARY, MAX_IMAGINARY_FREQ, FIT_METHOD +from atomate.vasp.analysis.phonopy import MESH_DENSITY +from atomate.vasp.config import SHENGBTE_CMD from atomate.vasp.firetasks.lattice_dynamics import CollectPerturbedStructures, \ - RunHiPhive, ForceConstantsToDb -from atomate.vasp.workflows.base.lattice_dynamics import IMAGINARY_TOL, \ - MAX_N_IMAGINARY, MAX_IMAGINARY_FREQ, FIT_METHOD, MESH_DENSITY + RunHiPhive, ForceConstantsToDb, DEFAULT_TEMPERATURE, ShengBTEToDb, \ + RunShengBTE from fireworks import Firework __author__ = "Alex Ganose" @@ -16,7 +20,7 @@ class FitForceConstantsFW(Firework): def __init__( self, name="Fit Force Constants", - parents: Union[Firework, List[Firework]] = None, + parents: Optional[Union[Firework, List[Firework]]] = None, db_file: str = None, cutoffs: Optional[List[List[float]]] = None, imaginary_tol: float = IMAGINARY_TOL, @@ -59,10 +63,10 @@ def __init__( max_imaginary_freq=max_imaginary_freq, fit_method=fit_method ) - fc_to_db = ForceConstantsToDb(db_file=db_file,mesh_density=mesh_density) + to_db = ForceConstantsToDb(db_file=db_file, mesh_density=mesh_density) pass_locs = PassCalcLocs(name=name) - tasks = [collect_structures, fit_constants, fc_to_db, pass_locs] + tasks = [collect_structures, fit_constants, to_db, pass_locs] super().__init__(tasks, parents=parents, name=name, **kwargs) @@ -70,65 +74,52 @@ class LatticeThermalConductivityFW(Firework): def __init__( self, - name="fit force constants", - parents: Union[Firework, List[Firework]] = None, + name="Lattice Thermal Conductivity", + parents: Optional[Union[Firework, List[Firework]]] = None, + prev_calc_dir: Optional[str] = None, db_file: str = None, - cutoffs: Optional[List[List[float]]] = None, - imaginary_tol: float = IMAGINARY_TOL, - max_n_imaginary: int = MAX_N_IMAGINARY, - max_imaginary_freq: float = MAX_IMAGINARY_FREQ, - fit_method: str = FIT_METHOD, - mesh_density: float = MESH_DENSITY, - additional_fields: dict = None, + shengbte_cmd: str = SHENGBTE_CMD, + temperature: Union[float, dict] = DEFAULT_TEMPERATURE, + shengbte_control_kwargs: Optional[dict] = None, **kwargs ): """ - Compile perturbed supercell calculations and fit force constants - using hiPhive. + Calculate the lattice thermal conductivity using ShengBTE. Args: - wf_uuid: Workflow identifier, from which the perturbed supercell - static calculations will be compiled. - parents: Parent(s) of this Firework. name: Name of this FW. + parents: Parent(s) of this Firework. + prev_calc_dir: Path to a directory containing the force constant + information. Will override ``parents`` when collecting the force + constants to run ShengBTE. db_file: Path to a db file. - cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs - will be generated based on the structure (default). - imaginary_tol: Tolerance used to decide if a phonon mode is - imaginary, in THz. - max_n_imaginary: Maximum number of imaginary modes allowed in the - final fitted force constant solution. If this criteria is not - reached by any cutoff combination the Firework will fizzle. - max_imaginary_freq: Maximum allowed imaginary frequency in the - final fitted force constant solution. If this criteria is not - reached by any cutoff combination this FireTask will fizzle. - fit_method: Method used for fitting force constants. This can be - any of the values allowed by the hiphive ``Optimizer`` class. - mesh_density: The density of the q-point mesh used to calculate the - phonon density of states. See the docstring for the ``mesh`` - argument in Phonopy.init_mesh() for more details. - additional_fields: Additional fields added to the document, such as - user-defined tags, name, ids, etc. + shengbte_cmd: The name of the shengbte executable to run. Supports + env_chk. + temperature: The temperature to calculate the lattice thermal + conductivity for. Can be given as a single float, or a + dictionary with the keys "min", "max", "step". + shengbte_control_kwargs: Options to be included in the ShengBTE + control file. **kwargs: Other kwargs that are passed to Firework.__init__. """ - fw_name = "{}-{}".format(wf_uuid, name) - additional_fields = additional_fields or {} + # files needed to run ShengBTE + files = [ + "structure_data.json", "FORCE_CONSTANTS_2ND", "FORCE_CONSTANTS_3RD" + ] - collect_structures = CollectPerturbedStructures(db_file, wf_uuid) - fit_constants = RunHiPhive( - cutoffs=cutoffs, - imaginary_tol=imaginary_tol, - max_n_imaginary=max_n_imaginary, - max_imaginary_freq=max_imaginary_freq, - fit_method=fit_method - ) - fc_to_db = ForceConstantsToDb( - db_file=db_file, - wf_uuid=wf_uuid, - mesh_density=mesh_density, - additional_fields=additional_fields + if prev_calc_dir: + copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) + elif parents: + copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + else: + raise ValueError("Must specify parents or prev_calc_dir.") + + run_shengbte = RunShengBTE( + shengbte_cmd=shengbte_cmd, + temperature=temperature, + control_kwargs=shengbte_control_kwargs ) - pass_locs = PassCalcLocs(name=name) + shengbte_to_db = ShengBTEToDb(db_file=db_file) - tasks = [collect_structures, fit_constants, fc_to_db, pass_locs] - super().__init__(tasks, parents=parents, name=fw_name, **kwargs) + tasks = [copy_files, run_shengbte, shengbte_to_db] + super().__init__(tasks, parents=parents, name=name, **kwargs) From 159c6f9bcde8333b9f1b045d6a9d3aac24d466c8 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 16:38:05 -0800 Subject: [PATCH 067/207] Use latest fireworks in LD workflow --- atomate/vasp/workflows/base/lattice_dynamics.py | 17 ++++++++--------- 1 file changed, 8 insertions(+), 9 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index a3d186df4..6e1101bc1 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -14,7 +14,6 @@ CubicSupercellTransformation, ) -from monty.dev import requires from fireworks import Workflow from atomate.utils.utils import get_logger @@ -25,11 +24,6 @@ from atomate.vasp.fireworks.lattice_dynamics import FitForceConstantsFW, \ LatticeThermalConductivityFW -try: - import hiphive -except ImportError: - hiphive = False - __author__ = "Rees Chang, Alex Ganose" __email__ = "rc564@cornell.edu, aganose@lbl.gov" __date__ = "July 2019" @@ -52,7 +46,6 @@ _WF_VERSION = 1.0 -@requires(hiphive, "hiphive is required for lattice dynamics workflow") def get_lattice_dynamics_wf( structure: Structure, common_settings: Dict = None, @@ -150,14 +143,20 @@ def get_lattice_dynamics_wf( if calculate_lattice_thermal_conductivity: fw_lattice_conductivity = LatticeThermalConductivityFW( - parents=wf.fws[-1], db_file=db_file + parents=wf.fws[-1], + db_file=db_file, + shengbte_cmd=shengbte_cmd, + temperature=thermal_conductivity_temperature ) + if shengbte_fworker: + fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker + wf.fws.append(fw_lattice_conductivity) formula = structure.composition.reduced_formula wf.name = "{} - lattice dynamics".format(formula) - # Add workflow meta data to all relevant *ToDb tasks. + # Add workflow metadata to all relevant *ToDb tasks. wf_meta = {"wf_name": "LatticeDynamicsWF", "wf_version": _WF_VERSION} for task_name in ["VaspToDb", "ShengBTEToDb", "ForceConstantsToDb"]: wf = add_additional_fields_to_taskdocs( From 705e4ac69127b5cc002ba72dddcdb0ba28afbe82 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 16:41:12 -0800 Subject: [PATCH 068/207] Run isort and black --- atomate/vasp/analysis/lattice_dynamics.py | 13 +- atomate/vasp/analysis/phonopy.py | 4 +- atomate/vasp/firetasks/lattice_dynamics.py | 31 ++-- atomate/vasp/fireworks/lattice_dynamics.py | 142 ++++++++++-------- .../vasp/workflows/base/lattice_dynamics.py | 46 +++--- 5 files changed, 127 insertions(+), 109 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index bdb425160..8f5c6f71a 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -1,12 +1,11 @@ -import numpy as np - from itertools import product -from typing import Tuple, List, Dict +from typing import Dict, List, Tuple -from pymatgen import Structure -from pymatgen.io.phonopy import get_phonopy_structure +import numpy as np from atomate.utils.utils import get_logger +from pymatgen import Structure +from pymatgen.io.phonopy import get_phonopy_structure __author__ = "Rees Chang, Alex Ganose" __email__ = "rc564@cornell.edu, aganose@lbl.gov" @@ -150,7 +149,9 @@ def fit_force_constants( } n_cutoffs = len(all_cutoffs) for i, cutoffs in enumerate(all_cutoffs): - logger.info("Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs)) + logger.info( + "Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs) + ) sc = get_structure_container(cutoffs, structures) opt = Optimizer(sc.get_fit_data(), fit_method) opt.train() diff --git a/atomate/vasp/analysis/phonopy.py b/atomate/vasp/analysis/phonopy.py index 451a05b08..490dad612 100644 --- a/atomate/vasp/analysis/phonopy.py +++ b/atomate/vasp/analysis/phonopy.py @@ -16,7 +16,7 @@ PhononBandStructure, PhononBandStructureSymmLine, ) -from pymatgen.phonon.dos import PhononDos, CompletePhononDos +from pymatgen.phonon.dos import CompletePhononDos, PhononDos from pymatgen.symmetry.bandstructure import HighSymmKpath try: @@ -28,7 +28,7 @@ __email__ = "kmathew@lbl.gov, aganose@lbl.gov" >>>>>>> 728556b6 (Add methods for generating phonon band structure & DOS) -MESH_DENSITY = 100. # should always be a float +MESH_DENSITY = 100.0 # should always be a float # TODO: @matk86 - unit tests? diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 3af069f71..70b792145 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -1,28 +1,30 @@ import os import shlex - -from pathlib import Path - from datetime import datetime +from pathlib import Path -from monty.serialization import dumpfn, loadfn +import numpy as np from monty.dev import requires +from monty.serialization import dumpfn, loadfn from pymongo import ReturnDocument -from atomate.utils.utils import get_logger, env_chk +from atomate.utils.utils import env_chk, get_logger from atomate.vasp.analysis.lattice_dynamics import ( + FIT_METHOD, + IMAGINARY_TOL, + MAX_IMAGINARY_FREQ, + MAX_N_IMAGINARY, fit_force_constants, get_cutoffs, - MAX_N_IMAGINARY, MAX_IMAGINARY_FREQ, IMAGINARY_TOL, FIT_METHOD) +) from atomate.vasp.analysis.phonopy import ( - get_phonon_dos, - get_phonon_band_structure, + MESH_DENSITY, get_line_mode_phonon_band_structure, - MESH_DENSITY) + get_phonon_band_structure, + get_phonon_dos, +) from atomate.vasp.database import VaspCalcDb -from fireworks import explicit_serialize, FiretaskBase, FWAction -import numpy as np - +from fireworks import FiretaskBase, FWAction, explicit_serialize from pymatgen import Structure from pymatgen.io.ase import AseAtomsAdaptor from pymatgen.io.shengbte import Control @@ -271,8 +273,9 @@ def run_task(self, fw_spec): # Get an id for the force constants mmdb.collection = mmdb.db["lattice_dynamics"] fc_id = mmdb.db.counter.find_one_and_update( - {"_id": "taskid"}, {"$inc": {"c": 1}}, - return_document=ReturnDocument.AFTER + {"_id": "taskid"}, + {"$inc": {"c": 1}}, + return_document=ReturnDocument.AFTER, )["c"] metadata = {"fc_id": fc_id, "fc_dir": os.getcwd()} data.update(metadata) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index f0beb661f..360e98c45 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -1,14 +1,26 @@ -from typing import Optional, List, Union +from typing import List, Optional, Union -from atomate.common.firetasks.glue_tasks import PassCalcLocs, \ - CopyFilesFromCalcLoc, CopyFiles -from atomate.vasp.analysis.lattice_dynamics import IMAGINARY_TOL, \ - MAX_N_IMAGINARY, MAX_IMAGINARY_FREQ, FIT_METHOD +from atomate.common.firetasks.glue_tasks import ( + CopyFiles, + CopyFilesFromCalcLoc, + PassCalcLocs, +) +from atomate.vasp.analysis.lattice_dynamics import ( + FIT_METHOD, + IMAGINARY_TOL, + MAX_IMAGINARY_FREQ, + MAX_N_IMAGINARY, +) from atomate.vasp.analysis.phonopy import MESH_DENSITY from atomate.vasp.config import SHENGBTE_CMD -from atomate.vasp.firetasks.lattice_dynamics import CollectPerturbedStructures, \ - RunHiPhive, ForceConstantsToDb, DEFAULT_TEMPERATURE, ShengBTEToDb, \ - RunShengBTE +from atomate.vasp.firetasks.lattice_dynamics import ( + DEFAULT_TEMPERATURE, + CollectPerturbedStructures, + ForceConstantsToDb, + RunHiPhive, + RunShengBTE, + ShengBTEToDb, +) from fireworks import Firework __author__ = "Alex Ganose" @@ -16,6 +28,31 @@ class FitForceConstantsFW(Firework): + """ + Compile perturbed supercell calculations and fit force constants + using hiPhive. + + Args: + parents: Parent(s) of this Firework. + name: Name of this FW. + db_file: Path to a db file. + cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs + will be generated based on the structure (default). + imaginary_tol: Tolerance used to decide if a phonon mode is + imaginary, in THz. + max_n_imaginary: Maximum number of imaginary modes allowed in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination the Firework will fizzle. + max_imaginary_freq: Maximum allowed imaginary frequency in the + final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + fit_method: Method used for fitting force constants. This can be + any of the values allowed by the hiphive ``Optimizer`` class. + mesh_density: The density of the q-point mesh used to calculate the + phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ def __init__( self, @@ -30,38 +67,13 @@ def __init__( mesh_density: float = MESH_DENSITY, **kwargs ): - """ - Compile perturbed supercell calculations and fit force constants - using hiPhive. - - Args: - parents: Parent(s) of this Firework. - name: Name of this FW. - db_file: Path to a db file. - cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs - will be generated based on the structure (default). - imaginary_tol: Tolerance used to decide if a phonon mode is - imaginary, in THz. - max_n_imaginary: Maximum number of imaginary modes allowed in the - final fitted force constant solution. If this criteria is not - reached by any cutoff combination the Firework will fizzle. - max_imaginary_freq: Maximum allowed imaginary frequency in the - final fitted force constant solution. If this criteria is not - reached by any cutoff combination this FireTask will fizzle. - fit_method: Method used for fitting force constants. This can be - any of the values allowed by the hiphive ``Optimizer`` class. - mesh_density: The density of the q-point mesh used to calculate the - phonon density of states. See the docstring for the ``mesh`` - argument in Phonopy.init_mesh() for more details. - **kwargs: Other kwargs that are passed to Firework.__init__. - """ collect_structures = CollectPerturbedStructures(db_file) fit_constants = RunHiPhive( cutoffs=cutoffs, imaginary_tol=imaginary_tol, max_n_imaginary=max_n_imaginary, max_imaginary_freq=max_imaginary_freq, - fit_method=fit_method + fit_method=fit_method, ) to_db = ForceConstantsToDb(db_file=db_file, mesh_density=mesh_density) pass_locs = PassCalcLocs(name=name) @@ -71,40 +83,42 @@ def __init__( class LatticeThermalConductivityFW(Firework): + """ + Calculate the lattice thermal conductivity using ShengBTE. + + Args: + name: Name of this FW. + parents: Parent(s) of this Firework. + prev_calc_dir: Path to a directory containing the force constant + information. Will override ``parents`` when collecting the force + constants to run ShengBTE. + db_file: Path to a db file. + shengbte_cmd: The name of the shengbte executable to run. Supports + env_chk. + temperature: The temperature to calculate the lattice thermal + conductivity for. Can be given as a single float, or a + dictionary with the keys "min", "max", "step". + shengbte_control_kwargs: Options to be included in the ShengBTE + control file. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ def __init__( - self, - name="Lattice Thermal Conductivity", - parents: Optional[Union[Firework, List[Firework]]] = None, - prev_calc_dir: Optional[str] = None, - db_file: str = None, - shengbte_cmd: str = SHENGBTE_CMD, - temperature: Union[float, dict] = DEFAULT_TEMPERATURE, - shengbte_control_kwargs: Optional[dict] = None, - **kwargs + self, + name="Lattice Thermal Conductivity", + parents: Optional[Union[Firework, List[Firework]]] = None, + prev_calc_dir: Optional[str] = None, + db_file: str = None, + shengbte_cmd: str = SHENGBTE_CMD, + temperature: Union[float, dict] = DEFAULT_TEMPERATURE, + shengbte_control_kwargs: Optional[dict] = None, + **kwargs ): - """ - Calculate the lattice thermal conductivity using ShengBTE. - - Args: - name: Name of this FW. - parents: Parent(s) of this Firework. - prev_calc_dir: Path to a directory containing the force constant - information. Will override ``parents`` when collecting the force - constants to run ShengBTE. - db_file: Path to a db file. - shengbte_cmd: The name of the shengbte executable to run. Supports - env_chk. - temperature: The temperature to calculate the lattice thermal - conductivity for. Can be given as a single float, or a - dictionary with the keys "min", "max", "step". - shengbte_control_kwargs: Options to be included in the ShengBTE - control file. - **kwargs: Other kwargs that are passed to Firework.__init__. - """ # files needed to run ShengBTE files = [ - "structure_data.json", "FORCE_CONSTANTS_2ND", "FORCE_CONSTANTS_3RD" + "structure_data.json", + "FORCE_CONSTANTS_2ND", + "FORCE_CONSTANTS_3RD", ] if prev_calc_dir: @@ -117,7 +131,7 @@ def __init__( run_shengbte = RunShengBTE( shengbte_cmd=shengbte_cmd, temperature=temperature, - control_kwargs=shengbte_control_kwargs + control_kwargs=shengbte_control_kwargs, ) shengbte_to_db = ShengBTEToDb(db_file=db_file) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 6e1101bc1..1d020b548 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -1,29 +1,28 @@ -import warnings import math +import warnings +from copy import deepcopy +from typing import Dict, List, Optional, Union import numpy as np -from copy import deepcopy -from typing import List, Dict, Optional, Union - +from atomate.utils.utils import get_logger +from atomate.vasp.config import DB_FILE, SHENGBTE_CMD, VASP_CMD +from atomate.vasp.firetasks import pass_vasp_result from atomate.vasp.firetasks.lattice_dynamics import DEFAULT_TEMPERATURE -from pymatgen.io.vasp.sets import MPStaticSet, VaspInputSet +from atomate.vasp.fireworks.core import TransmuterFW +from atomate.vasp.fireworks.lattice_dynamics import ( + FitForceConstantsFW, + LatticeThermalConductivityFW, +) +from atomate.vasp.powerups import add_additional_fields_to_taskdocs +from fireworks import Workflow from pymatgen.core.structure import Structure +from pymatgen.io.vasp.sets import MPStaticSet, VaspInputSet from pymatgen.symmetry.analyzer import SpacegroupAnalyzer from pymatgen.transformations.advanced_transformations import ( CubicSupercellTransformation, ) -from fireworks import Workflow - -from atomate.utils.utils import get_logger -from atomate.vasp.config import VASP_CMD, DB_FILE, SHENGBTE_CMD -from atomate.vasp.fireworks.core import TransmuterFW -from atomate.vasp.powerups import add_additional_fields_to_taskdocs -from atomate.vasp.firetasks import pass_vasp_result -from atomate.vasp.fireworks.lattice_dynamics import FitForceConstantsFW, \ - LatticeThermalConductivityFW - __author__ = "Rees Chang, Alex Ganose" __email__ = "rc564@cornell.edu, aganose@lbl.gov" __date__ = "July 2019" @@ -146,7 +145,7 @@ def get_lattice_dynamics_wf( parents=wf.fws[-1], db_file=db_file, shengbte_cmd=shengbte_cmd, - temperature=thermal_conductivity_temperature + temperature=thermal_conductivity_temperature, ) if shengbte_fworker: fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker @@ -230,11 +229,12 @@ def get_perturbed_structure_wf( for i, rattle_std in all_rattle_stds: name = "{} : i = {}; rattle_std : {:.3f}".format(name, i, rattle_std) transformations = [ - "SupercellTransformation", "MonteCarloRattleTransformation" + "SupercellTransformation", + "MonteCarloRattleTransformation", ] transformation_params = [ {"scaling_matrix": supercell_matrix}, - {"rattle_std": rattle_std, "min_distance": min_distance} + {"rattle_std": rattle_std, "min_distance": min_distance}, ] fw = TransmuterFW( @@ -250,15 +250,15 @@ def get_perturbed_structure_wf( if pass_forces: pass_dict = { - 'parent_structure': structure.to_json(), - 'supercell_matrix': supercell_matrix, - 'forces': '>>output.ionic_steps.-1.forces', - 'structure': '>>output.ionic_steps.-1.structure', + "parent_structure": structure.to_json(), + "supercell_matrix": supercell_matrix, + "forces": ">>output.ionic_steps.-1.forces", + "structure": ">>output.ionic_steps.-1.structure", } pass_task = pass_vasp_result( pass_dict=pass_dict, mod_spec_cmd="_push", - mod_spec_key="perturbed_tasks" + mod_spec_key="perturbed_tasks", ) fw.tasks.append(pass_task) From 20cf9e322a5da35b00a3ad0c38c7a78db8daccc5 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 16:47:05 -0800 Subject: [PATCH 069/207] Update docstrings --- .../vasp/workflows/base/lattice_dynamics.py | 25 +++++++++++-------- 1 file changed, 15 insertions(+), 10 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 1d020b548..44f806793 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -63,25 +63,30 @@ def get_lattice_dynamics_wf( A summary of the workflow is as follows: - 1. Transform the input structure into a supercell - 2. Transform the supercell into a list of supercells with all atoms - randomly perturbed from their original sites - 3. Run static VASP calculations on each perturbed supercell to - calculate atomic forces. - 4. Aggregate the forces and conduct the fit the force constants using + 1. Calculate a supercell transformation matrix that brings the + structure as close as cubic as possible, with all lattice lengths + greater than 5 nearest neighbor distances. + 2. Perturb the atomic sites for each supercell using a Monte Carlo + rattle procedure. The atoms are perturbed roughly according to a + normal deviation. A number of standard deviation perturbation distances + are included. Multiple supercells may be generated for each perturbation + distance. + 3. Run static VASP calculations on each perturbed supercell to calculate + atomic forces. + 4. Aggregate the forces and conduct the fit atomic force constants using the minimization schemes in hiPhive. 5. Output the interatomic force constants, and phonon band structure and density of states to the database. - 6. Optional: Solve the lattice thermal conductivity using ShengBTE. + 6. Optional: Solve the lattice thermal conductivity using ShengBTE and + output to the database. Args: structure: Initial structure. common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", and "user_incar_settings" keys. vasp_input_set: Vasp input set for perturbed structure calculations. - supercell_matrix_kwargs: Options that control the size of the supercell - that will be perturbed. Will be passed directly to - CubicSupercellTransformation in + supercell_matrix_kwargs: Options that control the size of the supercell. + Will be passed directly to CubicSupercellTransformation in pymatgen.transformations.advanced_transformations. Note, a diagonal supercell is required to calculate lattice thermal conductivity. num_supercell_kwargs: Options that control the number of supercells From a9155057cda2cbf5662fefb5322a0db5ed5ce0e9 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 17:03:07 -0800 Subject: [PATCH 070/207] Rewrite preset workflow --- atomate/vasp/workflows/presets/core.py | 80 +++++++++++++++++--------- 1 file changed, 52 insertions(+), 28 deletions(-) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 6e91dcb62..a75f34427 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -1,6 +1,20 @@ +<<<<<<< HEAD from uuid import uuid4 import numpy as np +======= +# coding: utf-8 +from typing import Optional + +from uuid import uuid4 + +import numpy as np + +from atomate.vasp.workflows.base.lattice_dynamics import get_lattice_dynamics_wf +from fireworks import Workflow +from pymatgen import Structure +from pymatgen.io.vasp.sets import MPRelaxSet, MPStaticSet, MPHSERelaxSet +>>>>>>> 7cb526cb (Rewrite preset workflow) from pymatgen.io.vasp.inputs import Kpoints from pymatgen.io.vasp.sets import MPHSERelaxSet, MPRelaxSet, MPStaticSet @@ -828,46 +842,56 @@ def wf_nudged_elastic_band(structures, parent, c=None): return wf -def wf_lattice_thermal_conductivity(structure, c=None): +def wf_lattice_thermal_conductivity( + structure: Structure, + c: Optional[dict] = None, + **ld_kwargs +) -> Workflow: """ - Lattice thermal conductivity workflow from the given structure and config - dict. + Get a workflow to calculate lattice thermal conductivity, including a tight + structure optimization. Args: - structure (Structure): input structure - c (dict): workflow config dict + structure: The input structure. + c: Workflow common settings dict. Supports the keys: "VASP_CMD", + "DB_FILE", and "user_incar_settings", "ADD_WF_METADATA", and the + options supported by "add_common_powerups". + **ld_kwargs: Keyword arguments to be passed directly to the lattice + dynamics base workflow. Returns: - Workflow + A workflow to calculate lattice thermal conductivity. """ - from atomate.vasp.workflows.base.csld import CompressedSensingLatticeDynamicsWF - c = c or {} - vasp_cmd = c.get("VASP_CMD", VASP_CMD) - db_file = c.get("DB_FILE", DB_FILE) + optimize_uis = { + "LAECHG": False, + 'ENCUT': 700, + 'ADDGRID': True, + 'EDIFFG': -5e-4, + 'PREC': 'Accurate', + "LREAL": False, + 'EDIFF': 1e-8, + "ISMEAR": 0, + 'LCHARG': False, + 'LASPH': True + } + # wf_structure_optimization expects user incar settings in capitals + c["USER_INCAR_SETTINGS"].update(optimize_uis) + c["USER_INCAR_SETTINGS"].update(c.get("user_incar_settings", {})) + wf = wf_structure_optimization(structure, c=c) - ## DFPT AT GAMMA POINT - - optimize = {"LAECHG": False, 'ENCUT': 700, - 'ADDGRID': True, 'EDIFFG': -5e-4, - 'PREC': 'Accurate', "LREAL": False, - 'EDIFF': 1e-8, "ISMEAR": 0, - 'LCHARG': False, 'LASPH': True} - vis_relax = MPRelaxSet(structure, user_incar_settings=optimize) - wf = get_wf(structure, "optimize_only.yaml", vis=vis_relax, - params=[{"vasp_cmd": vasp_cmd, "db_file": db_file, - "name": "phonon structure optimization"}]) - wf_csld = CompressedSensingLatticeDynamicsWF(structure, - num_nn_dists=5, - num_displacements=10, - supercells_per_displacement_distance=1).get_wf() - - wf.append_wf(wf_csld, wf.leaf_fw_ids) - wf = add_common_powerups(wf, c) + wf_ld = get_lattice_dynamics_wf( + structure, + common_settings=c, + calculate_lattice_thermal_conductivity=True, + **ld_kwargs + ) + wf.append_wf(wf_ld, wf.leaf_fw_ids) formula = structure.composition.reduced_formula wf_name = "{} - lattice thermal conductivity preset".format(formula) wf.name = wf_name + wf = add_common_powerups(wf, c) if c.get("ADD_WF_METADATA", ADD_WF_METADATA): wf = add_wf_metadata(wf, structure) From fda14fe2b0a7502593176528d4be31bdc105dd2b Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 17:24:21 -0800 Subject: [PATCH 071/207] Move most phonopy functions to pymatgen --- atomate/vasp/analysis/phonopy.py | 138 --------------------- atomate/vasp/firetasks/lattice_dynamics.py | 15 +-- 2 files changed, 6 insertions(+), 147 deletions(-) diff --git a/atomate/vasp/analysis/phonopy.py b/atomate/vasp/analysis/phonopy.py index 490dad612..6871b199e 100644 --- a/atomate/vasp/analysis/phonopy.py +++ b/atomate/vasp/analysis/phonopy.py @@ -11,13 +11,6 @@ __email__ = "kmathew@lbl.gov" ======= from pymatgen import Structure -from pymatgen.io.phonopy import get_phonopy_structure -from pymatgen.phonon.bandstructure import ( - PhononBandStructure, - PhononBandStructureSymmLine, -) -from pymatgen.phonon.dos import CompletePhononDos, PhononDos -from pymatgen.symmetry.bandstructure import HighSymmKpath try: import phonopy @@ -28,7 +21,6 @@ __email__ = "kmathew@lbl.gov, aganose@lbl.gov" >>>>>>> 728556b6 (Add methods for generating phonon band structure & DOS) -MESH_DENSITY = 100.0 # should always be a float # TODO: @matk86 - unit tests? @@ -220,133 +212,3 @@ def get_phonopy_thermal_expansion( alpha = phonopy_qha.get_thermal_expansion()[:max_t_index] T = phonopy_qha._qha._temperatures[:max_t_index] return alpha, T - - -@requires(phonopy, "phonopy is required to calculate phonon density of states") -def get_phonon_dos( - structure: Structure, - supercell_matrix: np.ndarray, - force_constants: np.ndarray, - mesh_density: float = MESH_DENSITY, - num_dos_steps: int = 200, -) -> CompletePhononDos: - """ - Get a projected phonon density of states. - - Args: - structure: A structure. - supercell_matrix: The supercell matrix used to generate the force - constants. - force_constants: The force constants in phonopy format. - mesh_density: The density of the q-point mesh. See the docstring - for the ``mesh`` argument in Phonopy.init_mesh() for more details. - num_dos_steps: Number of frequency steps in the energy grid. - - Returns: - The density of states. - """ - from phonopy import Phonopy - - structure_phonopy = get_phonopy_structure(structure) - phonon = Phonopy(structure_phonopy, supercell_matrix=supercell_matrix) - phonon.set_force_constants(force_constants) - phonon.run_mesh( - mesh_density, - is_mesh_symmetry=False, - with_eigenvectors=True, - is_gamma_center=True, - ) - - # get min, max, step frequency - frequencies = phonon.get_mesh_dict()["frequencies"] - freq_min = frequencies.min() - freq_max = frequencies.max() - freq_pitch = (freq_max - freq_min) / num_dos_steps - - phonon.run_projected_dos( - freq_min=freq_min, freq_max=freq_max, freq_pitch=freq_pitch - ) - - dos_raw = phonon.projected_dos.get_partial_dos() - pdoss = {s: dos for s, dos in zip(structure, dos_raw[1])} - - total_dos = PhononDos(dos_raw[0], dos_raw[1].sum(axis=0)) - return CompletePhononDos(structure, total_dos, pdoss) - - -@requires(phonopy, "phonopy is required to calculate phonon band structures") -def get_phonon_band_structure( - structure: Structure, - supercell_matrix: np.ndarray, - force_constants: np.ndarray, - mesh_density: float = 100.0, -) -> PhononBandStructure: - """ - Get a uniform phonon band structure. - - Args: - structure: A structure. - supercell_matrix: The supercell matrix used to generate the force - constants. - force_constants: The force constants in phonopy format. - mesh_density: The density of the q-point mesh. See the docstring - for the ``mesh`` argument in Phonopy.init_mesh() for more details. - - Returns: - The uniform phonon band structure. - """ - from phonopy import Phonopy - - structure_phonopy = get_phonopy_structure(structure) - phonon = Phonopy(structure_phonopy, supercell_matrix=supercell_matrix) - phonon.set_force_constants(force_constants) - phonon.run_mesh(mesh_density, is_mesh_symmetry=False, is_gamma_center=True) - mesh = phonon.get_mesh_dict() - - return PhononBandStructure( - mesh["qpoints"], mesh["frequencies"], structure.lattice - ) - - -@requires(phonopy, "phonopy is required to calculate phonon band structures") -def get_line_mode_phonon_band_structure( - structure: Structure, - supercell_matrix: np.ndarray, - force_constants: np.ndarray, - line_density: float = 20.0, - symprec: float = 0.01, -) -> PhononBandStructureSymmLine: - """ - Get a projected phonon density of states. - - Args: - structure: A structure. - supercell_matrix: The supercell matrix used to generate the force - constants. - force_constants: The force constants in phonopy format. - line_density: The density along the high symmetry path. - symprec: Symmetry precision for determining the band structure path. - - Returns: - The line mode band structure. - """ - from phonopy import Phonopy - - structure_phonopy = get_phonopy_structure(structure) - phonon = Phonopy(structure_phonopy, supercell_matrix=supercell_matrix) - phonon.set_force_constants(force_constants) - - kpath = HighSymmKpath(structure, symprec=symprec) - - kpoints, labels = kpath.get_kpoints( - line_density=line_density, coords_are_cartesian=False - ) - - phonon.run_qpoints(kpoints) - frequencies = phonon.qpoints.get_frequencies().T - - labels_dict = dict([(a, k) for a, k in zip(labels, kpoints) if a != ""]) - - return PhononBandStructureSymmLine( - kpoints, frequencies, structure.lattice, labels_dict=labels_dict - ) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 70b792145..92e7cea78 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -17,16 +17,12 @@ fit_force_constants, get_cutoffs, ) -from atomate.vasp.analysis.phonopy import ( - MESH_DENSITY, - get_line_mode_phonon_band_structure, - get_phonon_band_structure, - get_phonon_dos, -) from atomate.vasp.database import VaspCalcDb from fireworks import FiretaskBase, FWAction, explicit_serialize from pymatgen import Structure from pymatgen.io.ase import AseAtomsAdaptor +from pymatgen.io.phonopy import get_phonon_band_structure_from_fc, \ + get_line_mode_phonon_band_structure_from_fc, get_phonon_dos_from_fc from pymatgen.io.shengbte import Control from pymatgen.transformations.standard_transformations import ( SupercellTransformation, @@ -45,6 +41,7 @@ # define shared constants DEFAULT_TEMPERATURE = 300 +MESH_DENSITY = 100.0 # should always be a float @explicit_serialize @@ -227,18 +224,18 @@ def run_task(self, fw_spec): phonopy_fc = force_constants.get_fc_array(order=2) logger.info("Getting uniform phonon band structure.") - uniform_bs = get_phonon_band_structure( + uniform_bs = get_phonon_band_structure_from_fc( structure, supercell_matrix, phonopy_fc ) logger.info("Getting line mode phonon band structure.") - lm_bs = get_line_mode_phonon_band_structure( + lm_bs = get_line_mode_phonon_band_structure_from_fc( structure, supercell_matrix, phonopy_fc ) logger.info("Getting phonon density of states.") mesh_density = self.get("mesh_density", MESH_DENSITY) - dos = get_phonon_dos( + dos = get_phonon_dos_from_fc( structure, supercell_matrix, phonopy_fc, mesh_density=mesh_density ) From 2fbab7dea25ff9637c929320340e0961df5d3173 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 19:13:21 -0800 Subject: [PATCH 072/207] Tidy polarization tests --- .../tests/test_polarization_to_db.py | 24 +++++++++++++++++++ 1 file changed, 24 insertions(+) diff --git a/atomate/vasp/firetasks/tests/test_polarization_to_db.py b/atomate/vasp/firetasks/tests/test_polarization_to_db.py index 519210fad..2bc839900 100644 --- a/atomate/vasp/firetasks/tests/test_polarization_to_db.py +++ b/atomate/vasp/firetasks/tests/test_polarization_to_db.py @@ -1,4 +1,12 @@ +<<<<<<< HEAD import os +======= +import bson +import gzip +import os + +from pathlib import Path +>>>>>>> 45fcce62 (Tidy polarization tests) from atomate.utils.testing import AtomateTest from atomate.vasp.firetasks.parse_outputs import PolarizationToDb @@ -6,6 +14,7 @@ __author__ = "Tess Smidt" __email__ = "blondegeek@gmail.com" +<<<<<<< HEAD module_dir = os.path.dirname(os.path.abspath(__file__)) db_dir = os.path.join(module_dir, "..", "..", "..", "common", "test_files") ref_dir = os.path.join(module_dir, "..", "..", "test_files") @@ -16,10 +25,16 @@ ) # If None, runs a "fake" VASP. Otherwise, runs VASP with this command... VASP_CMD = None +======= +module_dir = Path(__file__).resolve().parent +db_dir = module_dir / "../../../common/test_files" +ref_dir = module_dir / "../..//test_files" +>>>>>>> 45fcce62 (Tidy polarization tests) class TestFerroelectricWorkflow(AtomateTest): def test_polarizationtodb(self): +<<<<<<< HEAD import gzip import bson @@ -27,6 +42,11 @@ def test_polarizationtodb(self): reference_dir = os.path.abspath(os.path.join(ref_dir, "ferroelectric_wf")) with gzip.open(os.path.join(reference_dir, "tasks.bson.gz")) as f: +======= + wf_dir = ref_dir / "ferroelectric_wf" + + with gzip.open(wf_dir / "tasks.bson.gz") as f: +>>>>>>> 45fcce62 (Tidy polarization tests) coll_raw = f.read() coll = bson.decode_all(coll_raw) @@ -46,4 +66,8 @@ def test_polarizationtodb(self): # Check recovered change in polarization coll = self.get_task_collection("polarization_tasks") d = coll.find_one() +<<<<<<< HEAD self.assertAlmostEqual(d["polarization_change_norm"], 46.288752795325244, 5) +======= + self.assertAlmostEqual(d["polarization_change_norm"], 46.28875279532, 5) +>>>>>>> 45fcce62 (Tidy polarization tests) From 792ceac1434426c15b7516303518d578e8027fd1 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 19:13:44 -0800 Subject: [PATCH 073/207] FIX: Use proper phonon function name --- atomate/vasp/firetasks/lattice_dynamics.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 92e7cea78..d845a46fc 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -22,7 +22,7 @@ from pymatgen import Structure from pymatgen.io.ase import AseAtomsAdaptor from pymatgen.io.phonopy import get_phonon_band_structure_from_fc, \ - get_line_mode_phonon_band_structure_from_fc, get_phonon_dos_from_fc + get_phonon_dos_from_fc, get_phonon_band_structure_symm_line_from_fc from pymatgen.io.shengbte import Control from pymatgen.transformations.standard_transformations import ( SupercellTransformation, @@ -229,7 +229,7 @@ def run_task(self, fw_spec): ) logger.info("Getting line mode phonon band structure.") - lm_bs = get_line_mode_phonon_band_structure_from_fc( + lm_bs = get_phonon_band_structure_symm_line_from_fc( structure, supercell_matrix, phonopy_fc ) From 54034c6beeccc0dd5f242235de2cf02ff9f0bc48 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 25 Feb 2020 19:18:41 -0800 Subject: [PATCH 074/207] Finish tidying polarization tests --- atomate/vasp/firetasks/tests/test_polarization_to_db.py | 9 ++++++--- 1 file changed, 6 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/tests/test_polarization_to_db.py b/atomate/vasp/firetasks/tests/test_polarization_to_db.py index 2bc839900..b85b0da70 100644 --- a/atomate/vasp/firetasks/tests/test_polarization_to_db.py +++ b/atomate/vasp/firetasks/tests/test_polarization_to_db.py @@ -3,7 +3,6 @@ ======= import bson import gzip -import os from pathlib import Path >>>>>>> 45fcce62 (Tidy polarization tests) @@ -28,11 +27,15 @@ ======= module_dir = Path(__file__).resolve().parent db_dir = module_dir / "../../../common/test_files" +<<<<<<< HEAD ref_dir = module_dir / "../..//test_files" >>>>>>> 45fcce62 (Tidy polarization tests) +======= +ref_dir = module_dir / "../../test_files" +>>>>>>> fcdf2e63 (Finish tidying polarization tests) -class TestFerroelectricWorkflow(AtomateTest): +class TestPolarizationFiretasks(AtomateTest): def test_polarizationtodb(self): <<<<<<< HEAD import gzip @@ -56,7 +59,7 @@ def test_polarizationtodb(self): task_coll.insert_one(c) new_fw_spec = { - "_fw_env": {"db_file": os.path.join(db_dir, "db.json")}, + "_fw_env": {"db_file": db_dir / "db.json"}, "tags": ["wfid_1494203093.06934658"], } From ff74e055b4a278ac38e4f1cd2ee5f09eb34c6a8b Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Wed, 26 Feb 2020 01:57:30 -0800 Subject: [PATCH 075/207] Add lattice dynamics test files --- atomate/vasp/test_files/csld_wf/FW.json | 56691 ---------------- .../test_files/csld_wf/POSCAR-well_relaxed_Si | 10 - atomate/vasp/test_files/csld_wf/__init__.py | 0 .../lattice_dynamics_wf/0/inputs/INCAR | 21 + .../lattice_dynamics_wf/0/inputs/KPOINTS | 4 + .../lattice_dynamics_wf/0/inputs/POSCAR | 136 + .../lattice_dynamics_wf/0/inputs/POTCAR | 1768 + .../lattice_dynamics_wf/0/outputs/INCAR | 21 + .../lattice_dynamics_wf/0/outputs/KPOINTS | 4 + .../lattice_dynamics_wf/0/outputs/POSCAR | 136 + .../lattice_dynamics_wf/0/outputs/POTCAR | 1768 + 11 files changed, 3858 insertions(+), 56701 deletions(-) delete mode 100644 atomate/vasp/test_files/csld_wf/FW.json delete mode 100644 atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si delete mode 100644 atomate/vasp/test_files/csld_wf/__init__.py create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/INCAR create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/KPOINTS create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POSCAR create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POTCAR create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/INCAR create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/KPOINTS create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POSCAR create mode 100644 atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POTCAR diff --git a/atomate/vasp/test_files/csld_wf/FW.json b/atomate/vasp/test_files/csld_wf/FW.json deleted file mode 100644 index dfec54f0c..000000000 --- a/atomate/vasp/test_files/csld_wf/FW.json +++ /dev/null @@ -1,56691 +0,0 @@ -[{ - "spec": { - "tags": [ - "csld", - "v1", - "rees", - "pre-relaxed si", - "diagonal supercell", - "not symmetrized", - "555" - ], - "_fworker": "rees_the_fire_worker", - "_tasks": [ - { - "db_file": ">>db_file<<", - "wf_uuid": "b8ab536c-b75d-4011-a069-48cbab8b8bda", - "parent_structure": { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 2.734364, - 2.734364 - ], - [ - 2.734364, - 0.0, - 2.734364 - ], - [ - 2.734364, - 2.734364, - 0.0 - ] - ], - "a": 3.8669746532647453, - "b": 3.8669746532647453, - "c": 3.8669746532647453, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 40.88829284866483 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.5, - 0.5 - ], - "xyz": [ - 2.734364, - 2.734364, - 2.734364 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.75, - 0.75, - 0.75 - ], - "xyz": [ - 4.101546, - 4.101546, - 4.101546 - ], - "label": "Si", - "properties": {} - } - ] - }, - "trans_mat": [ - [ - 5, - 0, - 0 - ], - [ - 0, - 5, - 0 - ], - [ - 0, - 0, - 5 - ] - ], - "supercell_structure": { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1, - 0.1, - 0.1 - ], - "xyz": [ - 2.734364, - 2.734364, - 2.734364 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1, - 0.1, - 0.3 - ], - "xyz": [ - 5.468728, - 5.468728, - 2.734364 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1, - 0.10000000000000002, - 0.5000000000000001 - ], - "xyz": [ - 8.203092000000002, - 8.203092, - 2.734364 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1, - 0.1, - 0.7000000000000001 - ], - "xyz": [ - 10.937456, - 10.937456, - 2.734364 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000000000000002, - 0.09999999999999999, - 0.9 - ], - "xyz": [ - 13.671819999999999, - 13.671819999999999, - 2.734364 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1, - 0.30000000000000004, - 0.10000000000000003 - ], - "xyz": [ - 5.4687280000000005, - 2.7343640000000002, - 5.4687280000000005 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999998, - 0.30000000000000004, - 0.3000000000000001 - ], - "xyz": [ - 8.203092000000002, - 5.4687280000000005, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000000000000002, - 0.3, - 0.5 - ], - "xyz": [ - 10.937455999999997, - 8.203092, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999992, - 0.3000000000000001, - 0.7000000000000001 - ], - "xyz": [ - 13.67182, - 10.937456, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999994, - 0.3000000000000001, - 0.9 - ], - "xyz": [ - 16.406184, - 13.671819999999999, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999999, - 0.5000000000000001, - 0.10000000000000005 - ], - "xyz": [ - 8.203092000000002, - 2.7343640000000002, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000000000000002, - 0.5, - 0.30000000000000004 - ], - "xyz": [ - 10.937456, - 5.4687280000000005, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000000000000007, - 0.5, - 0.5 - ], - "xyz": [ - 13.671819999999999, - 8.203092, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999996, - 0.5000000000000001, - 0.7000000000000002 - ], - "xyz": [ - 16.406184000000003, - 10.937456000000001, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999999, - 0.5000000000000001, - 0.9000000000000001 - ], - "xyz": [ - 19.140548000000003, - 13.67182, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000000000000003, - 0.7000000000000001, - 0.09999999999999998 - ], - "xyz": [ - 10.937456, - 2.734364, - 10.937456000000001 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000000000000003, - 0.7000000000000001, - 0.30000000000000004 - ], - "xyz": [ - 13.67182, - 5.4687280000000005, - 10.937456000000001 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999998, - 0.7000000000000001, - 0.5000000000000001 - ], - "xyz": [ - 16.406184, - 8.203092, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999998, - 0.7000000000000001, - 0.7000000000000001 - ], - "xyz": [ - 19.140548, - 10.937456, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999998, - 0.7000000000000001, - 0.9 - ], - "xyz": [ - 21.874912, - 13.671819999999999, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000000000000005, - 0.9, - 0.09999999999999996 - ], - "xyz": [ - 13.671819999999999, - 2.734364, - 13.67182 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999994, - 0.9000000000000001, - 0.30000000000000016 - ], - "xyz": [ - 16.406184000000003, - 5.4687280000000005, - 13.67182 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999999, - 0.9, - 0.5 - ], - "xyz": [ - 19.140548, - 8.203091999999998, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999999, - 0.9, - 0.7000000000000002 - ], - "xyz": [ - 21.874912000000002, - 10.937456000000001, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09999999999999999, - 0.9, - 0.9000000000000001 - ], - "xyz": [ - 24.609275999999998, - 13.67182, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.1, - 0.10000000000000003 - ], - "xyz": [ - 2.7343640000000002, - 5.4687280000000005, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.09999999999999999, - 0.3 - ], - "xyz": [ - 5.468727999999999, - 8.203092, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3, - 0.10000000000000003, - 0.5 - ], - "xyz": [ - 8.203092, - 10.937455999999997, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3000000000000001, - 0.09999999999999995, - 0.7000000000000001 - ], - "xyz": [ - 10.937456, - 13.67182, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3000000000000001, - 0.09999999999999994, - 0.9 - ], - "xyz": [ - 13.671819999999999, - 16.406184, - 5.468728 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.30000000000000004, - 0.09999999999999999 - ], - "xyz": [ - 5.468728, - 5.468728, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.30000000000000004, - 0.30000000000000004 - ], - "xyz": [ - 8.203092, - 8.203092, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.30000000000000004, - 0.5 - ], - "xyz": [ - 10.937456, - 10.937456, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3, - 0.30000000000000004, - 0.7000000000000002 - ], - "xyz": [ - 13.671820000000002, - 13.67182, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.30000000000000004, - 0.9000000000000001 - ], - "xyz": [ - 16.406184, - 16.406184, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3, - 0.5000000000000001, - 0.10000000000000009 - ], - "xyz": [ - 8.203092000000002, - 5.4687280000000005, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.5, - 0.30000000000000004 - ], - "xyz": [ - 10.937456, - 8.203092, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.5, - 0.5 - ], - "xyz": [ - 13.671819999999999, - 10.937456, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.5, - 0.7000000000000001 - ], - "xyz": [ - 16.406184, - 13.67182, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.5, - 0.9 - ], - "xyz": [ - 19.140548, - 16.406184, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3, - 0.7000000000000001, - 0.10000000000000007 - ], - "xyz": [ - 10.937456000000001, - 5.468728, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.7, - 0.30000000000000004 - ], - "xyz": [ - 13.671819999999999, - 8.203092, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29999999999999993, - 0.7000000000000001, - 0.5000000000000002 - ], - "xyz": [ - 16.406184000000003, - 10.937456000000001, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.7, - 0.7000000000000002 - ], - "xyz": [ - 19.140548, - 13.671820000000002, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.7, - 0.9000000000000001 - ], - "xyz": [ - 21.874912, - 16.406184, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3000000000000001, - 0.9, - 0.09999999999999999 - ], - "xyz": [ - 13.671819999999999, - 5.4687280000000005, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.9000000000000001, - 0.30000000000000004 - ], - "xyz": [ - 16.406184, - 8.203092, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000004, - 0.9000000000000001, - 0.5 - ], - "xyz": [ - 19.140548, - 10.937456, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3000000000000001, - 0.9, - 0.7 - ], - "xyz": [ - 21.874912, - 13.671819999999999, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30000000000000016, - 0.9, - 0.8999999999999999 - ], - "xyz": [ - 24.609275999999998, - 16.406184, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.09999999999999999, - 0.09999999999999999 - ], - "xyz": [ - 2.7343639999999994, - 8.203092000000002, - 8.203092000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.10000000000000002, - 0.30000000000000004 - ], - "xyz": [ - 5.4687280000000005, - 10.937456, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.10000000000000005, - 0.5 - ], - "xyz": [ - 8.203092, - 13.671819999999999, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.09999999999999999, - 0.7 - ], - "xyz": [ - 10.937455999999997, - 16.406184, - 8.203092000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.09999999999999996, - 0.8999999999999999 - ], - "xyz": [ - 13.671819999999997, - 19.140548, - 8.203092 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.3, - 0.09999999999999998 - ], - "xyz": [ - 5.468727999999999, - 8.203091999999998, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.30000000000000004, - 0.30000000000000004 - ], - "xyz": [ - 8.203092, - 10.937456, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.30000000000000004, - 0.5 - ], - "xyz": [ - 10.937456, - 13.671819999999999, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.30000000000000004, - 0.7000000000000001 - ], - "xyz": [ - 13.67182, - 16.406184, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.30000000000000004, - 0.9 - ], - "xyz": [ - 16.406184, - 19.140548, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.5, - 0.10000000000000007 - ], - "xyz": [ - 8.203092, - 8.203092, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.5, - 0.30000000000000004 - ], - "xyz": [ - 10.937456, - 10.937456, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.5, - 0.5 - ], - "xyz": [ - 13.671819999999999, - 13.671819999999999, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.5, - 0.7000000000000002 - ], - "xyz": [ - 16.406184, - 16.406184, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.5, - 0.9000000000000001 - ], - "xyz": [ - 19.140548, - 19.140548, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.7000000000000001, - 0.09999999999999999 - ], - "xyz": [ - 10.937456, - 8.203092000000002, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.7000000000000001, - 0.29999999999999993 - ], - "xyz": [ - 13.671819999999999, - 10.937456, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.7000000000000002, - 0.5 - ], - "xyz": [ - 16.406184, - 13.671819999999999, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.7000000000000001, - 0.7 - ], - "xyz": [ - 19.140548, - 16.406184, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.7000000000000001, - 0.8999999999999999 - ], - "xyz": [ - 21.874912, - 19.140548, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.9, - 0.09999999999999998 - ], - "xyz": [ - 13.671819999999999, - 8.203092, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.9000000000000001, - 0.30000000000000016 - ], - "xyz": [ - 16.406184000000003, - 10.937456000000001, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5, - 0.9000000000000001, - 0.5000000000000001 - ], - "xyz": [ - 19.140548000000003, - 13.67182, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.9, - 0.7000000000000001 - ], - "xyz": [ - 21.874912, - 16.406184, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000000000000001, - 0.9, - 0.9 - ], - "xyz": [ - 24.609275999999998, - 19.140548, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.09999999999999998, - 0.09999999999999998 - ], - "xyz": [ - 2.734363999999999, - 10.937456, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.10000000000000003, - 0.30000000000000004 - ], - "xyz": [ - 5.4687280000000005, - 13.67182, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.09999999999999998, - 0.5000000000000001 - ], - "xyz": [ - 8.203092, - 16.406184, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.09999999999999998, - 0.7000000000000001 - ], - "xyz": [ - 10.937456, - 19.140548, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.09999999999999998, - 0.9 - ], - "xyz": [ - 13.671819999999999, - 21.874912, - 10.937456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.3, - 0.10000000000000007 - ], - "xyz": [ - 5.468728, - 10.937456000000001, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7, - 0.30000000000000004, - 0.30000000000000004 - ], - "xyz": [ - 8.203092, - 13.671819999999999, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.3, - 0.5 - ], - "xyz": [ - 10.937455999999997, - 16.406184, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7, - 0.30000000000000004, - 0.7000000000000002 - ], - "xyz": [ - 13.671820000000002, - 19.140548, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7, - 0.30000000000000004, - 0.9000000000000001 - ], - "xyz": [ - 16.406184, - 21.874912, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.5000000000000001, - 0.09999999999999999 - ], - "xyz": [ - 8.203092000000002, - 10.937456, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.5000000000000001, - 0.29999999999999993 - ], - "xyz": [ - 10.937456, - 13.671819999999999, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000002, - 0.5, - 0.5 - ], - "xyz": [ - 13.671819999999999, - 16.406184, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.5000000000000001, - 0.7 - ], - "xyz": [ - 16.406184, - 19.140548, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.5000000000000001, - 0.9000000000000001 - ], - "xyz": [ - 19.140548000000003, - 21.874912, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.7000000000000001, - 0.09999999999999998 - ], - "xyz": [ - 10.937456, - 10.937456, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.7000000000000001, - 0.29999999999999993 - ], - "xyz": [ - 13.671819999999999, - 13.671819999999999, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.7000000000000001, - 0.5000000000000001 - ], - "xyz": [ - 16.406184, - 16.406184, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.7000000000000001, - 0.7000000000000001 - ], - "xyz": [ - 19.140548, - 19.140548, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.7000000000000001, - 0.9 - ], - "xyz": [ - 21.874912, - 21.874912, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.9, - 0.09999999999999996 - ], - "xyz": [ - 13.671819999999999, - 10.937456, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7, - 0.9000000000000001, - 0.30000000000000004 - ], - "xyz": [ - 16.406184, - 13.671819999999999, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.9, - 0.5 - ], - "xyz": [ - 19.140548, - 16.406184, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.9, - 0.7 - ], - "xyz": [ - 21.874912, - 19.140548, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000000000000001, - 0.9, - 0.9000000000000001 - ], - "xyz": [ - 24.609275999999998, - 21.874912, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.09999999999999999, - 0.09999999999999996 - ], - "xyz": [ - 2.734363999999999, - 13.671819999999999, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000000000000001, - 0.09999999999999994, - 0.30000000000000004 - ], - "xyz": [ - 5.468728, - 16.406184, - 13.67182 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.09999999999999999, - 0.5 - ], - "xyz": [ - 8.203091999999998, - 19.140548, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.09999999999999999, - 0.7000000000000002 - ], - "xyz": [ - 10.937456000000001, - 21.874912000000002, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.09999999999999999, - 0.9000000000000001 - ], - "xyz": [ - 13.67182, - 24.609275999999998, - 13.671819999999999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.3000000000000001, - 0.09999999999999999 - ], - "xyz": [ - 5.4687280000000005, - 13.671819999999999, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000000000000001, - 0.30000000000000004, - 0.30000000000000004 - ], - "xyz": [ - 8.203092, - 16.406184, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000000000000001, - 0.30000000000000004, - 0.5 - ], - "xyz": [ - 10.937456, - 19.140548, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.30000000000000016, - 0.7000000000000002 - ], - "xyz": [ - 13.671820000000004, - 21.874912000000002, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.30000000000000016, - 0.9000000000000001 - ], - "xyz": [ - 16.406184000000003, - 24.609275999999998, - 16.406184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.5000000000000001, - 0.09999999999999998 - ], - "xyz": [ - 8.203092, - 13.671819999999999, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000000000000001, - 0.5, - 0.29999999999999993 - ], - "xyz": [ - 10.937455999999997, - 16.406184, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000000000000001, - 0.5, - 0.4999999999999999 - ], - "xyz": [ - 13.671819999999997, - 19.140548, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.5000000000000001, - 0.7000000000000001 - ], - "xyz": [ - 16.406184, - 21.874912, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.5000000000000001, - 0.9 - ], - "xyz": [ - 19.140548, - 24.609275999999998, - 19.140548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.7000000000000001, - 0.09999999999999996 - ], - "xyz": [ - 10.937456, - 13.671819999999999, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000000000000001, - 0.7, - 0.30000000000000004 - ], - "xyz": [ - 13.671819999999999, - 16.406184, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.7000000000000001, - 0.5 - ], - "xyz": [ - 16.406184, - 19.140548, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.7000000000000001, - 0.7000000000000002 - ], - "xyz": [ - 19.140548000000003, - 21.874912000000002, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.7000000000000001, - 0.9000000000000001 - ], - "xyz": [ - 21.874912, - 24.609275999999998, - 21.874912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.9, - 0.09999999999999995 - ], - "xyz": [ - 13.671819999999999, - 13.671819999999999, - 24.609275999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.9, - 0.30000000000000016 - ], - "xyz": [ - 16.406184, - 16.406184, - 24.609275999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.9, - 0.5000000000000001 - ], - "xyz": [ - 19.140548, - 19.140548, - 24.609275999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.9, - 0.7000000000000001 - ], - "xyz": [ - 21.874912, - 21.874912, - 24.609275999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9, - 0.9, - 0.9 - ], - "xyz": [ - 24.609275999999998, - 24.609275999999998, - 24.609275999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000002, - 0.15000000000000002, - 0.15000000000000002 - ], - "xyz": [ - 4.101546, - 4.101546, - 4.101546 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15, - 0.15000000000000002, - 0.3500000000000001 - ], - "xyz": [ - 6.835910000000001, - 6.83591, - 4.101546 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000002, - 0.15000000000000002, - 0.55 - ], - "xyz": [ - 9.570274, - 9.570274, - 4.101546 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000005, - 0.15, - 0.7500000000000001 - ], - "xyz": [ - 12.304638, - 12.304638, - 4.101546 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000005, - 0.15, - 0.9500000000000001 - ], - "xyz": [ - 15.039001999999998, - 15.039002, - 4.101546 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15, - 0.3500000000000001, - 0.15000000000000005 - ], - "xyz": [ - 6.835910000000001, - 4.101546, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000005, - 0.35000000000000003, - 0.35000000000000003 - ], - "xyz": [ - 9.570274, - 6.83591, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15, - 0.3500000000000001, - 0.55 - ], - "xyz": [ - 12.304638, - 9.570274, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000008, - 0.35, - 0.7500000000000002 - ], - "xyz": [ - 15.039002, - 12.304638000000002, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000008, - 0.35, - 0.9500000000000002 - ], - "xyz": [ - 17.773366, - 15.039002000000002, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000002, - 0.55, - 0.14999999999999997 - ], - "xyz": [ - 9.570274, - 4.101545999999999, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15, - 0.55, - 0.35000000000000003 - ], - "xyz": [ - 12.304638, - 6.835909999999999, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000002, - 0.55, - 0.55 - ], - "xyz": [ - 15.039002, - 9.570274, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500000000000001, - 0.5499999999999999, - 0.7500000000000001 - ], - "xyz": [ - 17.773366, - 12.304638000000002, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15, - 0.55, - 0.9500000000000003 - ], - "xyz": [ - 20.507730000000002, - 15.039002000000002, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000005, - 0.7500000000000001, - 0.15 - ], - "xyz": [ - 12.304638, - 4.101546, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500000000000001, - 0.7500000000000001, - 0.35 - ], - "xyz": [ - 15.039002, - 6.83591, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500000000000001, - 0.7500000000000001, - 0.5499999999999999 - ], - "xyz": [ - 17.773366, - 9.570274, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000005, - 0.7500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 20.507730000000002, - 12.304638, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500000000000001, - 0.7500000000000001, - 0.9500000000000001 - ], - "xyz": [ - 23.242094, - 15.039002, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000005, - 0.9500000000000001, - 0.15 - ], - "xyz": [ - 15.039001999999998, - 4.101546, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500000000000001, - 0.9500000000000001, - 0.3499999999999999 - ], - "xyz": [ - 17.773365999999996, - 6.83591, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15, - 0.9500000000000002, - 0.55 - ], - "xyz": [ - 20.50773, - 9.570274, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15000000000000005, - 0.9500000000000001, - 0.7500000000000002 - ], - "xyz": [ - 23.242094, - 12.304638000000002, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500000000000001, - 0.9500000000000001, - 0.9500000000000002 - ], - "xyz": [ - 25.976458, - 15.039002000000002, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.15000000000000002, - 0.15000000000000005 - ], - "xyz": [ - 4.101546000000001, - 6.83591, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.15000000000000005, - 0.35000000000000003 - ], - "xyz": [ - 6.83591, - 9.570274, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.14999999999999997, - 0.5500000000000002 - ], - "xyz": [ - 9.570274000000001, - 12.304638000000002, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.15000000000000002, - 0.7500000000000002 - ], - "xyz": [ - 12.304638000000002, - 15.039002000000002, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.15000000000000002, - 0.9500000000000002 - ], - "xyz": [ - 15.039002000000002, - 17.773366, - 6.83591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.35000000000000003, - 0.15000000000000008 - ], - "xyz": [ - 6.83591, - 6.83591, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.35000000000000003, - 0.35000000000000003 - ], - "xyz": [ - 9.570274, - 9.570274, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.35000000000000003, - 0.5500000000000002 - ], - "xyz": [ - 12.304638, - 12.304638, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.35, - 0.7500000000000001 - ], - "xyz": [ - 15.039002, - 15.039002000000002, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.35, - 0.9500000000000001 - ], - "xyz": [ - 17.773366, - 17.773366, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.55, - 0.15 - ], - "xyz": [ - 9.570274, - 6.83591, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.5500000000000002, - 0.35 - ], - "xyz": [ - 12.304638, - 9.570274, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000014, - 0.55, - 0.5500000000000002 - ], - "xyz": [ - 15.039002000000002, - 12.304638000000002, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000014, - 0.55, - 0.7500000000000001 - ], - "xyz": [ - 17.773366, - 15.039002000000002, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.5500000000000002, - 0.9500000000000001 - ], - "xyz": [ - 20.50773, - 17.773366, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.7500000000000001, - 0.15 - ], - "xyz": [ - 12.304638, - 6.835909999999999, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.7500000000000001, - 0.3499999999999999 - ], - "xyz": [ - 15.039002, - 9.570274, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000014, - 0.75, - 0.55 - ], - "xyz": [ - 17.773366, - 12.304638, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.7500000000000001, - 0.7500000000000002 - ], - "xyz": [ - 20.507730000000002, - 15.039002000000002, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.7500000000000001, - 0.9500000000000002 - ], - "xyz": [ - 23.242094, - 17.773366000000003, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.9500000000000001, - 0.14999999999999997 - ], - "xyz": [ - 15.039001999999998, - 6.83591, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.9500000000000001, - 0.3499999999999999 - ], - "xyz": [ - 17.773365999999996, - 9.570274, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35000000000000003, - 0.9500000000000001, - 0.5500000000000002 - ], - "xyz": [ - 20.50773, - 12.304638, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.9500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 23.242093999999998, - 15.039002000000002, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500000000000001, - 0.9500000000000001, - 0.9500000000000001 - ], - "xyz": [ - 25.976457999999997, - 17.773366, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.15000000000000002, - 0.14999999999999997 - ], - "xyz": [ - 4.101545999999999, - 9.570274, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.15, - 0.35000000000000014 - ], - "xyz": [ - 6.835910000000001, - 12.304638, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.15, - 0.5500000000000002 - ], - "xyz": [ - 9.570274000000001, - 15.039002000000002, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.15000000000000002, - 0.7500000000000001 - ], - "xyz": [ - 12.304638, - 17.773366, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.15000000000000002, - 0.9500000000000001 - ], - "xyz": [ - 15.039002, - 20.50773, - 9.570274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.3500000000000001, - 0.15 - ], - "xyz": [ - 6.83591, - 9.570274, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.35000000000000003, - 0.3500000000000001 - ], - "xyz": [ - 9.570274000000001, - 12.304638000000002, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.3500000000000001, - 0.5500000000000002 - ], - "xyz": [ - 12.304638000000002, - 15.039002000000002, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.3500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 15.039002000000002, - 17.773366000000003, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.35000000000000003, - 0.9500000000000001 - ], - "xyz": [ - 17.773366, - 20.50773, - 12.304638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.55, - 0.15 - ], - "xyz": [ - 9.570274, - 9.570274, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.55, - 0.35000000000000003 - ], - "xyz": [ - 12.304638, - 12.304638, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.55, - 0.55 - ], - "xyz": [ - 15.039002, - 15.039002, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.55, - 0.75 - ], - "xyz": [ - 17.773366, - 17.773366, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.5500000000000002, - 0.9500000000000002 - ], - "xyz": [ - 20.507730000000002, - 20.507730000000002, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.7500000000000001, - 0.14999999999999997 - ], - "xyz": [ - 12.304638, - 9.570274, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.75, - 0.35000000000000014 - ], - "xyz": [ - 15.039002, - 12.304638000000002, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.75, - 0.5500000000000002 - ], - "xyz": [ - 17.773366, - 15.039002000000002, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.7500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 20.507730000000002, - 17.773366, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.7500000000000001, - 0.9500000000000001 - ], - "xyz": [ - 23.242094, - 20.50773, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.9500000000000001, - 0.14999999999999997 - ], - "xyz": [ - 15.039001999999998, - 9.570274, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500000000000002, - 0.95, - 0.35000000000000003 - ], - "xyz": [ - 17.773366, - 12.304638, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.9500000000000001, - 0.5500000000000002 - ], - "xyz": [ - 20.50773, - 15.039002000000002, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.9500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 23.242093999999998, - 17.773366, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55, - 0.9500000000000001, - 0.9500000000000001 - ], - "xyz": [ - 25.976457999999997, - 20.50773, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.15000000000000005, - 0.15 - ], - "xyz": [ - 4.101546, - 12.304638, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.15000000000000005, - 0.3500000000000001 - ], - "xyz": [ - 6.835910000000001, - 15.039002000000002, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.15000000000000005, - 0.5499999999999999 - ], - "xyz": [ - 9.570274, - 17.773366, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.1500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 12.304638000000002, - 20.507730000000002, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.1500000000000001, - 0.9500000000000001 - ], - "xyz": [ - 15.039002, - 23.242094, - 12.304638000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.35000000000000003, - 0.1500000000000001 - ], - "xyz": [ - 6.835910000000001, - 12.304638000000002, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.35000000000000003, - 0.35000000000000003 - ], - "xyz": [ - 9.570274, - 15.039002000000002, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.3500000000000001, - 0.55 - ], - "xyz": [ - 12.304638, - 17.773366, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.3500000000000001, - 0.75 - ], - "xyz": [ - 15.039002, - 20.50773, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.35000000000000003, - 0.95 - ], - "xyz": [ - 17.773366, - 23.242093999999998, - 15.039002000000002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.55, - 0.15000000000000008 - ], - "xyz": [ - 9.570274000000001, - 12.304638000000002, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.55, - 0.35000000000000014 - ], - "xyz": [ - 12.304638, - 15.039002000000002, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.55, - 0.5500000000000002 - ], - "xyz": [ - 15.039002000000002, - 17.773366000000003, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.55, - 0.7500000000000001 - ], - "xyz": [ - 17.773366, - 20.507730000000002, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.75, - 0.5500000000000002, - 0.9500000000000001 - ], - "xyz": [ - 20.50773, - 23.242093999999998, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.75, - 0.15000000000000008 - ], - "xyz": [ - 12.304638, - 12.304638000000002, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.75, - 0.35000000000000003 - ], - "xyz": [ - 15.039002, - 15.039002000000002, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.75, - 0.5499999999999999 - ], - "xyz": [ - 17.773366, - 17.773366, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.75, - 0.7500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 20.507730000000002, - 20.50773, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.75, - 0.7500000000000001, - 0.9500000000000001 - ], - "xyz": [ - 23.242094, - 23.242093999999998, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.95, - 0.15000000000000016 - ], - "xyz": [ - 15.039002, - 12.304638000000002, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500000000000001, - 0.95, - 0.35000000000000014 - ], - "xyz": [ - 17.773366, - 15.039002000000002, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.75, - 0.9500000000000001, - 0.55 - ], - "xyz": [ - 20.50773, - 17.773366, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.75, - 0.9500000000000001, - 0.75 - ], - "xyz": [ - 23.242093999999998, - 20.50773, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.75, - 0.9500000000000001, - 0.95 - ], - "xyz": [ - 25.976457999999997, - 23.242093999999998, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000002, - 0.15, - 0.15 - ], - "xyz": [ - 4.101545999999999, - 15.039002, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.15000000000000005, - 0.35000000000000003 - ], - "xyz": [ - 6.83591, - 17.773366, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.15000000000000005, - 0.55 - ], - "xyz": [ - 9.570274, - 20.50773, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.1500000000000001, - 0.75 - ], - "xyz": [ - 12.304638, - 23.242093999999998, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.15000000000000005, - 0.95 - ], - "xyz": [ - 15.039001999999998, - 25.976457999999997, - 15.039002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.35000000000000003, - 0.15000000000000008 - ], - "xyz": [ - 6.83591, - 15.039002, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.35000000000000003, - 0.3499999999999999 - ], - "xyz": [ - 9.570273999999998, - 17.773365999999996, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.3500000000000001, - 0.5500000000000002 - ], - "xyz": [ - 12.304638000000002, - 20.50773, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.3500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 15.039002000000002, - 23.242093999999998, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.35000000000000003, - 0.9500000000000001 - ], - "xyz": [ - 17.773366, - 25.976457999999997, - 17.773366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.55, - 0.15000000000000008 - ], - "xyz": [ - 9.570274000000001, - 15.039002, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.55, - 0.35000000000000003 - ], - "xyz": [ - 12.304638, - 17.773366, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.55, - 0.5499999999999999 - ], - "xyz": [ - 15.039001999999998, - 20.50773, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.55, - 0.7499999999999999 - ], - "xyz": [ - 17.773365999999996, - 23.242093999999994, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95, - 0.5500000000000002, - 0.9500000000000001 - ], - "xyz": [ - 20.50773, - 25.976457999999997, - 20.50773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.75, - 0.15000000000000016 - ], - "xyz": [ - 12.304638, - 15.039002, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.75, - 0.35000000000000014 - ], - "xyz": [ - 15.039002, - 17.773366, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.75, - 0.55 - ], - "xyz": [ - 17.773366, - 20.50773, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95, - 0.7500000000000001, - 0.75 - ], - "xyz": [ - 20.50773, - 23.242093999999998, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95, - 0.7500000000000001, - 0.95 - ], - "xyz": [ - 23.242093999999998, - 25.976457999999997, - 23.242093999999998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.95, - 0.15000000000000005 - ], - "xyz": [ - 15.039002, - 15.039002, - 25.976457999999997 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.95, - 0.35 - ], - "xyz": [ - 17.773366, - 17.773366, - 25.976457999999997 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95, - 0.9500000000000001, - 0.5500000000000002 - ], - "xyz": [ - 20.50773, - 20.50773, - 25.976457999999997 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95, - 0.9500000000000001, - 0.7500000000000001 - ], - "xyz": [ - 23.242093999999998, - 23.242093999999998, - 25.976457999999997 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500000000000001, - 0.9500000000000001, - 0.9500000000000001 - ], - "xyz": [ - 25.976457999999997, - 25.976457999999997, - 25.976457999999997 - ], - "label": "Si", - "properties": {} - } - ] - }, - "supercell_smallest_dim": 16.74449142758895, - "perturbed_supercells": [ - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10044424773297675, - 0.09950121535593849, - 0.10023626935595284 - ], - "xyz": [ - 2.73077493823373, - 2.743667907146769, - 2.733618381168293 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10050564196859288, - 0.0999908018568735, - 0.30003106773738425 - ], - "xyz": [ - 5.469026997156164, - 5.476065798492372, - 2.7411512906218873 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0997099537538339, - 0.10038677518534767, - 0.4995665433682368 - ], - "xyz": [ - 8.202453779667266, - 8.193200398883468, - 2.735686460645281 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.100279222507373, - 0.10021179072485692, - 0.7001363471141373 - ], - "xyz": [ - 10.942215677869918, - 10.943137593062756, - 2.7410770445286654 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1003696115018536, - 0.1001109422302662, - 0.9001275582016001 - ], - "xyz": [ - 13.675080734974397, - 13.67861721469507, - 2.74093404412587 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10018629754522747, - 0.30015442692392574, - 0.09937225880473773 - ], - "xyz": [ - 5.462256932478855, - 2.728328661876581, - 5.473386323611858 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09942058677768296, - 0.3003961157083183, - 0.29997858741613675 - ], - "xyz": [ - 8.208214873670986, - 5.460513617726548, - 5.466221989382161 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10020974348279003, - 0.29945451511427434, - 0.4999060646420115 - ], - "xyz": [ - 10.928713961523583, - 8.204675307836823, - 5.464137803972516 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09984833591024671, - 0.2999642795762544, - 0.7005902592898597 - ], - "xyz": [ - 13.679401555560515, - 10.943452394628718, - 5.466166112660654 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10059858058696342, - 0.2997070505811901, - 0.899995792580138 - ], - "xyz": [ - 16.402121325189906, - 13.679946162953438, - 5.472906534317384 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10056776084928998, - 0.4995624806503097, - 0.09985508240803964 - ], - "xyz": [ - 8.1951290269724, - 2.740145036902424, - 8.204872638339056 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0998207789327033, - 0.5002699031662314, - 0.30041613079574553 - ], - "xyz": [ - 10.946835332842035, - 5.471966987163601, - 8.204331789333857 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09985748846314861, - 0.5005705807665299, - 0.49956517308738047 - ], - "xyz": [ - 13.673676002254968, - 8.195198732639753, - 8.208944485455703 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09994514673893229, - 0.500515310965165, - 0.6994865511453154 - ], - "xyz": [ - 16.406209458439307, - 10.929686275767814, - 8.20938729484803 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10005142950617686, - 0.49945479037020224, - 0.9000089992047828 - ], - "xyz": [ - 19.133217027587072, - 13.672646170459071, - 8.196341127030276 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10057497321702974, - 0.6996479393492786, - 0.09972180117384971 - ], - "xyz": [ - 10.928839205878916, - 2.738421446052713, - 10.940503620482305 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09942348108115474, - 0.7001742506311651, - 0.2999874230940533 - ], - "xyz": [ - 13.674030374069915, - 5.460673987920693, - 10.931956260379128 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10059125762616206, - 0.6998863874596947, - 0.4999320959400623 - ], - "xyz": [ - 16.403702337714464, - 8.210247195753777, - 10.943986277637716 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10053713226154967, - 0.699799303490753, - 0.7001052847715065 - ], - "xyz": [ - 19.139243547895724, - 10.946239010040877, - 10.942055689047047 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09982161667890585, - 0.6998916506261924, - 0.8996688539428319 - ], - "xyz": [ - 21.868903297576875, - 13.664853806055685, - 10.933535842207187 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10011565513786799, - 0.8995321959615246, - 0.10052304051929159 - ], - "xyz": [ - 13.67257518322315, - 2.7430961320594673, - 13.667005483617695 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10057439869135831, - 0.8999823501322247, - 0.299563888372024 - ], - "xyz": [ - 16.399980254507156, - 5.470618635838891, - 13.679431769701237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10060232695606068, - 0.8997454366089532, - 0.4996729483300275 - ], - "xyz": [ - 19.132596263576456, - 8.206855514161845, - 13.676574560863427 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09968716728110733, - 0.900417513008275, - 0.6995889596630137 - ], - "xyz": [ - 21.875000493196776, - 10.927559337877172, - 13.673251170073982 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.100195657610068, - 0.9004946062282089, - 0.8995716732645876 - ], - "xyz": [ - 24.610182161295203, - 13.668638989598733, - 13.681257162949429 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30041112127450165, - 0.09988238649473655, - 0.09946013988596143 - ], - "xyz": [ - 2.725375139022154, - 5.466967905758842, - 5.472740785389625 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30013598790322626, - 0.09940250481417712, - 0.3003935485531298 - ], - "xyz": [ - 5.465939678348213, - 8.210331727114736, - 5.46241835550365 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3005590014834154, - 0.10009415548536428, - 0.4996864048254551 - ], - "xyz": [ - 8.200091860068666, - 10.940811150881741, - 5.477657844508901 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29984207284423203, - 0.10050618691333424, - 0.700136662215998 - ], - "xyz": [ - 10.946244917583385, - 13.671529269571153, - 5.473489344718689 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30054025305546506, - 0.10011050687311478, - 0.8997725043659659 - ], - "xyz": [ - 13.670220550718687, - 16.410459963169465, - 5.477625072606756 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2995801218071716, - 0.30055601082502026, - 0.09979001772574511 - ], - "xyz": [ - 5.473458840060925, - 5.460116661068921, - 8.204953180843452 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29980384961490825, - 0.30056514729243294, - 0.29958199965666155 - ], - "xyz": [ - 8.205103766601567, - 8.194695441788031, - 8.208136859297724 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30024945855298185, - 0.29987430530962433, - 0.500412093061602 - ], - "xyz": [ - 10.941371586979697, - 10.946500614595298, - 8.204784077252055 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29936835621119945, - 0.30024850296728844, - 0.7002123792340137 - ], - "xyz": [ - 13.678121098497405, - 13.666087890474572, - 8.197853767653633 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29971633051337465, - 0.3004056880431327, - 0.8995631605543587 - ], - "xyz": [ - 16.405758103632152, - 16.396333331569657, - 8.204760215741228 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3002099578529094, - 0.5004640585569241, - 0.09981857192696325 - ], - "xyz": [ - 8.20695607310222, - 5.469118054015057, - 10.946671031032288 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2994321146036323, - 0.4999499483871705, - 0.30021132118393845 - ], - "xyz": [ - 10.939660848547678, - 8.198217118269225, - 10.929007676438916 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3003716707273712, - 0.499458316336343, - 0.5002959324494456 - ], - "xyz": [ - 13.668460133634518, - 10.946583350464866, - 10.935131613737429 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3006308934266021, - 0.49975097825658715, - 0.6998410072629321 - ], - "xyz": [ - 16.400605699465473, - 13.678271741285185, - 10.94267688091566 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3005525407600691, - 0.4995296533246696, - 0.9000093352844232 - ], - "xyz": [ - 19.134245135245564, - 16.413865868142608, - 10.93857974273161 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3001420109996047, - 0.7002616149713389, - 0.09937103038047043 - ], - "xyz": [ - 10.932433593373773, - 5.462070389400938, - 13.677338301622063 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29972771526741304, - 0.7006145727902098, - 0.2997180119090455 - ], - "xyz": [ - 13.676367038142972, - 8.19551408172565, - 13.676499700711968 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30040090451914947, - 0.6994218631144071, - 0.4999783444468812 - ], - "xyz": [ - 16.39798374574057, - 10.942641023598757, - 13.66939691098781 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29956126195722804, - 0.6997252496808998, - 0.7002777491488076 - ], - "xyz": [ - 19.14058899945997, - 13.66961898881972, - 13.662065315544387 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29981790316616386, - 0.7004554061886579, - 0.8995048142889193 - ], - "xyz": [ - 21.874368141529747, - 16.396924314956753, - 13.675556636303437 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30052737735375057, - 0.8996815618515407, - 0.10015402076089794 - ], - "xyz": [ - 13.66957211507239, - 5.478043952371813, - 16.409040579205683 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29944042106882135, - 0.9004032039528429, - 0.3002315880836174 - ], - "xyz": [ - 16.414862762459915, - 8.198607768170493, - 16.404046069443687 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3002568028818206, - 0.8994897111027735, - 0.5004238305375148 - ], - "xyz": [ - 19.139365956868527, - 10.946761497595137, - 16.40271838482485 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2997962318740507, - 0.900289724360601, - 0.7004074861809656 - ], - "xyz": [ - 21.8844441370264, - 13.67460519657893, - 16.407359178168033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29973811193799077, - 0.8995443497823921, - 0.9003848362675669 - ], - "xyz": [ - 24.60830784442155, - 16.407864925735705, - 16.39637394579796 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500584813812994, - 0.0999198140545025, - 0.09991977679150464 - ], - "xyz": [ - 2.732170914920257, - 8.209990671918396, - 8.209991181371395 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4995605944619482, - 0.1000901312905473, - 0.29980531684736916 - ], - "xyz": [ - 5.467298585760928, - 10.92878685355695, - 8.198316785357482 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000760969015139, - 0.09953889842625425, - 0.49984431247344363 - ], - "xyz": [ - 8.194659370442707, - 13.67073185130073, - 8.197828285422085 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5002202286070385, - 0.1000520559431625, - 0.7003364633537125 - ], - "xyz": [ - 10.9427677658934, - 16.41379499228283, - 8.206814625359128 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5002801170679617, - 0.09980028843386149, - 0.9004144450554793 - ], - "xyz": [ - 13.674755797614237, - 19.1500439283305, - 8.204191289547936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5004875789791271, - 0.30021539381819146, - 0.09969198154815147 - ], - "xyz": [ - 5.467461652681074, - 8.205546919208057, - 10.947066917549835 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4999313251805624, - 0.2995637964786778, - 0.30057843859305106 - ], - "xyz": [ - 8.205036612298363, - 10.944425398555362, - 10.930553394203232 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49946060000730647, - 0.3002402376833799, - 0.49988352052322477 - ], - "xyz": [ - 10.93914799992422, - 13.662852933951726, - 10.933365906756277 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.50049176555322, - 0.3000163309433746, - 0.6994597604035497 - ], - "xyz": [ - 13.664657215198705, - 16.405521271606283, - 10.94440260384407 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5005395893519433, - 0.3001078725000712, - 0.8995699782240167 - ], - "xyz": [ - 16.401779633086598, - 19.14204598817636, - 10.946307981897608 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5001276887215991, - 0.5001499900216869, - 0.099382810390027 - ], - "xyz": [ - 8.196704531324878, - 8.196399631964312, - 13.67561637379603 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5002131144209466, - 0.49938744380213035, - 0.3003311977703589 - ], - "xyz": [ - 10.933609318223589, - 10.944897738303334, - 13.666358903925428 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49976385045185756, - 0.5005153581612637, - 0.4995648853795778 - ], - "xyz": [ - 13.672917075246547, - 13.662642597114933, - 13.675637289901042 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003285483745252, - 0.5003349711704783, - 0.6998858559975277 - ], - "xyz": [ - 16.409203109292086, - 16.40911529798192, - 13.680891519785769 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4997678945006039, - 0.4997960861737301, - 0.8998029904934473 - ], - "xyz": [ - 19.135066648359846, - 19.134681216879365, - 13.665858822262972 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4997191912940008, - 0.7000060513743362, - 0.10059473854346575 - ], - "xyz": [ - 10.945669891614003, - 8.20738399223047, - 16.40242756721782 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49968260613766813, - 0.7004055722859999, - 0.3003205178364174 - ], - "xyz": [ - 13.681746973457464, - 10.937498710411381, - 16.40738955953627 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49963940634795817, - 0.6999078738334309, - 0.4998429544907566 - ], - "xyz": [ - 16.40277736969919, - 13.664742930561957, - 16.399994496129516 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4995917820610007, - 0.7005343864251263, - 0.7001303350927858 - ], - "xyz": [ - 19.14963595294302, - 16.40238483574548, - 16.407908952832 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4995788476494608, - 0.7000408422311708, - 0.899813567237372 - ], - "xyz": [ - 21.872921512460213, - 19.132241205698097, - 16.400984468503815 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4994456251878285, - 0.8999544160686641, - 0.10045098845321036 - ], - "xyz": [ - 13.677362617650253, - 8.201678520309827, - 19.132345472051338 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003759852371765, - 0.9002995807046059, - 0.2994676869652477 - ], - "xyz": [ - 16.403002125474057, - 10.935318714490547, - 19.149784215954178 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5001227478729324, - 0.9002222101055256, - 0.5002808694886162 - ], - "xyz": [ - 19.147426013656776, - 13.677338183915966, - 19.14526420338904 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000415876263925, - 0.8999523557585, - 0.6994877738976862 - ], - "xyz": [ - 21.867257553436037, - 16.399749515472127, - 19.14046519504844 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4998974904408591, - 0.9006202863308056, - 0.8996878090581811 - ], - "xyz": [ - 24.613488224701054, - 19.134878289396966, - 19.147626950822378 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000841888834732, - 0.09965395781260167, - 0.10056328964733707 - ], - "xyz": [ - 2.7373341681677394, - 10.946308209927102, - 10.93387598876233 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7002986881839947, - 0.10036290866669594, - 0.2998873981963562 - ], - "xyz": [ - 5.472150150376413, - 13.674364139496607, - 10.946501233055207 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6993829744184767, - 0.10032719099109944, - 0.5001959834369919 - ], - "xyz": [ - 8.210244746609467, - 16.40042758758755, - 10.93349343364995 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7001482455305685, - 0.10005805753342793, - 0.6994027006318949 - ], - "xyz": [ - 10.930083582699822, - 19.134408616762887, - 10.940276538356406 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6995959439921661, - 0.10033444459992208, - 0.9003935916690848 - ], - "xyz": [ - 13.681773580823332, - 21.8747689334442, - 10.936504285361082 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6995670272353, - 0.29982568593872694, - 0.10056126970052034 - ], - "xyz": [ - 5.4740183878477735, - 10.939210052613085, - 13.663517283826922 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6997920871842911, - 0.29951801994345884, - 0.3004485887490487 - ], - "xyz": [ - 8.202635480054397, - 13.675110478038953, - 13.662387908831313 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6997821355236475, - 0.29998310675968215, - 0.4996379593368858 - ], - "xyz": [ - 10.93227528388038, - 16.398255641316137, - 13.668610434754072 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998577030742323, - 0.3000021920278037, - 0.7005725084909405 - ], - "xyz": [ - 13.679677202046177, - 19.14642977508096, - 13.669904511053916 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.700612870706503, - 0.29989435369221, - 0.8996474380181206 - ], - "xyz": [ - 16.39991945874113, - 21.878470894027483, - 13.678754680678813 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7004572737429068, - 0.5002352130490687, - 0.0995296626344726 - ], - "xyz": [ - 8.199877422667752, - 10.937277396502983, - 16.415651554772264 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7005381689624536, - 0.500104098893072, - 0.29955996348883585 - ], - "xyz": [ - 10.932863121354213, - 13.673161649210186, - 16.41496497051253 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6994189262344227, - 0.5000969347142196, - 0.5004301568579191 - ], - "xyz": [ - 13.679026301097796, - 16.40412069120354, - 16.399564938034864 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7001314156887214, - 0.49989703784421635, - 0.7004891200170477 - ], - "xyz": [ - 16.411463480770784, - 19.149031852472845, - 16.406573011580686 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7003453308326946, - 0.5002625041515985, - 0.8999807740618253 - ], - "xyz": [ - 19.14387405594385, - 21.879370447418992, - 16.414494210494954 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7002005847736716, - 0.6997147987938876, - 0.10049498807537602 - ], - "xyz": [ - 10.940324168314936, - 10.946965746789067, - 19.139391139366627 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6994399434588889, - 0.6999086395129438, - 0.30030558490410825 - ], - "xyz": [ - 13.67474883766954, - 13.668340909583792, - 19.13164194364596 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7005590743359482, - 0.6995794854667439, - 0.49979656335407896 - ], - "xyz": [ - 16.3976534517895, - 16.411046214483264, - 19.14244236468164 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7003048540011892, - 0.7004147366071986, - 0.6995655577861072 - ], - "xyz": [ - 19.140278588492283, - 19.138776293281794, - 19.150386113271566 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.699474754737723, - 0.7002969352680136, - 0.9003832982617807 - ], - "xyz": [ - 21.88421203037731, - 21.87297132615967, - 19.13742658685423 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6996882644438628, - 0.8995994454235373, - 0.10046498076196435 - ], - "xyz": [ - 13.672700823211464, - 10.93955114086993, - 21.865173697519317 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.700055343459345, - 0.8993922813673375, - 0.3003470679734397 - ], - "xyz": [ - 16.40262043110422, - 13.677321696674973, - 21.86736002605793 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7001788937966325, - 0.9002042504046505, - 0.5002488090420778 - ], - "xyz": [ - 19.146742147204964, - 16.412031476224332, - 21.88015027855398 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7003979015636627, - 0.8997234501308489, - 0.6995566862964666 - ], - "xyz": [ - 21.865070154809697, - 19.13992713339787, - 21.876571098524053 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6995602111631443, - 0.9004006795932815, - 0.8997193305924982 - ], - "xyz": [ - 24.610916757658142, - 21.865062024565624, - 21.874377305461515 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9005954921819675, - 0.09976229290056539, - 0.09999412678271079 - ], - "xyz": [ - 2.7310338137542085, - 13.679881164353667, - 13.676711573247074 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8997216312384697, - 0.1006287753225893, - 0.29984418881549907 - ], - "xyz": [ - 5.475194280562398, - 16.40024796993025, - 13.676610695429616 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8998269718050519, - 0.10025669731911825, - 0.4994914430748192 - ], - "xyz": [ - 8.199648620800641, - 19.131229490922916, - 13.67296390920521 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8998478165231611, - 0.10040473419191076, - 0.6994761497747222 - ], - "xyz": [ - 10.93582746703269, - 21.865669388910725, - 13.675272827917333 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8996733840263553, - 0.1000118062326715, - 0.9005925037624706 - ], - "xyz": [ - 13.680082017477782, - 24.612911169989022, - 13.667515977887167 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8998192859167712, - 0.299488150103906, - 0.1003301306623186 - ], - "xyz": [ - 5.466243567345284, - 13.67386279657433, - 16.39671538993621 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994399367821356, - 0.30003964714537334, - 0.3004655527599326 - ], - "xyz": [ - 8.20999900216936, - 16.404891870031037, - 16.399068965131793 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.899855114121477, - 0.300580554720674, - 0.4999847151876429 - ], - "xyz": [ - 10.945184268437924, - 19.138358175145008, - 16.412140385989495 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8995153527327476, - 0.30003424239434845, - 0.7005394509603097 - ], - "xyz": [ - 13.67966343228008, - 21.875661266226814, - 16.400026145650532 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8996217957427698, - 0.29965515320042246, - 0.9004377910800809 - ], - "xyz": [ - 16.40745471747307, - 24.610090660316384, - 16.396298576100513 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9002466154036934, - 0.49938431275721895, - 0.10030071489789345 - ], - "xyz": [ - 8.198785754795718, - 13.67930300136384, - 19.135502116248922 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994677661986458, - 0.4999430065484297, - 0.3001011238219944 - ], - "xyz": [ - 10.93805934248097, - 16.400289941961987, - 19.13249219105892 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9003018036607293, - 0.49974028879267396, - 0.49954561163864625 - ], - "xyz": [ - 13.662056959234931, - 19.138461889438307, - 19.141123480446286 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.900288368148021, - 0.4996293749027972, - 0.6996467366610523 - ], - "xyz": [ - 16.396287127600868, - 21.874024764630782, - 19.139423397797035 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9001245289950816, - 0.4993855402270395, - 0.9001403047642346 - ], - "xyz": [ - 19.1340654380686, - 24.612896759487292, - 19.133849754592376 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8999259504779898, - 0.7005448710425694, - 0.10001135615670437 - ], - "xyz": [ - 10.945060638147574, - 13.670962867594344, - 21.88134898708121 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8997401644253199, - 0.7001118141749251, - 0.3005451900481677 - ], - "xyz": [ - 13.680802443477363, - 16.410085314997715, - 21.872888278066398 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.899565620019205, - 0.7004925733694572, - 0.49974508885503427 - ], - "xyz": [ - 16.409433275154047, - 19.131124135801, - 21.875707609534977 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994910811082424, - 0.7002157243723931, - 0.6998412490132806 - ], - "xyz": [ - 19.14132692987372, - 21.865783737602037, - 21.87090349730626 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9002004928385059, - 0.7004774019455271, - 0.8995248333096223 - ], - "xyz": [ - 21.874942560006055, - 24.6055207085385, - 21.884180055466235 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8999264507651086, - 0.8998512281244031, - 0.09961986829981954 - ], - "xyz": [ - 13.664588925514614, - 13.665617355918263, - 24.6062364657952 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9002761046571044, - 0.9004450519230331, - 0.29962134331013424 - ], - "xyz": [ - 16.40709174367672, - 16.40478192706745, - 24.619135522955453 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9001972914074405, - 0.89937472556414, - 0.500131786576435 - ], - "xyz": [ - 19.133801122813754, - 19.14504709496151, - 24.60342469307239 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.899652101238138, - 0.8996673908989266, - 0.7001508017988511 - ], - "xyz": [ - 21.87242636328933, - 21.872217325799166, - 24.599972218989357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9005662761872006, - 0.8995436670108305, - 0.8999494887202126 - ], - "xyz": [ - 24.60234651638679, - 24.61632744497647, - 24.610779123613703 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15042210323873015, - 0.14978597182565462, - 0.14951559078135002 - ], - "xyz": [ - 4.091997089681698, - 4.100694163857612, - 4.104390764826757 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1506140688722234, - 0.14968533518763535, - 0.34976640476420034 - ], - "xyz": [ - 6.828414287308306, - 6.84111176707193, - 4.105639398413658 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15007974098388668, - 0.14940676808458084, - 0.5504065334177525 - ], - "xyz": [ - 9.56772149174563, - 9.576922256089818, - 4.094525644412455 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14962275838415906, - 0.14984507889908547, - 0.7506030395877652 - ], - "xyz": [ - 12.310764595290893, - 12.307725069228512, - 4.094270367125808 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14978839807927335, - 0.15017539486044262, - 0.9504970596105683 - ], - "xyz": [ - 15.048195676485856, - 15.042904726153129, - 4.101050983589068 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14971281682243556, - 0.34981096792697236, - 0.14984862445818284 - ], - "xyz": [ - 6.831256008363211, - 4.095550104129184, - 6.829399270812649 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.150597200936992, - 0.3497834202659105, - 0.3496379336576334 - ], - "xyz": [ - 9.562362854998986, - 6.83912471785349, - 6.841113784574266 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1501933580259242, - 0.35020017488346594, - 0.54936728591431 - ], - "xyz": [ - 12.298724401884249, - 9.564267203034973, - 6.8412903111012575 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15010406384459776, - 0.34974281971959537, - 0.750548945113175 - ], - "xyz": [ - 15.042990956275965, - 12.313565820929057, - 6.833816619650606 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1502921436219815, - 0.3493735069615719, - 0.9501421160741418 - ], - "xyz": [ - 17.76674368533213, - 15.04493912039865, - 6.831338834961237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15021196581680338, - 0.5499263015911742, - 0.1504182430283629 - ], - "xyz": [ - 9.574984552020279, - 4.110162101893521, - 9.572164367113734 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15046245156879057, - 0.5498289850414821, - 0.35020742248907283 - ], - "xyz": [ - 12.305135757204392, - 6.845068397541777, - 9.574258468877057 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15057087382519105, - 0.5497866629742054, - 0.5495979983510286 - ], - "xyz": [ - 15.030589200399561, - 9.572582789996282, - 9.575162178764725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15011923807214375, - 0.5501893801006544, - 0.7503132841828125 - ], - "xyz": [ - 17.780238335603986, - 12.310551366415755, - 9.574493372107225 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14999638523162256, - 0.5498907249437072, - 0.950564709557354 - ], - "xyz": [ - 20.513956618520297, - 15.046673186957824, - 9.568730590637275 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500748006416289, - 0.7494074508992935, - 0.15011012821562333 - ], - "xyz": [ - 12.298042428494902, - 4.104074314049158, - 12.297559436262212 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14961412219494155, - 0.7499088837777116, - 0.3498751606942508 - ], - "xyz": [ - 15.036049494892664, - 6.828927567590116, - 12.298116623517037 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14969210102629002, - 0.7506244039769864, - 0.5498522889984753 - ], - "xyz": [ - 17.779883260555774, - 9.564044982428385, - 12.308965199433894 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14976494798317097, - 0.7496854314441275, - 0.7506137408438099 - ], - "xyz": [ - 20.511820229669667, - 12.309815365478492, - 12.297123686461726 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14986599234694137, - 0.7494626933810968, - 0.950296900331283 - ], - "xyz": [ - 23.238807208508785, - 15.041229039376, - 12.295459912110307 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1505708968592921, - 0.9499372810384431, - 0.1499408633267349 - ], - "xyz": [ - 15.037336011694727, - 4.108542693146527, - 15.045949716745813 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15034091926064136, - 0.949425215605673, - 0.3502916359824814 - ], - "xyz": [ - 17.769494845879958, - 6.844558181424031, - 15.035804637987972 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14951675903512834, - 0.950146815888585, - 0.5498340535877634 - ], - "xyz": [ - 20.507468450924126, - 9.561398427033902, - 15.03440245691352 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14971186997734845, - 0.9495710947566578, - 0.7502845458294928 - ], - "xyz": [ - 23.24012034407854, - 12.304588997556287, - 15.02919882290968 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14978609044159513, - 0.9495138453806673, - 0.9504126560456881 - ], - "xyz": [ - 25.97545314073087, - 15.041719226199767, - 15.029430848573522 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3496921857962323, - 0.14987129796896204, - 0.14981303900937148 - ], - "xyz": [ - 4.097230311987119, - 6.829145522601749, - 6.829942028610659 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34948588827510374, - 0.15024939467876977, - 0.3504268461550253 - ], - "xyz": [ - 6.845155442956296, - 9.569080920836527, - 6.832290836194426 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34988710010809004, - 0.1495827169795978, - 0.549942931872624 - ], - "xyz": [ - 9.563788756490782, - 12.302314227834565, - 6.828661434655792 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35035010487923285, - 0.1499507969087986, - 0.7494225088585722 - ], - "xyz": [ - 12.296069949256454, - 15.035893215952797, - 6.840023875083643 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3495186690583163, - 0.14985732043352723, - 0.9505220773467403 - ], - "xyz": [ - 15.044189058160216, - 17.77392307751558, - 6.827378640654375 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3495791975069369, - 0.3504985397124701, - 0.150191732711594 - ], - "xyz": [ - 6.845347280332767, - 6.832778199180314, - 9.571336809271031 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34968400872050753, - 0.35027938847183315, - 0.3504404469769522 - ], - "xyz": [ - 9.58011546068541, - 9.571975535893642, - 9.569773573002186 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34956649312683336, - 0.3497563152988614, - 0.5501677341433006 - ], - "xyz": [ - 12.303599617644338, - 12.30100440307636, - 9.561015558690581 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3506119574922189, - 0.3498163219441523, - 0.7496534767080699 - ], - "xyz": [ - 15.031753182609423, - 15.042630968608192, - 9.576129359363767 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3496295196249096, - 0.3501472896859863, - 0.9505306031354763 - ], - "xyz": [ - 17.782634028634327, - 17.775555169557897, - 9.567222577072892 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3494530772637272, - 0.5502675696579582, - 0.15038993139624576 - ], - "xyz": [ - 9.579263236062886, - 6.833763642657591, - 12.300818734996836 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500245231454986, - 0.5494240691017354, - 0.35043487205841095 - ], - "xyz": [ - 12.302709468932111, - 9.576554768536713, - 12.297099252457576 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34995235843072975, - 0.5503277841024462, - 0.5494205883169351 - ], - "xyz": [ - 15.035561793010743, - 12.296065040803658, - 12.308468058287925 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3499503443191883, - 0.5494373132037206, - 0.7504253943225467 - ], - "xyz": [ - 17.77148896201177, - 15.044139031076844, - 12.296266163874854 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3498501967958452, - 0.5496943445386383, - 0.9506248467590028 - ], - "xyz": [ - 20.512093925966912, - 17.77986070997404, - 12.298411051107617 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35042499937346533, - 0.7500491895628694, - 0.15010896940258078 - ], - "xyz": [ - 12.30680032090702, - 6.8432103249917215, - 15.045485025783558 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3505004410902633, - 0.7500938848647235, - 0.3494802109498497 - ], - "xyz": [ - 15.033179114639596, - 9.570009478175056, - 15.047127517477906 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3497117379295541, - 0.7495661617655786, - 0.5503225339257362 - ], - "xyz": [ - 17.77184426752643, - 12.305106558636593, - 15.029129574609907 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34940040369829684, - 0.7502943973147905, - 0.7500072837257155 - ], - "xyz": [ - 20.51185452888321, - 15.030904009077357, - 15.034829374386746 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3497943890225249, - 0.7498502929716768, - 0.9506288676843744 - ], - "xyz": [ - 23.24864499824061, - 17.779152689510518, - 15.034144156181965 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500027985656835, - 0.9505320160130325, - 0.14949921547033124 - ], - "xyz": [ - 15.03942899121888, - 6.829101625537866, - 17.780677888653578 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3497208423086766, - 0.950205656362017, - 0.3495828413780558 - ], - "xyz": [ - 17.770474379172683, - 9.560754088701941, - 17.77236110305596 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3504724473307376, - 0.9494448340713934, - 0.5500325505628408 - ], - "xyz": [ - 20.500584896790013, - 12.311542240301383, - 17.77223508621928 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35001648489599535, - 0.9497975915471489, - 0.7505810536455024 - ], - "xyz": [ - 23.24727076891779, - 15.047171439382419, - 17.770824086596907 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35003475010527335, - 0.9496377382787126, - 0.9497460723120155 - ], - "xyz": [ - 25.968033569310524, - 17.770369443541135, - 17.768888320137943 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5505397577224826, - 0.14967999785840858, - 0.15013209951450007 - ], - "xyz": [ - 4.09897702910488, - 9.579459511209725, - 9.57327845874594 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5505826608727189, - 0.14962209995330403, - 0.34977167034391926 - ], - "xyz": [ - 6.827621736624983, - 12.309482352614257, - 9.573073453156436 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502281874582624, - 0.14978919826031936, - 0.5504594599140219 - ], - "xyz": [ - 9.573673609801121, - 15.048403391097342, - 9.57051169441502 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5494771786691306, - 0.14994598005902088, - 0.7505033146039612 - ], - "xyz": [ - 12.31078067575925, - 17.77309930754092, - 9.562387529962715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5498212670216157, - 0.15053166560810172, - 0.9495423775518929 - ], - "xyz": [ - 15.040014304755676, - 20.499029863152984, - 9.575099231385623 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497955659732778, - 0.35063332713560025, - 0.14979332770101914 - ], - "xyz": [ - 6.841743148128389, - 9.564653428314125, - 12.310501749383821 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5495516153133678, - 0.3498044293762257, - 0.3505321634569318 - ], - "xyz": [ - 9.574875836628218, - 12.305783408267356, - 12.295833958908077 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5501592538624943, - 0.3503214296782636, - 0.5493783546133776 - ], - "xyz": [ - 12.300533504874144, - 15.032680266312592, - 12.311209818846203 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5495412840066359, - 0.349786826091617, - 0.7504993624555483 - ], - "xyz": [ - 15.042914718302903, - 17.773921711114617, - 12.295452042203495 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5494151344356935, - 0.3503680219287741, - 0.9499780883800363 - ], - "xyz": [ - 17.7780979578422, - 20.499434251556547, - 12.301673352846853 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502169101375576, - 0.5501626543816337, - 0.1502514948595328 - ], - "xyz": [ - 9.575936173878363, - 9.576677948807319, - 15.044191337784769 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5505910599752656, - 0.549814713672412, - 0.34998283207040765 - ], - "xyz": [ - 12.301870081837595, - 12.312484148747876, - 15.04454966427179 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497237342817011, - 0.5497283568984673, - 0.5506165746810211 - ], - "xyz": [ - 15.04371784246708, - 15.043654642882723, - 15.031511089238847 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5501829750607, - 0.5504519527364959, - 0.7494638076661262 - ], - "xyz": [ - 17.772214291387776, - 17.768536877020274, - 15.047682618556259 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5494138843189151, - 0.5499717540316013, - 0.9503383458288641 - ], - "xyz": [ - 20.511969629474304, - 20.50434253517901, - 15.030602558113355 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5495681418523163, - 0.7498528500743469, - 0.15057164967694264 - ], - "xyz": [ - 12.310441684189673, - 9.572185204625551, - 17.76544990584279 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500785264449303, - 0.7496741921286618, - 0.3505664165232842 - ], - "xyz": [ - 15.042291558179848, - 12.313455544171692, - 17.769985212848805 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5503033565405245, - 0.750294524402757, - 0.5499989617218883 - ], - "xyz": [ - 17.777378489468646, - 15.04313524086642, - 17.781540120637974 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.549646644014137, - 0.7502796654503188, - 0.7504425568002219 - ], - "xyz": [ - 20.517604092609385, - 17.774585537477765, - 17.772358516262333 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5499268083500655, - 0.7497923111407279, - 0.9496676541246387 - ], - "xyz": [ - 23.23471074231434, - 20.502185563950906, - 17.769525852236615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5506054105193703, - 0.9497771644590788, - 0.14995976329223223 - ], - "xyz": [ - 15.035405323568927, - 9.578000954620942, - 20.512960496241856 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5504111873395253, - 0.949606816301636, - 0.349666066228779 - ], - "xyz": [ - 17.763424980836977, - 12.305694196880212, - 20.5079761425413 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5504813515488193, - 0.9496780948673169, - 0.5502260203541529 - ], - "xyz": [ - 20.506419080567195, - 15.048673061330492, - 20.50990992270106 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497307068332249, - 0.9506303049825446, - 0.7498160218283128 - ], - "xyz": [ - 23.248196099819214, - 17.76716895584938, - 20.51266568856307 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502300350253433, - 0.9494142701988573, - 0.9499832488782836 - ], - "xyz": [ - 25.96822098926923, - 20.51064597913928, - 20.502867005050327 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503830238263989, - 0.1498350541673517, - 0.1494802916260643 - ], - "xyz": [ - 4.092185530925341, - 12.302769273469293, - 12.307619523076518 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.749381972462253, - 0.15018236175866892, - 0.35010630738681026 - ], - "xyz": [ - 6.839856632596544, - 15.032005854206018, - 12.298681655888283 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7497432417804133, - 0.14988649184291852, - 0.5506253800393119 - ], - "xyz": [ - 9.577272220236916, - 17.778405731167354, - 12.299575784746139 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7504552018732191, - 0.14981591616443582, - 0.7495058716291517 - ], - "xyz": [ - 12.295365604792124, - 20.50719780393118, - 12.30834467700957 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7502552455868761, - 0.14944607480835576, - 0.9499060253157866 - ], - "xyz": [ - 15.030144029519251, - 23.244298866752438, - 12.300554506205938 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7501661540239376, - 0.34938452721205343, - 0.1503422061200874 - ], - "xyz": [ - 6.832173947305029, - 12.311588208384283, - 15.032858994735845 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7494650068310825, - 0.35046391046109515, - 0.3499109719413161 - ], - "xyz": [ - 9.575399324726932, - 15.030470494100053, - 15.038030170013538 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7501674379042896, - 0.3504175821139314, - 0.549423361872817 - ], - "xyz": [ - 12.302463414816906, - 17.76777148820864, - 15.047000288385513 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7496477522204014, - 0.35017374729595757, - 0.7505163299926119 - ], - "xyz": [ - 15.048436612475408, - 20.509973302481516, - 15.036561573517744 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7494196843733278, - 0.3499709987503982, - 0.950381311006887 - ], - "xyz": [ - 17.778182715585846, - 23.239373244659127, - 15.03067152934462 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7504520801422705, - 0.5494310571566712, - 0.15005167857233215 - ], - "xyz": [ - 9.563202055994502, - 12.311525298469478, - 17.771768274186414 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7496064917806805, - 0.5500107716126108, - 0.3497997156140245 - ], - "xyz": [ - 12.302047015474855, - 15.030883774383074, - 17.768133294005665 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7498672127612339, - 0.5498380587909178, - 0.5496742351588042 - ], - "xyz": [ - 15.032334170667689, - 17.767096758502134, - 17.769336525712138 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7496737766672685, - 0.5503140525750956, - 0.7495999651299553 - ], - "xyz": [ - 17.772190465540266, - 20.49780072857812, - 17.77319960359234 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7497826764341772, - 0.5496457387022854, - 0.9499704300750634 - ], - "xyz": [ - 20.50248232861353, - 23.238718516635164, - 17.76555139463099 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7505616929553238, - 0.7495822991440914, - 0.15005963262508 - ], - "xyz": [ - 12.29974255560039, - 12.313132651496675, - 20.509698634064623 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7497646229584464, - 0.7498859880399692, - 0.3506250025306742 - ], - "xyz": [ - 15.04598817110353, - 15.044328889554667, - 20.502953216460355 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500125074466053, - 0.7500239909907651, - 0.5504982747341297 - ], - "xyz": [ - 17.78050632298293, - 17.780349322034215, - 20.508229000066006 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7502805587727536, - 0.7495655167221776, - 0.7504344931876857 - ], - "xyz": [ - 20.507730135485865, - 20.51750606169377, - 20.505625571873107 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7495854121350437, - 0.7502173792513237, - 0.9504835780748617 - ], - "xyz": [ - 23.251677362391284, - 23.243037221731587, - 20.505033799331965 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7497332549652487, - 0.9501568532417347, - 0.1505203479288383 - ], - "xyz": [ - 15.048260572507862, - 12.308105213119434, - 23.240591579186397 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503031492601452, - 0.9497095597701021, - 0.3495701739399693 - ], - "xyz": [ - 17.763518648932024, - 15.037270097593789, - 23.242267755573913 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499917652119588, - 0.9503127652477081, - 0.550289737455196 - ], - "xyz": [ - 20.515967308503615, - 17.777214653794857, - 23.24625748562908 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.749629186669248, - 0.9497724836158393, - 0.7505878918948878 - ], - "xyz": [ - 23.247020989115068, - 20.510697859054723, - 23.23391374383706 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7501565746989015, - 0.9499963040550211, - 0.9494241725943271 - ], - "xyz": [ - 25.96853486106409, - 23.236362052458507, - 23.24418413080545 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.950087544689142, - 0.1498571052155727, - 0.14952499361226382 - ], - "xyz": [ - 4.093098166396391, - 15.033704693399924, - 15.038245263460274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499027559141917, - 0.1499483221063097, - 0.34956860717461274 - ], - "xyz": [ - 6.8293055440815005, - 17.766138571304776, - 15.036965965502251 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9498285606309016, - 0.15007216668736426, - 0.5505473636953371 - ], - "xyz": [ - 9.578744107876823, - 20.512869569721953, - 15.037644761764412 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9505607988553477, - 0.15008136905106786, - 0.7497409078641584 - ], - "xyz": [ - 12.302208201975127, - 23.246218879961877, - 15.047781604026289 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9497010563328833, - 0.14978773601295942, - 0.949888246977171 - ], - "xyz": [ - 15.034572097764123, - 25.970843028780465, - 15.032012860969738 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499650865540646, - 0.3497524255778734, - 0.15060631399245622 - ], - "xyz": [ - 6.840814622832423, - 15.046814085419934, - 17.76950387671567 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494470418944783, - 0.3501617822145749, - 0.3499440460809233 - ], - "xyz": [ - 9.571720865406956, - 17.765041064403853, - 17.768017913630633 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9504000966725064, - 0.3494065508990719, - 0.5500517301579033 - ], - "xyz": [ - 12.297231716120374, - 20.51390729509653, - 17.770722520402053 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.949415129551158, - 0.35028558311616936, - 0.7503320915322709 - ], - "xyz": [ - 15.047446736612036, - 23.23863805215284, - 17.769274197459417 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499317785348487, - 0.35060145714708923, - 0.9498483104957219 - ], - "xyz": [ - 17.779515142254336, - 25.973451416809933, - 17.78065630226103 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95051326129256, - 0.5497972986859964, - 0.1495428563558982 - ], - "xyz": [ - 9.561252718504875, - 15.039769230388542, - 20.511975920126023 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9498848650274694, - 0.5497302790634522, - 0.3497594559123715 - ], - "xyz": [ - 12.297661748437164, - 17.768503219911732, - 20.502468319285143 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9498047431767288, - 0.5495075743228096, - 0.5502491571064272 - ], - "xyz": [ - 15.035676075888867, - 20.508466914969254, - 20.498328128636537 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95060382260144, - 0.5499434790573153, - 0.7498196930393999 - ], - "xyz": [ - 17.770128131535312, - 23.247884229608747, - 20.515212609764202 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501456853846788, - 0.5505324553422146, - 0.9496736125776393 - ], - "xyz": [ - 20.510547323508014, - 25.973987474267176, - 20.517001417952756 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9495900362538815, - 0.7498116130698234, - 0.15057523727411698 - ], - "xyz": [ - 12.30992694826929, - 15.04126158992556, - 23.23391345725681 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9495138493611717, - 0.7500593314510657, - 0.34989400226362244 - ], - "xyz": [ - 15.038363986947147, - 17.765270254000892, - 23.23625860489236 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501391213608726, - 0.7501329594755108, - 0.5493838840182018 - ], - "xyz": [ - 17.766760371214207, - 20.501208615401733, - 23.24581384022048 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9503482385820997, - 0.750381092626035, - 0.7495997791275049 - ], - "xyz": [ - 20.50746848205748, - 23.241383307482526, - 23.252065284998 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494300140091391, - 0.7503864064826684, - 0.9502400249421362 - ], - "xyz": [ - 23.25065845768227, - 25.971946831934822, - 23.2395841340083 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500604203088545, - 0.949595423623524, - 0.1497793709534562 - ], - "xyz": [ - 15.030454303993448, - 15.036811654975883, - 25.971752760191567 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494970854523178, - 0.9503717498587122, - 0.3503256486552092 - ], - "xyz": [ - 17.7829007069506, - 17.77094245262597, - 25.974664739982043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9498865287382269, - 0.9494594583427363, - 0.5504166295588485 - ], - "xyz": [ - 20.50603589609464, - 20.511874725669117, - 25.96751645309325 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499679418167245, - 0.9498402806685534, - 0.7505908962118291 - ], - "xyz": [ - 23.24798897269675, - 23.249734332935535, - 25.97383605233867 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500626102245209, - 0.9504897585934476, - 0.9494605164418677 - ], - "xyz": [ - 25.975778169233323, - 25.969938273620063, - 25.984009887052874 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10052830177693867, - 0.09881302875637897, - 0.09998652137006833 - ], - "xyz": [ - 2.7179516654097644, - 2.741402569397713, - 2.7253587896120224 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10077043629691967, - 0.09991593668529435, - 0.30046420919073036 - ], - "xyz": [ - 5.4739252859907515, - 5.485607850870963, - 2.743747967865693 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.098817289903781, - 0.10035523644109169, - 0.5007829358336594 - ], - "xyz": [ - 8.218652886469387, - 8.197626358241651, - 2.723050929132357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09987314393270684, - 0.10085043081882797, - 0.7003928194715365 - ], - "xyz": [ - 10.95445349418481, - 10.9410922037894, - 2.7442565837595283 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09938618538148614, - 0.09940949421014564, - 0.9000150874058076 - ], - "xyz": [ - 13.66395298342862, - 13.663634309318777, - 2.7178987481544628 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10030544516989624, - 0.3003084006368565, - 0.10063200126717377 - ], - "xyz": [ - 5.481585005559558, - 2.747180598947262, - 5.477120389377678 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10098243473957959, - 0.30027119074256275, - 0.2997703379713944 - ], - "xyz": [ - 8.203659773102054, - 5.479019773005348, - 5.4858673419392625 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10048071003399955, - 0.30052354510738116, - 0.49874603387376687 - ], - "xyz": [ - 10.927469815306038, - 8.192520181893078, - 5.482457995527032 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10066275530917572, - 0.2993845319682931, - 0.6991637049302243 - ], - "xyz": [ - 13.651971756193888, - 10.935083395630233, - 5.469374503145843 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09982638599932875, - 0.2989614833766074, - 0.90022091643513 - ], - "xyz": [ - 16.395005917394105, - 13.67246671036948, - 5.4521559682913106 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1006401591428181, - 0.4998209914524267, - 0.10066155432131249 - ], - "xyz": [ - 8.209689278960322, - 2.7521607921731697, - 8.209396767931079 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09885065361846945, - 0.5007965938548298, - 0.3004235525072634 - ], - "xyz": [ - 10.95413762143619, - 5.458805076793916, - 8.198269230950402 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10050230239356801, - 0.5003018463297237, - 0.5004561860160976 - ], - "xyz": [ - 13.682183681786245, - 8.216196281009035, - 8.214086176598073 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09986414544378752, - 0.4989813184750829, - 0.700120473257878 - ], - "xyz": [ - 16.39390385825053, - 10.937245709657804, - 8.18730739051529 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10093036877233559, - 0.49939952601370907, - 0.8991795383461616 - ], - "xyz": [ - 19.121121223696566, - 13.673322630340811, - 8.20760226213374 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10052148083094348, - 0.7008785824359245, - 0.09954083171846301 - ], - "xyz": [ - 10.943190154824237, - 2.7352159259592264, - 10.95659741297323 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10107862096578954, - 0.7002186540501839, - 0.29914246751491985 - ], - "xyz": [ - 13.663085369036216, - 5.471750681912332, - 10.955192110508884 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10001634249218543, - 0.7002209433223564, - 0.5008969192351682 - ], - "xyz": [ - 16.421467215671214, - 8.215577949949267, - 10.940700128944968 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09913148238012733, - 0.6995517325863734, - 0.7010569776993478 - ], - "xyz": [ - 19.148870177458527, - 10.94003259228377, - 10.919453152043303 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10012954240203811, - 0.7008180439943087, - 0.8988173235116703 - ], - "xyz": [ - 21.869926810175592, - 13.657421740336355, - 10.950411230645301 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09992719036077297, - 0.9006683104828712, - 0.09883313581534925 - ], - "xyz": [ - 13.665003863528936, - 2.717415402621231, - 13.67996158034415 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10008224859763504, - 0.8989545260072725, - 0.30101840220740483 - ], - "xyz": [ - 16.405813879423988, - 5.48377589968936, - 13.658650955778866 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09966542445991518, - 0.8999826710495628, - 0.4991845369013776 - ], - "xyz": [ - 19.129162217007824, - 8.18736887873855, - 13.66700882514839 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09893476716495084, - 0.900341796085397, - 0.7009215140141953 - ], - "xyz": [ - 21.892183748285806, - 10.935491102150673, - 13.661929302977368 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10123399460352701, - 0.8994001329823215, - 0.8995151175252382 - ], - "xyz": [ - 24.59444550019426, - 13.682061726184292, - 13.680489678210753 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30081487061324164, - 0.0998015916093993, - 0.10048125460615312 - ], - "xyz": [ - 2.7382310225467137, - 5.486448390697024, - 5.477156160544746 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2992541959857871, - 0.1001046828765001, - 0.3011473821787236 - ], - "xyz": [ - 5.485846008063308, - 8.20858230438112, - 5.459962707206994 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3006983733999176, - 0.10070284644174093, - 0.49959649375571935 - ], - "xyz": [ - 8.207184525298441, - 10.94148737067578, - 5.487885225455583 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30051590517722426, - 0.09982405494298464, - 0.700774759846247 - ], - "xyz": [ - 10.945642888011712, - 13.689465739881195, - 5.473375873570674 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2989333555829914, - 0.10082949906753927, - 0.9004967593113142 - ], - "xyz": [ - 13.689952365829175, - 16.398392633414264, - 5.465485791468217 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2989110125309208, - 0.3008471946362217, - 0.09979910153495816 - ], - "xyz": [ - 5.47756404491906, - 5.451092911688164, - 8.199786251911881 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2987840584367269, - 0.30022982929081093, - 0.30024564540203963 - ], - "xyz": [ - 8.209592604415208, - 8.189826285536924, - 8.189610050511105 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2990921066459992, - 0.29979169343535955, - 0.4999882951060385 - ], - "xyz": [ - 10.934448042940055, - 10.924883418281542, - 8.187831515628321 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29955307867059916, - 0.2996130134809082, - 0.6995676101047525 - ], - "xyz": [ - 13.660617633150906, - 13.659798215212628, - 8.191690961998821 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30071395980796733, - 0.29951144482014047, - 0.9007137781284249 - ], - "xyz": [ - 16.409263207612653, - 16.425703776073522, - 8.206173691502656 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3007575872690739, - 0.4998070300269481, - 0.10054515615840091 - ], - "xyz": [ - 8.207907026132577, - 5.486538873646618, - 10.945175346040099 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3000719831170561, - 0.5007299823194648, - 0.3003991229626929 - ], - "xyz": [ - 10.952892924178707, - 8.209532877523232, - 10.948420327094333 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.299458019486551, - 0.49913640612509724, - 0.5004654990785623 - ], - "xyz": [ - 13.666377319601494, - 10.936410359588885, - 10.918239239965843 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30035687663271676, - 0.49965196551778485, - 0.700968060342141 - ], - "xyz": [ - 16.41466088195225, - 13.689934299831599, - 10.937576888290069 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2988475154937022, - 0.5001289060808708, - 0.9008800788585798 - ], - "xyz": [ - 19.154342660474878, - 16.402459719017415, - 10.923461820011678 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2987790548362602, - 0.7003319125911039, - 0.10071275658842617 - ], - "xyz": [ - 10.951738528982082, - 5.461780137272255, - 13.659665306692784 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30090354515377904, - 0.6988877517640998, - 0.2999244908080997 - ], - "xyz": [ - 13.655581194243446, - 8.214412758624333, - 13.668966649027793 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30093185595880917, - 0.6994228454376024, - 0.49916098519487423 - ], - "xyz": [ - 16.386822387317704, - 10.938725307541752, - 13.676669413645486 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3003922990021061, - 0.6987744722468388, - 0.7001548736819658 - ], - "xyz": [ - 19.125910210256347, - 13.679300846445546, - 13.660428246496748 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3012321130162959, - 0.6998575770990445, - 0.899392428566024 - ], - "xyz": [ - 21.864658212451793, - 16.41472262009599, - 13.686718047112711 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3011812225838559, - 0.899749165244155, - 0.09918199408553202 - ], - "xyz": [ - 13.657207002746802, - 5.47369383292487, - 16.418904094914755 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30073593007194727, - 0.8988955235946346, - 0.30057835046699644 - ], - "xyz": [ - 16.398990900873287, - 8.22106060695794, - 16.401145300867846 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29950313473470647, - 0.899066895610956, - 0.5007138145549109 - ], - "xyz": [ - 19.1375499088599, - 10.940422091636776, - 16.38663371228043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2999666324313198, - 0.9009838025171638, - 0.6989250641940057 - ], - "xyz": [ - 21.873666042079098, - 13.656667475756056, - 16.419178175537375 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3001075240598181, - 0.900372164286136, - 0.8987919486942231 - ], - "xyz": [ - 24.59784790312713, - 16.391137789588154, - 16.41274221272198 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5006277300560018, - 0.09983167717161844, - 0.09887250377656635 - ], - "xyz": [ - 2.7166477951710117, - 8.196259286916781, - 8.209372932922722 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5009320742065669, - 0.09912698115256997, - 0.3004741092113113 - ], - "xyz": [ - 5.463274179258718, - 10.956681086576214, - 8.203899394240155 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5010627572240084, - 0.09921301343653194, - 0.4994419107067084 - ], - "xyz": [ - 8.184702365000035, - 13.678719729108531, - 8.206862286832187 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49961689321964503, - 0.09994079579412847, - 0.6992485628778495 - ], - "xyz": [ - 10.92637305767872, - 16.390672719982845, - 8.197044803812288 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5006202646503626, - 0.09878048278647673, - 0.9000893099125666 - ], - "xyz": [ - 13.656368009218633, - 19.150249175700946, - 8.194899126821928 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49916363148563975, - 0.3007516360333171, - 0.09938209757441627 - ], - "xyz": [ - 5.47055638181288, - 8.183209469477854, - 10.936297552771023 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49998387223668833, - 0.300787886694624, - 0.300395509287015 - ], - "xyz": [ - 8.21927117684969, - 10.942642835903396, - 10.948007349192293 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49975262975431195, - 0.299876926592273, - 0.4991864688828753 - ], - "xyz": [ - 10.92465091152504, - 13.657315547529867, - 10.932391361050366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4995690408175911, - 0.3012489045079986, - 0.6997641785328665 - ], - "xyz": [ - 13.68567068897976, - 16.397067894979973, - 10.948638801261303 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49963041915537476, - 0.300826421924488, - 0.8989918188705821 - ], - "xyz": [ - 16.403699020866853, - 19.121711486288035, - 10.943701849012488 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5009562992118315, - 0.5001801053326759, - 0.0989086751416587 - ], - "xyz": [ - 8.190633970664615, - 8.201245953665534, - 13.687356718379686 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5007379979155997, - 0.500068284817161, - 0.29880136552375386 - ], - "xyz": [ - 10.922002062923927, - 10.93115825985742, - 13.68284335239141 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5011269299286538, - 0.4992353406364413, - 0.5001502808081949 - ], - "xyz": [ - 13.663420326979205, - 13.689281795296262, - 13.676772897957278 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5007311687616451, - 0.49969464597841845, - 0.6989440444981817 - ], - "xyz": [ - 16.387572421231788, - 16.401743574149965, - 13.677641662479495 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4994221799471725, - 0.5002377422041491, - 0.8992503258176364 - ], - "xyz": [ - 19.133548958141606, - 19.122398737765426, - 13.66717051686688 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003378961331093, - 0.7005999819557714, - 0.09874811509564227 - ], - "xyz": [ - 10.928543300229457, - 8.19059611003747, - 16.41900650041312 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4988940897976621, - 0.7009294250309738, - 0.30022522153708564 - ], - "xyz": [ - 13.687606120042124, - 10.92541538309263, - 16.403771126504438 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5004708495301587, - 0.6987502811615831, - 0.5002264115221384 - ], - "xyz": [ - 16.392193526567155, - 13.681352827600016, - 16.39553543901397 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49944050661502204, - 0.6991628123386849, - 0.7009728339086014 - ], - "xyz": [ - 19.142402531076574, - 16.411835117237683, - 16.387088828137667 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4992443558402678, - 0.7002071834651412, - 0.899444881028002 - ], - "xyz": [ - 21.87015508837864, - 19.122627482400347, - 16.398685544106474 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500202616356544, - 0.8988400019926642, - 0.10009461423124563 - ], - "xyz": [ - 13.657254264782374, - 8.207155683094753, - 19.12745885039907 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003751221693832, - 0.9009735468587945, - 0.2995921275244205 - ], - "xyz": [ - 16.413917798345924, - 10.937008243708737, - 19.158986760192818 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4996759699559824, - 0.9001239410455342, - 0.5010999428896038 - ], - "xyz": [ - 19.157280720862094, - 13.68242814076054, - 19.13781241922875 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5001086550099517, - 0.8988412877985364, - 0.7008672553540725 - ], - "xyz": [ - 21.870927254444698, - 16.41952647083307, - 19.12619180708794 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5004543309681019, - 0.9009464834944826, - 0.8994677891193669 - ], - "xyz": [ - 24.614939860607475, - 19.139483239854254, - 19.15969968318585 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998323443492892, - 0.100077259987353, - 0.1010703331952062 - ], - "xyz": [ - 2.750053687425176, - 10.949797244906382, - 10.93622012676179 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998590733108581, - 0.09889634090653707, - 0.3008748276676397 - ], - "xyz": [ - 5.4655994579358005, - 13.681853762075843, - 10.920440247205667 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7008773200528693, - 0.10047586418003662, - 0.4989855637916603 - ], - "xyz": [ - 8.195728740172004, - 16.404309372603315, - 10.955956491259126 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6991055639317901, - 0.10038601462383534, - 0.6995256165671645 - ], - "xyz": [ - 10.936247837549734, - 19.121833746169216, - 10.930504953528372 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7011091497739558, - 0.09999555208503977, - 0.8998346582010787 - ], - "xyz": [ - 13.669498665593958, - 21.887815572749233, - 10.952559284969851 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6996941555360534, - 0.3011067668633055, - 0.10009991674108691 - ], - "xyz": [ - 5.485225561036204, - 10.93464059324005, - 13.682770066878001 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6992781215737248, - 0.2993765664261445, - 0.3010759289633093 - ], - "xyz": [ - 8.209278435515442, - 13.676660515213232, - 13.653427136490373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.700653041770924, - 0.29897510166491387, - 0.5007308821489165 - ], - "xyz": [ - 10.933436263625602, - 16.42510475872575, - 13.666736043988957 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6994353902690021, - 0.3003221114606961, - 0.6992025474450069 - ], - "xyz": [ - 13.665321222120166, - 19.121926129597142, - 13.668504607298122 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7004474202147437, - 0.3009038685644314, - 0.8996482493624792 - ], - "xyz": [ - 16.413732456915493, - 21.876219977239266, - 13.690294576956902 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6988147021736075, - 0.5000921899659061, - 0.10029249103099049 - ], - "xyz": [ - 8.20835128934699, - 10.925249706198485, - 16.391239226090843 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.700055504910029, - 0.5007841948260816, - 0.29881550050818095 - ], - "xyz": [ - 10.931983106664877, - 13.65638458929679, - 16.41766422364615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6988812754444798, - 0.5001870185248158, - 0.5000079176408874 - ], - "xyz": [ - 13.674485132168984, - 16.390997247808382, - 16.393445882855293 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6988484753395199, - 0.5002695412059057, - 0.7008607293390757 - ], - "xyz": [ - 16.421636855442287, - 19.136572298708913, - 16.394125680966077 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7012212951428777, - 0.4998712968277244, - 0.8995859222022987 - ], - "xyz": [ - 19.133127196279048, - 21.885948130244127, - 16.421121720755515 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6997428643016567, - 0.6997053823869122, - 0.09931805775991526 - ], - "xyz": [ - 10.924104649468196, - 10.924617095459839, - 19.133004528041706 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7002545309569358, - 0.7010737721237644, - 0.2991944251252313 - ], - "xyz": [ - 13.675486744512764, - 13.664286226743291, - 19.158708320624775 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7007982161233667, - 0.7006372613738724, - 0.49946449650753977 - ], - "xyz": [ - 16.407575215438246, - 16.409775759801477, - 19.1601735899563 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6990389716647892, - 0.7000858208320035, - 0.6997949399690442 - ], - "xyz": [ - 19.13891778313498, - 19.124605449753673, - 19.1285823205535 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7001758721085025, - 0.7010931888284038, - 0.8995986192624708 - ], - "xyz": [ - 21.884370275692977, - 21.871828886615496, - 19.157898372698412 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6999340578864784, - 0.90064355717294, - 0.09882953651065154 - ], - "xyz": [ - 13.6646162316852, - 10.920552085150568, - 21.882809049121654 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6992784516553446, - 0.8993770928456928, - 0.3010769144227479 - ], - "xyz": [ - 16.412391105652812, - 13.676678501053786, - 21.85653084642017 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7011164156895897, - 0.8991115741482274, - 0.49968814898589475 - ], - "xyz": [ - 19.12413803073955, - 16.41718386342158, - 21.87802903602446 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000327569299424, - 0.9008916967853737, - 0.7002147017680332 - ], - "xyz": [ - 21.890038481870437, - 19.143931210776156, - 21.88755096479413 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.700210890239246, - 0.9011049717389888, - 0.8994083435463059 - ], - "xyz": [ - 24.616293954183796, - 21.869706232853982, - 21.892902228111268 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9003452896260656, - 0.09886902784357048, - 0.09992754739341937 - ], - "xyz": [ - 2.717910993256582, - 13.675550178619734, - 13.661078289867719 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9005072384837209, - 0.10003927665826048, - 0.2987962062119583 - ], - "xyz": [ - 5.452806931414714, - 16.396660821259278, - 13.679291856648444 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9011725319731576, - 0.09915693402497781, - 0.4998424381119473 - ], - "xyz": [ - 8.189411595969055, - 19.154424488308937, - 13.676324399822626 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8991038417888237, - 0.10021485931770574, - 0.7010681864151984 - ], - "xyz": [ - 10.954997570312033, - 21.87726393864031, - 13.662505404162271 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9007195681102569, - 0.09918833430656022, - 0.8993535360507967 - ], - "xyz": [ - 13.651884713989118, - 24.610275466931174, - 13.670560858420288 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8989922621033151, - 0.2999384012481598, - 0.10001078965063494 - ], - "xyz": [ - 5.468033347113959, - 13.658189903030689, - 16.39156422182196 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9011552513832214, - 0.29945825146233496, - 0.29929095631362684 - ], - "xyz": [ - 8.185991393855549, - 16.41228447131392, - 16.41457170047393 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9012008971806611, - 0.29921927689482025, - 0.49978741240110636 - ], - "xyz": [ - 10.923875634849834, - 19.154059990706198, - 16.411928544328646 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9002089458779601, - 0.3003139630955039, - 0.6987739160156303 - ], - "xyz": [ - 13.659349647389186, - 21.861005870894026, - 16.41333311736158 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9002229271040155, - 0.3001156427513369, - 0.8988258310678668 - ], - "xyz": [ - 16.391712020590866, - 24.5962707929495, - 16.4108128661198 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9002196199986793, - 0.498750569333939, - 0.10052910567710449 - ], - "xyz": [ - 8.193243846409484, - 13.682056442668692, - 19.126468613921475 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994392991437054, - 0.5002310858579622, - 0.29923802297987845 - ], - "xyz": [ - 10.930197751591365, - 16.388100586155655, - 19.136041563073494 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.901062222669154, - 0.49975052796185865, - 0.49903723761277 - ], - "xyz": [ - 13.655246549138518, - 19.141907803071614, - 19.15165978033209 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8999704817303971, - 0.5006106297540525, - 0.7006031396573642 - ], - "xyz": [ - 16.422778436914392, - 21.88275444836162, - 19.148492851615323 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994186341080408, - 0.5006277526607059, - 0.9008155058073611 - ], - "xyz": [ - 19.160279969988885, - 24.612477118778187, - 19.141182191552684 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8996568382501865, - 0.7011057490779655, - 0.09911434658759893 - ], - "xyz": [ - 10.940465108322377, - 13.655019860288931, - 21.885337956684772 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9011130536004559, - 0.6999217818447739, - 0.2990586013572365 - ], - "xyz": [ - 13.65787998266891, - 16.408530835683674, - 21.889060083936798 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9010993069517653, - 0.6999287110576913, - 0.49903989692639844 - ], - "xyz": [ - 16.392082994009037, - 19.142451170365554, - 21.888966877182046 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8998415173632286, - 0.7009408222164581, - 0.7002884173788984 - ], - "xyz": [ - 19.157353942484583, - 21.876688444406103, - 21.88560800591235 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8995293681623985, - 0.7005770029040753, - 0.90083560132484 - ], - "xyz": [ - 21.894224870748964, - 24.614265797135012, - 21.876366286074035 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9001749233917333, - 0.8997734413070685, - 0.10103989558189017 - ], - "xyz": [ - 13.682939795545202, - 13.688428786339964, - 24.60857005145637 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8989286649932531, - 0.90099430017828, - 0.3000559747098348 - ], - "xyz": [ - 16.420543169220824, - 16.392302176785467, - 24.608222793691464 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8990755210921838, - 0.9011226373929164, - 0.4998491574578692 - ], - "xyz": [ - 19.153834204276865, - 19.125846398694183, - 24.611985187139762 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9007721442834558, - 0.9004130957444253, - 0.6999864811808282 - ], - "xyz": [ - 21.880374943798216, - 21.885283790795103, - 24.625480388317982 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9001928957934806, - 0.899322331676215, - 0.8993688810016668 - ], - "xyz": [ - 24.591382495313717, - 24.60328469122343, - 24.60264827722473 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1489411038291813, - 0.14986265834924187, - 0.15097518120368816 - ], - "xyz": [ - 4.11300079155654, - 4.100401464038085, - 4.085191251826209 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14889481318857764, - 0.14980974236244735, - 0.35050067763776727 - ], - "xyz": [ - 6.840154006367333, - 6.827645259389438, - 4.083834916673614 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14885918713252208, - 0.15071786132534123, - 0.5498696093107183 - ], - "xyz": [ - 9.57830579279149, - 9.552894333788622, - 4.095763482647184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1491745427633825, - 0.1509054962816511, - 0.7493963041749775 - ], - "xyz": [ - 12.308764161518942, - 12.285098876588807, - 4.10264027941667 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15122815896412065, - 0.14976624144098655, - 0.9492996561905497 - ], - "xyz": [ - 15.026231120556789, - 15.046218193787924, - 4.115141263346552 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15004013752582473, - 0.3488060804861529, - 0.15073068789495456 - ], - "xyz": [ - 6.829576780688192, - 4.112084586404318, - 6.820135700340515 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14952952006681217, - 0.3505981562994975, - 0.3490550615715472 - ], - "xyz": [ - 9.565532857153705, - 6.816558654934954, - 6.837655568298439 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1491800735549051, - 0.3496486868319824, - 0.551159364874028 - ], - "xyz": [ - 12.315685537475265, - 9.574914741101454, - 6.819897022832655 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15065166867558968, - 0.349026773520192, - 0.7495622696359008 - ], - "xyz": [ - 15.01971165200233, - 12.3075629260858, - 6.831513719581131 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1492532352919045, - 0.34941823367517455, - 0.9510893309815786 - ], - "xyz": [ - 17.78030533262549, - 15.04368550442913, - 6.817746562853491 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.150805940900316, - 0.5495649275270172, - 0.15059953959201125 - ], - "xyz": [ - 9.572522564847276, - 4.120761476304609, - 9.575344446382182 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1508580463145069, - 0.54930328135477, - 0.3505921268389962 - ], - "xyz": [ - 12.303208039651695, - 6.855736506323526, - 9.572479642855372 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1488855306391048, - 0.5499960536110498, - 0.5509283174879347 - ], - "xyz": [ - 15.051639835278516, - 9.56772896510022, - 9.554983221182948 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14905582448314547, - 0.550885194848459, - 0.7505107343221907 - ], - "xyz": [ - 17.79245089235387, - 12.29871207000597, - 9.569467626918215 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14896921200246815, - 0.5500267070123175, - 0.949966950890228 - ], - "xyz": [ - 20.507643291985175, - 15.02445741055962, - 9.556546385504726 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14912888052763365, - 0.7511539621287853, - 0.14978969280968765 - ], - "xyz": [ - 12.317539480460912, - 4.086760929324655, - 12.30850497388688 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1507858697419265, - 0.7501142686653888, - 0.3488068981313068 - ], - "xyz": [ - 15.024252386634396, - 6.830342395664628, - 12.3169445302799 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15077428249014846, - 0.7506567412507483, - 0.5494909237362883 - ], - "xyz": [ - 17.775384849123064, - 9.57389985179072, - 12.324202699001265 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15016653432056, - 0.7487859707390122, - 0.7507355784008828 - ], - "xyz": [ - 20.501188705961795, - 12.316971522747275, - 12.290316837723559 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1498212384024219, - 0.7496502635641483, - 0.9512249888017104 - ], - "xyz": [ - 23.25406029280059, - 15.053305830013999, - 12.297412470016592 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14981486342301853, - 0.9509189322494224, - 0.14892881949242692 - ], - "xyz": [ - 15.036920489219249, - 4.084369858957045, - 15.049034322350389 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15019543810967867, - 0.9491493613969761, - 0.3510903394901357 - ], - "xyz": [ - 17.776643147382433, - 6.853488919904693, - 15.030044216791072 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14907540762237517, - 0.9507052237913944, - 0.5507276225137019 - ], - "xyz": [ - 20.527319616770942, - 9.56758106347502, - 15.036002832175402 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1492181986209997, - 0.9495006428539764, - 0.750161667110164 - ], - "xyz": [ - 23.23747716261393, - 12.296159635900636, - 15.021486231254405 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1510663628942233, - 0.9490708321013442, - 0.9496763787793262 - ], - "xyz": [ - 25.959330092662565, - 15.049156630467266, - 15.040877705284299 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3494899979139699, - 0.14977592702150191, - 0.14948379795255848 - ], - "xyz": [ - 4.091425093094858, - 6.8218799218039194, - 6.825873857851282 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3497323142441092, - 0.15010285984455787, - 0.34907143604299895 - ], - "xyz": [ - 6.824621122001417, - 9.55391908925029, - 6.83365652980892 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.349735511342578, - 0.15031139229964802, - 0.5489835857304698 - ], - "xyz": [ - 9.560635066531724, - 12.287125725745236, - 6.836551258153858 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34992608198074043, - 0.15121602946042667, - 0.7493867101479145 - ], - "xyz": [ - 12.31287854743211, - 15.029606617680384, - 6.851524742043576 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3509703650475244, - 0.15037546689098943, - 0.94960254067243 - ], - "xyz": [ - 15.038701323365707, - 17.781198663880186, - 6.854309972013612 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35021614718383814, - 0.3507583320974821, - 0.15023504012782735 - ], - "xyz": [ - 6.849491206257429, - 6.842078551711374, - 9.583596905327939 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3510843183183038, - 0.34955521864533484, - 0.3491501901022754 - ], - "xyz": [ - 9.552574581423752, - 9.573480156914641, - 9.579017634250214 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34931372169439845, - 0.3493814110424292, - 0.5511188019085571 - ], - "xyz": [ - 12.311476821427553, - 12.31055138484536, - 9.552434089654014 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3497989297570113, - 0.3505830110980682, - 0.7488906893178514 - ], - "xyz": [ - 15.031806526820377, - 15.02108670786009, - 9.575495826621292 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34971886326915314, - 0.350192630879522, - 0.9510492173722751 - ], - "xyz": [ - 17.790344325765883, - 17.78386706027509, - 9.56906396393174 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3496625048889536, - 0.5494960218588079, - 0.14957870553879238 - ], - "xyz": [ - 9.557623839529057, - 6.825535965550265, - 12.29313352916058 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3503138072593579, - 0.5508556753598877, - 0.34997448499610867 - ], - "xyz": [ - 12.315987802958317, - 9.574215479824131, - 12.320626955863453 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3498946309336321, - 0.548950963588858, - 0.5510026802367765 - ], - "xyz": [ - 15.038368226728183, - 12.316905876805814, - 12.28885517610447 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34890421782612346, - 0.550340638594797, - 0.7498588839737091 - ], - "xyz": [ - 17.776093836642552, - 15.022091350448987, - 12.294313812912668 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35082330866502787, - 0.5498437338637187, - 0.9488869791823523 - ], - "xyz": [ - 20.49037653723753, - 17.769405107597567, - 12.313757685385367 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3497941419564404, - 0.7499214660720824, - 0.14912953026367295 - ], - "xyz": [ - 12.291663392723107, - 6.821194640332389, - 15.035113844156518 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35048045830190827, - 0.748831506524618, - 0.3507358433490948 - ], - "xyz": [ - 15.033086885350423, - 9.586903057238215, - 15.029595306954597 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3510042546764125, - 0.7491720759863405, - 0.550375750802824 - ], - "xyz": [ - 17.767183969252635, - 12.323505186511134, - 15.041412761081638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.351151763035178, - 0.7501089219313422, - 0.7493109937749051 - ], - "xyz": [ - 20.499799191950984, - 15.045328727811228, - 15.056237857938967 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34986389102755283, - 0.7494388719075673, - 0.9512327870930462 - ], - "xyz": [ - 23.251276800957765, - 17.788359585862764, - 15.029469500351633 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3509411787492812, - 0.9490616455865998, - 0.15043081335552136 - ], - "xyz": [ - 15.032062990014069, - 6.854667629098281, - 17.77340461381178 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3508957578944552, - 0.9492845981657255, - 0.3505460303059768 - ], - "xyz": [ - 17.771050382951987, - 9.58998586875443, - 17.775831795590697 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3502029117813454, - 0.9511113644095001, - 0.5493415884597945 - ], - "xyz": [ - 20.513922690097477, - 12.29841048928682, - 17.79133454751152 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35014955760662375, - 0.9506363432775585, - 0.7487692405422395 - ], - "xyz": [ - 23.233967248979187, - 15.02422000290759, - 17.784110695426378 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3510794437259265, - 0.9497757794601419, - 0.9490438095192796 - ], - "xyz": [ - 25.960319633000633, - 17.77505109618287, - 17.78505845745975 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5499105216315048, - 0.14925226948916023, - 0.14963681112015828 - ], - "xyz": [ - 4.086357710056093, - 9.56408521486084, - 9.558827830899329 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.550022126338541, - 0.14984758513822394, - 0.35109173103908853 - ], - "xyz": [ - 6.848752161699303, - 12.31986645757262, - 9.568492718762263 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.549656588341975, - 0.15062974216235986, - 0.5489667592170017 - ], - "xyz": [ - 9.564757439488382, - 15.020180655623767, - 9.574188659115773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497049786159434, - 0.14893689857733144, - 0.7506948285676969 - ], - "xyz": [ - 12.29960303981594, - 17.778832091849434, - 9.551705989448557 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5507938209983141, - 0.1488069883067137, - 0.9501410165339622 - ], - "xyz": [ - 15.024619311540848, - 20.52051093047052, - 9.564816336672664 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5493158971543131, - 0.34931491663228853, - 0.15104880243543356 - ], - "xyz": [ - 6.840882701624463, - 9.57526010714509, - 12.285918732543934 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5509427568316273, - 0.34937867055029587, - 0.3492015286245017 - ], - "xyz": [ - 9.55086273868198, - 12.306610644784811, - 12.309032497308724 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497731511362655, - 0.3489014038547146, - 0.5507026731275613 - ], - "xyz": [ - 12.299225011767817, - 15.04550738368667, - 12.28651675441678 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5492289821261823, - 0.3505472917653638, - 0.7508931903588709 - ], - "xyz": [ - 15.058696012315753, - 17.775036320224597, - 12.301579256915916 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5488789051450772, - 0.3508926092465511, - 0.9502878234202798 - ], - "xyz": [ - 17.78950466294303, - 20.49633766293442, - 12.301514185889749 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502951554634226, - 0.5490569157667181, - 0.14963347985436898 - ], - "xyz": [ - 9.55236932466029, - 9.569298314910487, - 15.03014363448566 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5489645398344856, - 0.5499727860051664, - 0.3500301326824836 - ], - "xyz": [ - 12.304677903772186, - 12.290893343610948, - 15.024473310161069 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5487400321992589, - 0.5502991698332727, - 0.5504541271094582 - ], - "xyz": [ - 15.049300940207564, - 15.027984691120103, - 15.025866143132404 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5492220568222254, - 0.5495666441509439, - 0.7511594331769469 - ], - "xyz": [ - 17.783292798533, - 17.77858166260048, - 15.022441337738993 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5488516442566646, - 0.5499210335726418, - 0.9504378035112899 - ], - "xyz": [ - 20.512635956020837, - 20.498015457782873, - 15.022222272200265 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5499002044621001, - 0.7512107182021127, - 0.14959799214733324 - ], - "xyz": [ - 12.31569454232976, - 9.563413434368782, - 17.788554334699036 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5488788276969243, - 0.7502891303587711, - 0.34993999700119205 - ], - "xyz": [ - 15.04213458802249, - 12.2884891838842, - 17.761990472305015 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5490766512454162, - 0.7495141191079882, - 0.5505338064866886 - ], - "xyz": [ - 17.774021230103813, - 15.033676248230943, - 17.75409926593308 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5501008081381777, - 0.7488183041354571, - 0.7502672756893033 - ], - "xyz": [ - 20.495228211959756, - 17.77839837583423, - 17.758588297564923 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5493863860603546, - 0.7492480765563556, - 0.9503182751160254 - ], - "xyz": [ - 23.23616523812149, - 20.503692180764453, - 17.75469661869239 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5499810372075163, - 0.9511447937613196, - 0.149749581083001 - ], - "xyz": [ - 15.051229731884076, - 9.56659106175666, - 20.523122158356347 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5506992329857212, - 0.9504649231842197, - 0.3500332503266911 - ], - "xyz": [ - 17.780176938569937, - 12.314652380000304, - 20.52364613360732 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508123662729029, - 0.9495242219838437, - 0.5490580720019412 - ], - "xyz": [ - 20.488347378560732, - 15.037230655414778, - 20.51233177406035 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5511297001990336, - 0.950156348054084, - 0.7494355281794566 - ], - "xyz": [ - 23.236514205327243, - 17.78109370064961, - 20.525312620227936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5507150309207131, - 0.949267211510418, - 0.9507476488380645 - ], - "xyz": [ - 25.97666116800959, - 20.527727494379647, - 20.507487221714786 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503616140635082, - 0.1506034652553439, - 0.14874955925749928 - ], - "xyz": [ - 4.09270066759518, - 12.292486121633615, - 12.317832390733068 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7493372536648728, - 0.15100668670923728, - 0.34926759698369825 - ], - "xyz": [ - 6.839659957278749, - 15.019927769194146, - 12.309340290885565 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7491720976744193, - 0.15109985392942055, - 0.550186428039378 - ], - "xyz": [ - 9.587859815546658, - 17.764595879024405, - 12.308356073376409 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7487978372168246, - 0.15036312084078032, - 0.7507442673685112 - ], - "xyz": [ - 12.319778012267555, - 20.501469736311883, - 12.293166769591123 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7496732413544285, - 0.14938140127213426, - 0.9512484629214186 - ], - "xyz": [ - 15.047613389878698, - 23.254695374952608, - 12.29171324415469 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7510768815597401, - 0.3498814714098116, - 0.15002432381831424 - ], - "xyz": [ - 6.8346220493157945, - 12.31969348171179, - 15.052104429296174 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7504739179658306, - 0.3502855201266685, - 0.3487412260212499 - ], - "xyz": [ - 9.556967848520033, - 15.028271589865446, - 15.049384900901789 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7511883505491761, - 0.3494725247036372, - 0.549329574894371 - ], - "xyz": [ - 12.288260521326038, - 17.780446983437592, - 15.048037367498917 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.749184833743653, - 0.3497599281175616, - 0.7511837722294661 - ], - "xyz": [ - 15.051904101278499, - 20.51276951451541, - 15.02457497410939 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7495917683301067, - 0.3490074166347159, - 0.9506414498072641 - ], - "xyz": [ - 17.76856536519879, - 23.245282516394866, - 15.01985030898576 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7501044868580005, - 0.5497592439848318, - 0.14905280147215694 - ], - "xyz": [ - 9.554032499319767, - 12.293116597738011, - 17.771502952611648 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7492851765199185, - 0.5511676617648273, - 0.34948807220875194 - ], - "xyz": [ - 12.31360307685466, - 15.02223007743361, - 17.779557123518153 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503239067723092, - 0.5487666412062885, - 0.5502307536495086 - ], - "xyz": [ - 15.02529456293738, - 17.780949217448214, - 17.76093213566475 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503936279061308, - 0.5497574901070028, - 0.750902908145236 - ], - "xyz": [ - 17.782394846032922, - 20.525456007517796, - 17.77543205827432 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499044149056842, - 0.5488742908416886, - 0.9508533720661473 - ], - "xyz": [ - 20.504006656296607, - 23.252454327077224, - 17.756668684811043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500994838734975, - 0.750924906469314, - 0.15010014927115073 - ], - "xyz": [ - 12.3186523775736, - 12.307367348419662, - 20.521735280376653 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499619177356929, - 0.7489898932479977, - 0.3510574106534642 - ], - "xyz": [ - 15.039648730426084, - 15.052938074257444, - 20.493399348443038 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7491154428926433, - 0.7497772370542066, - 0.5499642430342438 - ], - "xyz": [ - 17.769831562302876, - 17.760783631648934, - 20.492590919550942 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7501502512450607, - 0.7495973705649535, - 0.7491455171406813 - ], - "xyz": [ - 20.49054298699165, - 20.498101872131553, - 20.504279530814586 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503198032308889, - 0.7496259355857746, - 0.9510008599707728 - ], - "xyz": [ - 23.250663436025913, - 23.26014986957374, - 20.506988150868434 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503916015770703, - 0.9509938877931948, - 0.14916758946406286 - ], - "xyz": [ - 15.04120968799532, - 12.298611339259983, - 23.261036161282174 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7498545233678987, - 0.9488630957838947, - 0.35068593006501503 - ], - "xyz": [ - 17.76720036258164, - 15.046390982053177, - 23.22456151987187 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7497541191951334, - 0.9511056338148851, - 0.550063832476077 - ], - "xyz": [ - 20.5237187326261, - 17.770877068017484, - 23.253848388397426 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7492540535886753, - 0.951207734994562, - 0.7498647195789335 - ], - "xyz": [ - 23.256756405887007, - 20.495682025368374, - 23.24840749038807 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7509058650412354, - 0.9504051006431541, - 0.949729195413694 - ], - "xyz": [ - 25.978294071515936, - 23.25077643222891, - 23.260017286863146 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9490206131634863, - 0.15038517318683325, - 0.14964294081081114 - ], - "xyz": [ - 4.101930369515274, - 15.020730350496878, - 15.030878017940026 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9508751643165149, - 0.14954489136585142, - 0.3505243795389626 - ], - "xyz": [ - 6.836857059341853, - 17.792500311674193, - 15.044744925679288 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501743284004927, - 0.1503508685387865, - 0.5487760084778831 - ], - "xyz": [ - 9.558336819734043, - 20.493379194740513, - 15.046182398018374 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9508416710676865, - 0.14964086685280603, - 0.7505288479178951 - ], - "xyz": [ - 12.306958309796366, - 23.26083148887745, - 15.045599171592146 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9488885256932937, - 0.15088148833643683, - 0.9498901323138917 - ], - "xyz": [ - 15.049551458639574, - 25.959760032115796, - 15.03585767321195 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9504475114180063, - 0.3488890772030638, - 0.15082439980303922 - ], - "xyz": [ - 6.831992709201578, - 15.056391341270112, - 17.764295959041316 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95020298081406, - 0.349224001664013, - 0.3494702921630564 - ], - "xyz": [ - 9.552422620230804, - 17.768899046953997, - 17.765531807583365 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9505960004061099, - 0.3498388277357935, - 0.5488703804975205 - ], - "xyz": [ - 12.286990527308385, - 20.50043445576587, - 17.779310892087036 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9502873003214685, - 0.3507229237966793, - 0.7502106153900934 - ], - "xyz": [ - 15.051765179724502, - 23.248901413983642, - 17.78717760230297 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9495804821058033, - 0.3490238316011495, - 0.950561648217873 - ], - "xyz": [ - 17.767698754699307, - 25.978401180201843, - 17.754284428224988 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9493414303667449, - 0.5491991746269225, - 0.15073253525594074 - ], - "xyz": [ - 9.569340349810727, - 15.040013244679544, - 20.48777741416452 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9509076359628172, - 0.5500257776434081, - 0.34887001714956456 - ], - "xyz": [ - 12.289541505166458, - 17.77032611337492, - 20.52049146280986 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9493580383627621, - 0.5510049839653662, - 0.5503894389731012 - ], - "xyz": [ - 15.058066299418597, - 20.50427755559, - 20.51269317592615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.950631719608556, - 0.549239262179287, - 0.7508240661127327 - ], - "xyz": [ - 17.774231813009397, - 23.261997240340026, - 20.505966086226664 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9503697566224714, - 0.5494810782898102, - 0.9491464544748189 - ], - "xyz": [ - 20.48896587500211, - 25.969843725204154, - 20.50569064177043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.949460007362671, - 0.7511964441447889, - 0.1493544153743646 - ], - "xyz": [ - 12.312169252191152, - 15.022793001064656, - 23.251068886848717 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.949723512868785, - 0.7491119399773489, - 0.3500360193029916 - ], - "xyz": [ - 15.027353052648143, - 17.770078367136737, - 23.226172520930827 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494641687318541, - 0.7510729502904973, - 0.5492035284023653 - ], - "xyz": [ - 17.77714596692265, - 20.489514995033563, - 23.24943739459216 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501547105609971, - 0.7506671042431758, - 0.7487726016234317 - ], - "xyz": [ - 20.5000697594612, - 23.227428405269315, - 23.253329704075984 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494331743402543, - 0.7491914489796034, - 0.9510186654168274 - ], - "xyz": [ - 23.24496664620741, - 25.982635471827663, - 23.223290097596895 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9488532427489341, - 0.9498857889242219, - 0.15053869278421847 - ], - "xyz": [ - 15.044805437511089, - 15.030688652060865, - 25.959218268009685 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494088227069686, - 0.9511150733652007, - 0.3501907414210236 - ], - "xyz": [ - 17.791218864710594, - 17.767891312836362, - 25.983620612797402 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.949909927260061, - 0.9512207726492259, - 0.549400531605051 - ], - "xyz": [ - 20.516224359929705, - 20.498302717721213, - 25.991916725633782 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.951073402653144, - 0.9498722667258059, - 0.7490151526614176 - ], - "xyz": [ - 23.226882998126626, - 23.243304712320725, - 25.98938702152851 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499701500279393, - 0.9488662294695464, - 0.9508789930775221 - ], - "xyz": [ - 25.972974728523457, - 25.988067331692104, - 25.96054918994131 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09871111253340094, - 0.1014856000676176, - 0.10058257767177382 - ], - "xyz": [ - 2.762639753780966, - 2.724707459620912, - 2.7370534192728573 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09850977202500469, - 0.0998206845802195, - 0.3000704721734347 - ], - "xyz": [ - 5.4672399147277435, - 5.449317354237107, - 2.711538303224436 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1017710482541046, - 0.09918370919724723, - 0.49899526700682567 - ], - "xyz": [ - 8.178195290446368, - 8.21356892431069, - 2.7474172720185406 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.100355845998428, - 0.09972319676685333, - 0.698442493398141 - ], - "xyz": [ - 10.912377646111572, - 10.9210271125288, - 2.7354446584592287 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09941324690185249, - 0.09864408526771652, - 0.9015817294534834 - ], - "xyz": [ - 13.674907298221594, - 13.685423137634407, - 2.7078041951025567 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10049574296414632, - 0.2981194453378534, - 0.1008845384751968 - ], - "xyz": [ - 5.455110645974935, - 2.7532349593880396, - 5.449795103731045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1011556835228626, - 0.2983655945880713, - 0.30082819698125557 - ], - "xyz": [ - 8.192069663453355, - 5.495851257153812, - 5.462183000502628 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10116935730907996, - 0.3008758748620629, - 0.49952001082499825 - ], - "xyz": [ - 10.942868477854075, - 8.212516917042853, - 5.496690046102074 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09814920548726441, - 0.3009502568609566, - 0.7006515349110564 - ], - "xyz": [ - 13.69371940878444, - 10.921059938592569, - 5.456416011321655 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10137506250108122, - 0.2990799624465906, - 0.9007660011653041 - ], - "xyz": [ - 16.404078042228374, - 13.70109223705536, - 5.474949019180078 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10101950970007423, - 0.5004515605306162, - 0.10038017044218617 - ], - "xyz": [ - 8.214463276148578, - 2.753500174962558, - 8.223204207401357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10039374674748466, - 0.5003054690844349, - 0.30112044808346283 - ], - "xyz": [ - 10.956950882854406, - 5.489429799173644, - 8.212651552995153 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09997727114808745, - 0.4997778659459883, - 0.49858374865989374 - ], - "xyz": [ - 13.649420289800988, - 8.183418521831152, - 8.199744278425525 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09919924194965854, - 0.4989455612204773, - 0.700108758900234 - ], - "xyz": [ - 16.393254834912742, - 10.927995112179577, - 8.177728082877525 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09849239144753114, - 0.4995394261155246, - 0.9005407822786269 - ], - "xyz": [ - 19.141644594727325, - 13.65860172521276, - 8.176183363994936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09967925949378685, - 0.6985791652997607, - 0.10010373456797252 - ], - "xyz": [ - 10.91944884406967, - 2.731397133873443, - 10.913645497260918 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10032421625573679, - 0.7001356106981778, - 0.298255870276983 - ], - "xyz": [ - 13.649828617425822, - 5.449315198659769, - 10.943742671345067 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10132913586114996, - 0.6986226852663283, - 0.49926574587278977 - ], - "xyz": [ - 16.377315010616417, - 8.21122511598771, - 10.936797307127078 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10180753150678055, - 0.6993788963287786, - 0.6998854211793851 - ], - "xyz": [ - 19.13048988139446, - 10.960601744393772, - 10.953676627810752 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1003147068590424, - 0.7016004108258022, - 0.8986419817691843 - ], - "xyz": [ - 21.878225947927984, - 13.65755603472116, - 10.96363914426601 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09827175666244015, - 0.8998365767710426, - 0.10086774631137357 - ], - "xyz": [ - 13.681449378404638, - 2.7225994395474458, - 13.645957475202556 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10030464859072255, - 0.8988780703229179, - 0.30165952370802224 - ], - "xyz": [ - 16.413533888824087, - 5.495581810117424, - 13.660646280097886 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09860734275989826, - 0.9008515490184236, - 0.5012715285266985 - ], - "xyz": [ - 19.16957433404295, - 8.201435950033519, - 13.664422065792694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09977049946868548, - 0.9016684811653686, - 0.6999672032134968 - ], - "xyz": [ - 21.897274782404658, - 10.933869918284312, - 13.691493484212272 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10044789259424784, - 0.9009084701736856, - 0.8981240826844101 - ], - "xyz": [ - 24.596049236816366, - 13.65229630305426, - 13.690363947617886 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30068730085180245, - 0.09989204117727453, - 0.09826757599659629 - ], - "xyz": [ - 2.70920261727007, - 5.454439264393475, - 5.476648659939975 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29907155512471784, - 0.10149631359385294, - 0.3005971805131993 - ], - "xyz": [ - 5.497349874602678, - 8.198563013269187, - 5.47649179890393 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30020579022317506, - 0.10063705624087742, - 0.5009948294262945 - ], - "xyz": [ - 8.225402847102153, - 10.95387065573601, - 5.480251245144161 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2985890483217069, - 0.10162245754386702, - 0.699603207508335 - ], - "xyz": [ - 10.954213071973996, - 13.647104847102282, - 5.47161967012307 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30028727850849346, - 0.0999175975052131, - 0.9014312865988524 - ], - "xyz": [ - 13.690261700671643, - 16.429679912805913, - 5.471529027981713 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29835082400010987, - 0.301426481415774, - 0.10024457902311355 - ], - "xyz": [ - 5.491574437529591, - 5.449524602960966, - 8.200047359730988 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30052285451060556, - 0.2984303446437442, - 0.2996488040149119 - ], - "xyz": [ - 8.176830466214387, - 8.205438884462339, - 8.188780327262421 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30038970891419725, - 0.2981547130075169, - 0.5004126560180597 - ], - "xyz": [ - 10.917869327191259, - 10.948425788928128, - 8.183191598517729 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29844508751295995, - 0.30123032977365666, - 0.6995177809331271 - ], - "xyz": [ - 13.68204803492322, - 13.643968704078581, - 8.19865436356751 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.299354516832192, - 0.29938549368301715, - 0.9019002063883333 - ], - "xyz": [ - 16.42376185994949, - 16.423338350020842, - 8.185865650562047 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29821757909827873, - 0.5002737348838509, - 0.1012152696449586 - ], - "xyz": [ - 8.223449401897067, - 5.460974010104766, - 10.916829516327157 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29880442092376813, - 0.5009352712418301, - 0.2990172956989771 - ], - "xyz": [ - 10.936807503752666, - 8.17331090175718, - 10.933897118143468 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3001410475330758, - 0.500217754722867, - 0.49829036237396257 - ], - "xyz": [ - 13.651423245486775, - 10.916010518595245, - 10.942361479858842 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3008621882140377, - 0.5011691285014334, - 0.6984179606897183 - ], - "xyz": [ - 16.40053875774537, - 13.661978325385348, - 10.96522779649691 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2988872891379231, - 0.5014308274001893, - 0.9007008652617745 - ], - "xyz": [ - 19.16969211836969, - 16.40055332108487, - 10.941805232048095 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29911159752799965, - 0.7010725465140787, - 0.09871244501292903 - ], - "xyz": [ - 10.934516442858774, - 5.438978701291918, - 13.674337584197366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30002598076642467, - 0.6986755886046261, - 0.3017021224665689 - ], - "xyz": [ - 13.676983997777382, - 8.226718316342906, - 13.654068090158518 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29837115109031287, - 0.7006887123568348, - 0.5012592218373159 - ], - "xyz": [ - 16.432815805674274, - 10.932402525199413, - 13.658966622273981 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30103924709015156, - 0.7009214018331044, - 0.6997138803290541 - ], - "xyz": [ - 19.14923346337024, - 13.682116622512444, - 13.698625639161948 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3006655356976918, - 0.698533867521103, - 0.9013754826608211 - ], - "xyz": [ - 21.87367265200423, - 16.43408843561428, - 13.66087438491478 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3012829021552822, - 0.8983692716414117, - 0.09969992782656811 - ], - "xyz": [ - 13.645422442670313, - 5.48216507460246, - 16.401428582757113 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3004811047487977, - 0.899272403593904, - 0.3015416412525952 - ], - "xyz": [ - 16.417313474613263, - 8.230746619236761, - 16.402814010429914 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3007598477029664, - 0.899712292640151, - 0.49834207782718287 - ], - "xyz": [ - 19.1139477032427, - 10.925177687501604, - 16.412639017785835 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2984916389537561, - 0.901574507554113, - 0.69979588030304 - ], - "xyz": [ - 21.893647696113177, - 13.648407271525448, - 16.407088343149212 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30070649124689425, - 0.8998953121628593, - 0.8982631743002334 - ], - "xyz": [ - 24.584099158395837, - 16.39209745282053, - 16.414411747893535 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49875204321726707, - 0.10128326511417637, - 0.10087960268474352 - ], - "xyz": [ - 2.763934339230629, - 8.198055929076025, - 8.203574729151994 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4989673052236999, - 0.09938197283094602, - 0.2998243437444897 - ], - "xyz": [ - 5.457876903082373, - 10.920935642196273, - 8.180523626693068 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5015639688741245, - 0.09854418314731309, - 0.4995968690095778 - ], - "xyz": [ - 8.177676799699624, - 13.687690766595157, - 8.20457063496973 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003820943308891, - 0.1015346158517683, - 0.6985532814768745 - ], - "xyz": [ - 10.938657716455683, - 16.391628649676097, - 8.229296916609458 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500472147729878, - 0.09875547517229273, - 0.9015577003540505 - ], - "xyz": [ - 13.676101679424567, - 19.168299717630813, - 8.192532199346354 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4989556067467447, - 0.299165099078932, - 0.10014553172302626 - ], - "xyz": [ - 5.459303068410828, - 8.190802926953783, - 10.911762628321602 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5015224172836773, - 0.29842411578977374, - 0.3001052629150181 - ], - "xyz": [ - 8.182985930363746, - 10.959709350694126, - 10.936725009804269 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49891027174634256, - 0.29891318918985993, - 0.5008912898585762 - ], - "xyz": [ - 10.93478287274399, - 13.66910698598136, - 10.90769874969679 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5001745195144434, - 0.29905675509860485, - 0.6990428539961172 - ], - "xyz": [ - 13.6458381976134, - 16.39548407150915, - 10.926946124880164 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5018353256845718, - 0.2997614616204418, - 0.8994411295819433 - ], - "xyz": [ - 16.39528197045259, - 19.157999466641844, - 10.95928698861243 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4990194502910644, - 0.499941544907171, - 0.10180602257498839 - ], - "xyz": [ - 8.226984428053935, - 8.214377716439557, - 13.657614913371138 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5006925117553427, - 0.5014179681272182, - 0.2987237852559266 - ], - "xyz": [ - 10.939394026738745, - 10.92947571780461, - 13.70067410106799 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4999432088103731, - 0.49991527016667, - 0.49852245336308465 - ], - "xyz": [ - 13.650460837308568, - 13.650842809416321, - 13.669885150047914 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49854605769702326, - 0.5007794924337358, - 0.7013031262100322 - ], - "xyz": [ - 16.43465718722624, - 16.404122069524156, - 13.662599042788713 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5007799728449579, - 0.49885125741772846, - 0.8989971684148025 - ], - "xyz": [ - 19.11113206526571, - 19.137501115418015, - 13.666778246529999 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5005520188537896, - 0.6989719684802227, - 0.10153030290996352 - ], - "xyz": [ - 10.944322964037774, - 8.231561128336114, - 16.399676040512894 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5008690236706191, - 0.6981478872804809, - 0.3007618895174176 - ], - "xyz": [ - 13.656914664621045, - 10.959753551542464, - 16.392743383479466 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500484623643413, - 0.6981641658562718, - 0.500290315392865 - ], - "xyz": [ - 16.385053945831572, - 13.682414827014965, - 16.38771049325758 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4997570596342914, - 0.7018106567889247, - 0.6988636058930573 - ], - "xyz": [ - 19.149766398020773, - 16.387325987370115, - 16.427617536749253 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5005751674388701, - 0.7010124391987032, - 0.9002547267007502 - ], - "xyz": [ - 21.892236464087464, - 19.151894163295943, - 16.427889472179704 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4981949485319173, - 0.9011184032550277, - 0.10015604222292747 - ], - "xyz": [ - 13.689243989174416, - 8.180547042421901, - 19.131160269227788 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49947327559031884, - 0.9016558740859727, - 0.3001963724160374 - ], - "xyz": [ - 16.43150758077111, - 10.93293948700626, - 19.155985531127314 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500259460868998, - 0.8993192709888608, - 0.49876227583112454 - ], - "xyz": [ - 19.11431925344441, - 13.658445360251468, - 19.134788497788907 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4992372420700969, - 0.8999558490639089, - 0.7018008857571741 - ], - "xyz": [ - 21.898929762261577, - 16.420377096791437, - 19.12951608722772 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5007951076761004, - 0.900782777633321, - 0.8981328341608987 - ], - "xyz": [ - 24.594450439640447, - 19.12589101376592, - 19.16212056393105 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6992133090753357, - 0.09880279363869555, - 0.10162235273253555 - ], - "xyz": [ - 2.7401765246611243, - 10.948881017818088, - 10.910332513407745 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7006147405361733, - 0.09873219302530928, - 0.30147030771559363 - ], - "xyz": [ - 5.471496553679491, - 13.700326404389472, - 10.928527393204549 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.699977979245414, - 0.09829648600345503, - 0.5013230654293537 - ], - "xyz": [ - 8.197890575670101, - 16.42397164860538, - 10.913864799478791 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7007536439823215, - 0.09810667788925759, - 0.700649987520414 - ], - "xyz": [ - 10.920457353281254, - 19.159738197251727, - 10.921874525770292 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6994835830795251, - 0.10174214381976877, - 0.8987698951895217 - ], - "xyz": [ - 13.678820505167996, - 21.851033869268317, - 10.954213917536302 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6999946455136248, - 0.2989043901758192, - 0.09932400798688838 - ], - "xyz": [ - 5.444506978568868, - 10.928140753301385, - 13.656767814119652 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6994548803870342, - 0.29962582288504436, - 0.3018659220557789 - ], - "xyz": [ - 8.223486868316845, - 13.689877773253698, - 13.659251540609267 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000033120402935, - 0.3015792458580592, - 0.49993969825113577 - ], - "xyz": [ - 10.958222730450974, - 16.40540484696257, - 13.693456446725854 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7006752220294588, - 0.2981795791441345, - 0.7010138088180453 - ], - "xyz": [ - 13.660792145409088, - 19.16364012572152, - 13.656163047781154 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7001152384857698, - 0.30008302061355896, - 0.9014460408081391 - ], - "xyz": [ - 16.427089052526398, - 21.89625752947605, - 13.674530562719385 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7009268539842967, - 0.4992144748044514, - 0.10121945836743343 - ], - "xyz": [ - 8.209024656218038, - 10.96679999613663, - 16.40811622176058 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7006895336918773, - 0.5014314863678332, - 0.29908259055541153 - ], - "xyz": [ - 10.944484367160754, - 13.668704523726566, - 16.43518220447275 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.700679932971545, - 0.498884557020209, - 0.49899024285249705 - ], - "xyz": [ - 13.642764646395658, - 16.401674703234654, - 16.40022978555906 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6995901760493921, - 0.5015379116916483, - 0.7003430144291047 - ], - "xyz": [ - 16.43189968335623, - 19.13963459224772, - 16.42160701253971 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6996314383064873, - 0.5012688652124413, - 0.9007039276730306 - ], - "xyz": [ - 19.167519669227453, - 21.87949706330609, - 16.418492787656156 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7008544432785505, - 0.6984456875734824, - 0.09950611596558662 - ], - "xyz": [ - 10.909453426661512, - 10.942385501085178, - 19.130979514985437 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7013463005639801, - 0.6985535812164133, - 0.30072283849427695 - ], - "xyz": [ - 13.661927340529008, - 13.700108896759458, - 19.139179201722815 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6989397250178379, - 0.7018327150477193, - 0.49974333540710214 - ], - "xyz": [ - 16.427731478129235, - 16.3881790391789, - 19.151108661537084 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7017712636452531, - 0.7000245459535142, - 0.6989225331319066 - ], - "xyz": [ - 19.126152654781635, - 19.150033464653905, - 19.165099985588615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6994131136619653, - 0.6987387652604888, - 0.9016895682574878 - ], - "xyz": [ - 21.88076809875774, - 21.889987668720014, - 19.115280821289584 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6989281814155757, - 0.8991287717961833, - 0.10025759781547461 - ], - "xyz": [ - 13.663430555784055, - 10.926324120206656, - 21.848347014059588 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6993705972164713, - 0.9010940603709318, - 0.2985199013478196 - ], - "xyz": [ - 16.40090615410566, - 13.642979276081242, - 21.881264714896606 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6981256366335498, - 0.9004159998822158, - 0.5009097677019958 - ], - "xyz": [ - 19.15867365577317, - 16.392996221702795, - 21.85497351694897 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6990693732869265, - 0.9007736232939842, - 0.7013704081338834 - ], - "xyz": [ - 21.904224811756148, - 19.146560612424658, - 21.872765477514825 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.700183549976252, - 0.9014854169542547, - 0.8983967353220316 - ], - "xyz": [ - 24.607664807133972, - 21.855501916146775, - 21.897729815459837 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8991926932000079, - 0.09902097105922601, - 0.09999617597804962 - ], - "xyz": [ - 2.7209266112071653, - 13.660730365405948, - 13.647397539292678 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9018162934868018, - 0.09931482863171341, - 0.29898342448545057 - ], - "xyz": [ - 5.445462022932304, - 16.417117600167398, - 13.687284498002356 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9006001787390605, - 0.0983122250519279, - 0.49983151410767196 - ], - "xyz": [ - 8.177713535917, - 19.146450026895813, - 13.656950580397709 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8995224698701539, - 0.09982539980822498, - 0.6988523332813104 - ], - "xyz": [ - 10.91937820480817, - 21.85269260122225, - 13.662904191626254 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9011934898915291, - 0.09839067360260197, - 0.9008054627956377 - ], - "xyz": [ - 13.66082972153218, - 24.63660532132746, - 13.666134758142329 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9001160017945122, - 0.29850432446642194, - 0.09979187333904545 - ], - "xyz": [ - 5.445433923080744, - 13.670560485408474, - 16.387321348980763 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9011795260640262, - 0.2992419315540229, - 0.3009640404808726 - ], - "xyz": [ - 8.205908012586125, - 16.435490455959876, - 16.411946092691593 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.898404358691015, - 0.30009992462854546, - 0.5015029372178801 - ], - "xyz": [ - 10.959370038649196, - 19.139280566353147, - 16.38573483077403 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9010793818868817, - 0.2981658825763607, - 0.7003543060172401 - ], - "xyz": [ - 13.651588284817763, - 21.894513122961328, - 16.395865391593844 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8998035469687958, - 0.29839179708905916, - 0.9014322461743792 - ], - "xyz": [ - 16.40377835116994, - 24.62617154141072, - 16.38151106879706 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8986008577950201, - 0.5011857916414786, - 0.09926155145143051 - ], - "xyz": [ - 8.209207994244496, - 13.642595243983807, - 19.13763110949891 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9004502200706751, - 0.5014871068495362, - 0.29954325735580045 - ], - "xyz": [ - 10.951542953949804, - 16.406094824548838, - 19.167034784934284 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.899330959209692, - 0.4998459818796307, - 0.4989964537701439 - ], - "xyz": [ - 13.6559939885653, - 19.11768069132598, - 19.12929528672382 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9003055034627755, - 0.5000916082123573, - 0.6982792163109316 - ], - "xyz": [ - 16.38391020613399, - 21.85556254349656, - 19.14597723934231 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9017252285271791, - 0.4991102470754124, - 0.8989915655522298 - ], - "xyz": [ - 19.11459632391885, - 24.619075879630742, - 19.15197047205302 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994303481672786, - 0.7000827352720157, - 0.10172079309871274 - ], - "xyz": [ - 10.962113515249492, - 13.687558196183204, - 21.86825496442701 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8995390530423197, - 0.6991872379040766, - 0.3018879953734693 - ], - "xyz": [ - 13.686520395828616, - 16.42569434907195, - 21.857498079086756 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8990344839021631, - 0.7002336740369015, - 0.5017001450078417 - ], - "xyz": [ - 16.4326228258923, - 19.15059171422438, - 21.86490638707446 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8998441367950543, - 0.7015167052481229, - 0.6984351879863159 - ], - "xyz": [ - 19.139890292960462, - 21.85138723813243, - 21.89351718746275 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8988890924314785, - 0.7008795492395616, - 0.901294755647703 - ], - "xyz": [ - 21.904638705043798, - 24.61178953784591, - 21.871748910570957 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9003315684341459, - 0.900515131429011, - 0.10100514231386218 - ], - "xyz": [ - 13.692604908963286, - 13.69009526873883, - 24.620851928123102 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8987045979810157, - 0.8992219741116726, - 0.30147374153761003 - ], - "xyz": [ - 16.415695699128175, - 16.408622225797536, - 24.580928466868254 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8992187576621372, - 0.900135251096457, - 0.5017332515804195 - ], - "xyz": [ - 19.16609383226777, - 19.153563699002568, - 24.60044412402592 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9017796927408034, - 0.8999736939221794, - 0.6988890547965647 - ], - "xyz": [ - 21.8593637051879, - 21.884054995956337, - 24.633247986846698 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8986692185844886, - 0.9007726604511646, - 0.9013493865262587 - ], - "xyz": [ - 24.63828824430687, - 24.609530365725213, - 24.60164547063722 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15061193715756174, - 0.14926551109507608, - 0.1486660199771288 - ], - "xyz": [ - 4.073266265143592, - 4.091674359913204, - 4.0998704945693785 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15108459305432007, - 0.14866901351046677, - 0.349164889213691 - ], - "xyz": [ - 6.806295507942194, - 6.8393208766614375, - 4.0981773533045835 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14948187437582394, - 0.15126401193326106, - 0.548471510435207 - ], - "xyz": [ - 9.566658109427669, - 9.542293045527149, - 4.111743623358274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14964026530272936, - 0.1485203065182813, - 0.750285569519902 - ], - "xyz": [ - 12.288312152136355, - 12.303624027044746, - 4.07639766903393 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1512577600486335, - 0.15068853656676826, - 0.9496844421172986 - ], - "xyz": [ - 15.044101297432398, - 15.051883618416232, - 4.1281554169923815 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1493419569448206, - 0.3502851928151957, - 0.15164091201926994 - ], - "xyz": [ - 6.862243358597944, - 4.1149836075606325, - 6.830812458631986 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14864372361842557, - 0.3515823612377696, - 0.3503591962002816 - ], - "xyz": [ - 9.596818623812696, - 6.822278099235796, - 6.839000991458625 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15148196442005935, - 0.34987307378070936, - 0.5484047294449333 - ], - "xyz": [ - 12.281092435696406, - 9.568724898917283, - 6.854435838374033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14974129083014276, - 0.350152983834748, - 0.7485167954288124 - ], - "xyz": [ - 15.02081546153113, - 12.280822868876907, - 6.834464542248946 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14879265361356234, - 0.3495269113417924, - 0.9499124515522704 - ], - "xyz": [ - 17.765701070402304, - 15.021298430908335, - 6.812935394547917 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14899946275560616, - 0.549859541510501, - 0.15182413049620977 - ], - "xyz": [ - 9.593292860614786, - 4.112806018692042, - 9.554674511705448 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14893261163857527, - 0.5502431143797343, - 0.3491321385101441 - ], - "xyz": [ - 12.296096569964895, - 6.809451612378263, - 9.559004674491643 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14915388711401345, - 0.5503242448575821, - 0.5488721011098644 - ], - "xyz": [ - 15.028014586724654, - 9.543285666318976, - 9.563139114251898 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1483320200886, - 0.5509785606455101, - 0.7509918344862442 - ], - "xyz": [ - 17.800304887570217, - 12.295393861453444, - 9.56084838389222 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15033644006116442, - 0.5505836902581633, - 0.9481367736947663 - ], - "xyz": [ - 20.49023641348094, - 15.018128053292608, - 9.58285385610239 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15147496450858908, - 0.7498947951996413, - 0.15023441861608336 - ], - "xyz": [ - 12.3064045880301, - 4.124916378391559, - 12.323365108174176 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14950278722743568, - 0.7518912218862535, - 0.3494013749801834 - ], - "xyz": [ - 15.056674151690489, - 6.82092790295337, - 12.323696641680716 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1516764106204357, - 0.7486979642613293, - 0.5501586453411424 - ], - "xyz": [ - 17.757733772295264, - 9.595362554796623, - 12.30975638599601 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15052199381075343, - 0.7503893473171249, - 0.7481344378909623 - ], - "xyz": [ - 20.48754745708363, - 12.28626897606815, - 12.317097691858947 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14875598689971004, - 0.7517424041417091, - 0.9495192975317073 - ], - "xyz": [ - 23.259343758172644, - 15.015421999195139, - 12.311451912607893 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1511296399515015, - 0.9509359247516266, - 0.14845262644989057 - ], - "xyz": [ - 15.030642382087924, - 4.09583482143188, - 15.06724202881952 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1483607002151499, - 0.9496405410789707, - 0.35097821508237176 - ], - "xyz": [ - 17.781825522861762, - 6.826871768942962, - 15.011675330749782 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15125369521140392, - 0.9483917972853368, - 0.5496322660931007 - ], - "xyz": [ - 20.48071535017859, - 9.58238670348215, - 15.03415523722679 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15071248901563714, - 0.9481673912418086, - 0.7509609956258227 - ], - "xyz": [ - 23.230177462144617, - 12.327517580790802, - 15.02368792450135 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14869528116204322, - 0.9491341003429481, - 0.9511447346113667 - ], - "xyz": [ - 25.980270181305098, - 15.03681472445122, - 15.009325694647568 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35012424155771077, - 0.15047762011776356, - 0.14821747325655468 - ], - "xyz": [ - 4.083705551496871, - 6.81323822343197, - 6.844138544491983 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35116994858828615, - 0.1485746333708046, - 0.35095893089838864 - ], - "xyz": [ - 6.829532974646841, - 9.59937965714351, - 6.832417970519936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34904008847647877, - 0.15183708745170932, - 0.5498201486709877 - ], - "xyz": [ - 9.59293143396701, - 12.289055367437474, - 6.84790259139852 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35081702519116204, - 0.15081085294985946, - 0.7502264748483419 - ], - "xyz": [ - 12.318820158938005, - 15.05326854471009, - 6.858166056925979 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3486202232080915, - 0.15095523474250594, - 0.9511891418326245 - ], - "xyz": [ - 15.068319530547399, - 17.77075967315096, - 6.830105737518136 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3514971115651169, - 0.3502621706765534, - 0.14842850808947092 - ], - "xyz": [ - 6.818009195766906, - 6.834893085305986, - 9.594326590137312 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3509773738421521, - 0.3499397401511375, - 0.3482308155543203 - ], - "xyz": [ - 9.54526216690499, - 9.559448507954478, - 9.582812617435735 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35112048628984427, - 0.34940441445126486, - 0.550975886512079 - ], - "xyz": [ - 12.309837406316662, - 12.333299231600789, - 9.57745034845031 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3485626148428824, - 0.34967952084075316, - 0.7501369408925358 - ], - "xyz": [ - 15.036492697854413, - 15.021222560094603, - 9.546240795482241 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34895347899446993, - 0.3488705007490559, - 0.9508925341908592 - ], - "xyz": [ - 17.770126256352228, - 17.771260719987445, - 9.54052384273713 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34979188368182174, - 0.5496261726491285, - 0.14879722821056296 - ], - "xyz": [ - 9.548719020341546, - 6.816620591752542, - 12.296681770906611 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3512722695977353, - 0.5507812948080734, - 0.34946172247697843 - ], - "xyz": [ - 12.307960488578114, - 9.58030900752691, - 12.332713962914621 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500291073591538, - 0.5497795069932364, - 0.5485550517400456 - ], - "xyz": [ - 15.016232386780858, - 12.285280878055616, - 12.302021409875294 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3499391477322087, - 0.5515671424956592, - 0.748465562748035 - ], - "xyz": [ - 17.77381314020484, - 15.017191488838003, - 12.325231728863168 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35135123489121817, - 0.5506515624626973, - 0.9484699423871897 - ], - "xyz": [ - 20.49571937243678, - 17.770921167938482, - 12.332019884919207 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.348572075147019, - 0.7500364446600679, - 0.15164614063642307 - ], - "xyz": [ - 12.32764200330827, - 6.838893406912378, - 15.019977933268926 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34842368514847777, - 0.750312526700396, - 0.349785163055603 - ], - "xyz": [ - 15.04033759675986, - 9.545785695053514, - 15.021723715879668 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3493491482644273, - 0.7513312180093341, - 0.5485671755605707 - ], - "xyz": [ - 17.771976855176895, - 12.276150354397084, - 15.048303845228936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35120193871309713, - 0.7505918074744659, - 0.7499431486576654 - ], - "xyz": [ - 20.515043823946392, - 15.054657428417338, - 15.063525775002045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3504628153393065, - 0.7508345036063053, - 0.9505888412352397 - ], - "xyz": [ - 23.26155371447153, - 17.78774405938901, - 15.056738711106993 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34980407277627285, - 0.9510354680403648, - 0.15087482076351216 - ], - "xyz": [ - 15.06511912467462, - 6.8451917102751025, - 17.78484405092772 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34927217122674503, - 0.9510394899105971, - 0.35110037168528824 - ], - "xyz": [ - 17.802621802563856, - 9.575367339635594, - 17.777626974970733 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3491461182019065, - 0.9493643275599337, - 0.5496106807728656 - ], - "xyz": [ - 20.49371649842453, - 12.287641179359268, - 17.75300108257564 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3506670472402009, - 0.9484065961586035, - 0.7513004274978665 - ], - "xyz": [ - 23.238088480166997, - 15.065900960473403, - 17.76070101929264 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500488921739487, - 0.9512666756023078, - 0.9504245080600684 - ], - "xyz": [ - 25.999579558618947, - 17.779838242787438, - 17.791352205834777 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5492747162675281, - 0.14973093013729222, - 0.149132969350819 - ], - "xyz": [ - 4.086013438299548, - 9.548504164390629, - 9.556679376630349 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508629075934979, - 0.15122599709228204, - 0.34939457428332044 - ], - "xyz": [ - 6.8443943401443885, - 12.308158245873122, - 9.59883312886114 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5496441539787774, - 0.1491981721707882, - 0.5492797468773626 - ], - "xyz": [ - 9.549464383200888, - 15.02428976620299, - 9.554446491498153 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508660822103126, - 0.15122840186656378, - 0.7485270660421895 - ], - "xyz": [ - 12.30129480126425, - 17.76506923214152, - 9.598909409291918 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5498067063490862, - 0.1484745588045134, - 0.9515570674027376 - ], - "xyz": [ - 15.039434387812816, - 20.52637526925566, - 9.546775766552285 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508187898657045, - 0.3506071933245673, - 0.14811246297612757 - ], - "xyz": [ - 6.818405371404966, - 9.555662281228015, - 12.32413378550042 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5511084936607272, - 0.35053859240433344, - 0.3481916619866125 - ], - "xyz": [ - 9.552914266587221, - 12.295069853982412, - 12.327156664206017 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502275697479808, - 0.3481670827107908, - 0.5510424490738017 - ], - "xyz": [ - 12.293830860843226, - 15.056365468728021, - 12.282689977378881 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5484135349154021, - 0.35005865471835185, - 0.7500130675052126 - ], - "xyz": [ - 15.03998257333057, - 17.751854791506208, - 12.283750051678549 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5516892905963571, - 0.3498053374447726, - 0.9486177151866556 - ], - "xyz": [ - 17.75180625942741, - 20.511927327804308, - 12.325072285545277 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5503364311865805, - 0.5510056325268935, - 0.15051004356579506 - ], - "xyz": [ - 9.590996050717541, - 9.581846850449022, - 15.057350453519147 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5506044250493792, - 0.5511005709183799, - 0.3482028229903023 - ], - "xyz": [ - 12.295114126908599, - 12.288330909893878, - 15.062312397971928 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5513866727670784, - 0.5498527016242365, - 0.548355045541626 - ], - "xyz": [ - 15.01449864185718, - 15.035470819207308, - 15.055946503590665 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5489788898598991, - 0.5490703637300682, - 0.7502663833444889 - ], - "xyz": [ - 17.76429812538887, - 17.763047511101213, - 15.012331746216384 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5506100344607523, - 0.5503593415641718, - 0.9509016408073867 - ], - "xyz": [ - 20.524969924007117, - 20.528397352164447, - 15.052255134525076 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5491034790601523, - 0.7514114298208244, - 0.14877134037448955 - ], - "xyz": [ - 12.307136801211696, - 9.541218913842924, - 17.780405741537113 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5494570416478674, - 0.7487356302838127, - 0.35170624630743463 - ], - "xyz": [ - 15.045043257217747, - 12.320542263533056, - 17.74865653596898 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5491868120107755, - 0.7486640439010607, - 0.5512470031541266 - ], - "xyz": [ - 17.772149851350047, - 15.04493304284781, - 17.743983288872556 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5517690465440706, - 0.7488877668646776, - 0.7493305372987377 - ], - "xyz": [ - 20.483370975227462, - 17.78839931237378, - 17.78234583469799 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5514154865247739, - 0.7504376278040698, - 0.9497453029329148 - ], - "xyz": [ - 23.244594996108518, - 20.523600104523414, - 17.79870144554337 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5511039565507482, - 0.9482339191178709, - 0.15069020174309386 - ], - "xyz": [ - 15.024292774069353, - 9.594803409244914, - 20.498677555323738 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5496793790311248, - 0.9503068449765015, - 0.3484873680060075 - ], - "xyz": [ - 17.756880696938524, - 12.279574095477205, - 20.507541657111943 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508245620200174, - 0.9499527744900199, - 0.5509952879828759 - ], - "xyz": [ - 20.520691739478185, - 15.063882661666556, - 20.518357604844656 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5507211584781325, - 0.948720049762352, - 0.7513975332279156 - ], - "xyz": [ - 23.243701573478, - 17.80233237164058, - 20.50009029964642 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5504565351093916, - 0.9505486847421689, - 0.9508758340897674 - ], - "xyz": [ - 25.99593376505684, - 20.525945911864444, - 20.52147318487096 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7487820712608524, - 0.14943051909609795, - 0.1517333038346837 - ], - "xyz": [ - 4.1174575776215185, - 12.31168411553865, - 12.28020085709396 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7507816687210441, - 0.15054840181997492, - 0.34810642206280656 - ], - "xyz": [ - 6.817518994257089, - 15.023800177340464, - 12.322822485024114 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7493618569566787, - 0.1487051003636961, - 0.55030978321738 - ], - "xyz": [ - 9.556805665641427, - 17.768876723564496, - 12.278209788431845 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7512237099467994, - 0.14835928526863978, - 0.7496895750483258 - ], - "xyz": [ - 12.277962369458695, - 20.52021626806205, - 12.298936785646344 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7511300442938684, - 0.14836923056597462, - 0.9508640223493258 - ], - "xyz": [ - 15.02851917187246, - 23.26935652021375, - 12.297792176014298 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7507578097117572, - 0.3492635535428513, - 0.1513491108931887 - ], - "xyz": [ - 6.84428623788994, - 12.33344343926511, - 15.03929407457162 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499971681161481, - 0.35002300734429603, - 0.3484384310979104 - ], - "xyz": [ - 9.549239063322926, - 15.01761379404675, - 15.039277835263608 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7485212142032479, - 0.3500677851886512, - 0.5516077377763583 - ], - "xyz": [ - 12.327545448383475, - 17.775129008253817, - 15.019711053666153 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.749094407246677, - 0.34950740872112596, - 0.749521228518375 - ], - "xyz": [ - 15.025721703183752, - 20.48880322136535, - 15.019886279584926 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7506772201377764, - 0.3481431538233821, - 0.9509158995884419 - ], - "xyz": [ - 17.760501547616844, - 23.263874846135305, - 15.022874365129645 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7511784406632085, - 0.5484817022621895, - 0.14944081033616452 - ], - "xyz": [ - 9.541870966192429, - 12.313104288198247, - 17.768719535250312 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7518980247956678, - 0.5492887811261699, - 0.34937236272980055 - ], - "xyz": [ - 12.286333399792932, - 15.056370509578448, - 17.789591796938296 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499498468104642, - 0.5482262617018494, - 0.5508733739717535 - ], - "xyz": [ - 15.026692380995076, - 17.784620926354737, - 17.748430083880816 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7498593548775331, - 0.5488504546744287, - 0.7517943117687268 - ], - "xyz": [ - 17.78218113075286, - 20.530338632727666, - 17.7557267484287 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7495215949541154, - 0.5487847659425913, - 0.9517619852817368 - ], - "xyz": [ - 20.515205084323792, - 23.259642877940127, - 17.75021087103481 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7515970803286103, - 0.7493393056890625, - 0.14869833935538113 - ], - "xyz": [ - 12.277809036271524, - 12.308676924743986, - 20.520532101084136 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7486658002022759, - 0.7509401812866231, - 0.3512151628023871 - ], - "xyz": [ - 15.068469476423012, - 15.037374547626412, - 20.502343049839556 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7485276616658475, - 0.7494110264386161, - 0.5513270974629243 - ], - "xyz": [ - 17.783457497119556, - 17.77138029295192, - 20.479548114800366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.751335112969693, - 0.7501571059699442, - 0.7482806585624989 - ], - "xyz": [ - 20.486371397889947, - 20.50247689754925, - 20.528131348743308 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7510853693625872, - 0.7481986640503709, - 0.9500974198637873 - ], - "xyz": [ - 23.218798365979264, - 23.25826488140093, - 20.497941433695946 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7493724256256694, - 0.9486116050790229, - 0.15148828267162295 - ], - "xyz": [ - 15.040367647347034, - 12.316405448913088, - 23.214532030669023 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7497938566904016, - 0.9497818032905855, - 0.3517344694940727 - ], - "xyz": [ - 17.794096208582744, - 15.059897000495418, - 23.236292499641255 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7481878591277564, - 0.9511359415059168, - 0.5502603562006425 - ], - "xyz": [ - 20.52681993091049, - 17.752150279291108, - 23.232849123979463 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7481717793419598, - 0.9508631172406838, - 0.7501207132871196 - ], - "xyz": [ - 23.255544753886632, - 20.484385266576098, - 23.22889927979652 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7511048254129966, - 0.9492374855368366, - 0.9486134695536331 - ], - "xyz": [ - 25.947076644824982, - 23.238242579490663, - 23.246774013690146 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9518960759114445, - 0.14936775292883028, - 0.1492645079624386 - ], - "xyz": [ - 4.082846517098467, - 15.054869293818632, - 15.056280840415043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9485631279093109, - 0.1514355013280147, - 0.34941346220053165 - ], - "xyz": [ - 6.84751687654885, - 17.745702304195543, - 15.03898325917945 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9512822237091748, - 0.15085442177093417, - 0.5492128954835097 - ], - "xyz": [ - 9.57119434938565, - 20.514499180480925, - 15.068213832407862 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9495861502429793, - 0.15048159470583553, - 0.7484812994607548 - ], - "xyz": [ - 12.290458875724672, - 23.215672520208503, - 15.039928196746104 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9496988870825247, - 0.15186936397017092, - 0.9492198876516701 - ], - "xyz": [ - 15.053894052108516, - 25.961675682786456, - 15.060442846107263 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500417397532256, - 0.34974402618442024, - 0.1485701206718156 - ], - "xyz": [ - 6.812861319272022, - 15.020023605596286, - 17.770437030461625 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.949217465485007, - 0.3511317707800462, - 0.35102135013319863 - ], - "xyz": [ - 9.599711081564118, - 17.776631044145294, - 17.778140695353276 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9488775702560367, - 0.34960635688667274, - 0.5518189055653134 - ], - "xyz": [ - 12.324123931696313, - 20.51725209206385, - 17.752638524788235 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.949910518918925, - 0.35147176574092565, - 0.7483908511791071 - ], - "xyz": [ - 15.03712372325964, - 23.218870637733676, - 17.79226434705824 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9486809060850432, - 0.35102443956901097, - 0.9491518291175867 - ], - "xyz": [ - 17.775775913754796, - 25.946827545798016, - 17.769337538820007 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.951362677262306, - 0.5482973526193525, - 0.1501450725054517 - ], - "xyz": [ - 9.5489791166698, - 15.059615683429824, - 20.503081989736653 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9491813711584673, - 0.5489264356297803, - 0.3501708426723539 - ], - "xyz": [ - 12.292296151436682, - 17.764509584096498, - 20.481860275003697 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9497902942509666, - 0.5495137013745088, - 0.5488830355261455 - ], - "xyz": [ - 15.017082475493103, - 20.489592003513312, - 20.498214353472285 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9515454119703919, - 0.5499958028317864, - 0.7500164571539829 - ], - "xyz": [ - 17.773533616318637, - 23.263447593532007, - 20.528801211356715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9491676916795285, - 0.5488209994096493, - 0.9504100592759355 - ], - "xyz": [ - 20.49721717275875, - 25.970685087067928, - 20.48023174660684 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9517519704405313, - 0.7495963078757143, - 0.1487455016554053 - ], - "xyz": [ - 12.28196751838375, - 15.045803348950667, - 23.260527418449612 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9486328333448716, - 0.7516189869551946, - 0.3494913638516131 - ], - "xyz": [ - 15.05418251636753, - 17.74772036171484, - 23.245536841814847 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9497556339058332, - 0.7483358803314851, - 0.5512412625000815 - ], - "xyz": [ - 17.76758477290747, - 20.52135938822031, - 23.21600152618005 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.950186022395775, - 0.7509248685642965, - 0.7507306149734118 - ], - "xyz": [ - 20.530363472940508, - 23.25462610111679, - 23.257281901245722 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.948734190186134, - 0.7503789001786992, - 0.9492867819263547 - ], - "xyz": [ - 23.237523265917517, - 25.949401086946963, - 23.22996833111173 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9505012953148178, - 0.949852264559717, - 0.14832667345638118 - ], - "xyz": [ - 15.01410476834725, - 15.022978200005452, - 25.98129180696386 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9481051638920219, - 0.950503371411322, - 0.35073481482858637 - ], - "xyz": [ - 17.790294259398504, - 17.757506397871985, - 25.95743414513096 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9513408481403577, - 0.9508189898648397, - 0.549003328510344 - ], - "xyz": [ - 20.5053007688082, - 20.512435521216595, - 26.005986916436214 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9493211053533004, - 0.9487459223168618, - 0.7516421816380272 - ], - "xyz": [ - 23.24740008741253, - 23.25526388635377, - 25.950030750241474 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494541158572519, - 0.9504756681125204, - 0.9485708311049367 - ], - "xyz": [ - 25.96342190893121, - 25.949455430376588, - 25.975498019073612 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09793541679331759, - 0.09959251629986078, - 0.10196943947080185 - ], - "xyz": [ - 2.7557187781444603, - 2.733063211968913, - 2.7005663462219776 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10082048087758234, - 0.09871645045607946, - 0.29848053913689687 - ], - "xyz": [ - 5.430405746257045, - 5.4591716714543566, - 2.7280330085461837 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10230054970217371, - 0.09999058802294034, - 0.49942126418013816 - ], - "xyz": [ - 8.195050949187092, - 8.226632329472467, - 2.7656880225729683 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09828724929591012, - 0.10232619727240633, - 0.6995770745618479 - ], - "xyz": [ - 10.963477189928993, - 10.908257420204972, - 2.74275093106164 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09889803286058407, - 0.0982420129917466, - 0.9017175133244714 - ], - "xyz": [ - 13.671266651080593, - 13.680235636643763, - 2.695263221684811 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09957787651475973, - 0.29797065934732414, - 0.10201902363598978 - ], - "xyz": [ - 5.46858694760493, - 2.75619653141902, - 5.435212023569955 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09813115463082675, - 0.29906556728026384, - 0.30176560429575805 - ], - "xyz": [ - 8.214455628176486, - 5.46731650662766, - 5.430402086558486 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10000684950350397, - 0.2996780220460047, - 0.5022077475418145 - ], - "xyz": [ - 10.963237902366137, - 8.233369572176125, - 5.464419620548003 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09818504562733582, - 0.3022718051268547, - 0.6997849674704124 - ], - "xyz": [ - 13.699939824730768, - 10.909702384470055, - 5.474973981278157 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10025247442701316, - 0.29934340099136897, - 0.90219997983398 - ], - "xyz": [ - 16.42728482483562, - 13.70534951321453, - 5.463202881462545 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09861459250548205, - 0.4987786130609116, - 0.10036770379441456 - ], - "xyz": [ - 8.191420597708984, - 2.7204501381988524, - 8.16745237572673 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10215042320636016, - 0.5001338466565906, - 0.298048947997849 - ], - "xyz": [ - 10.912611495612458, - 5.47145376721713, - 8.234322126397686 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10101690351245056, - 0.49849124846709947, - 0.5018472502999786 - ], - "xyz": [ - 13.676447894213712, - 8.242250195375844, - 8.19636754239705 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09807543695868944, - 0.4991016294782659, - 0.7015908873862544 - ], - "xyz": [ - 16.415651965918684, - 10.93289404650569, - 8.164497360454094 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10166161197569805, - 0.5012408870020646, - 0.8987018319994734 - ], - "xyz": [ - 19.139764864499604, - 13.676788940608628, - 8.242774443574154 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09896474516029401, - 0.6998832914795701, - 0.09873058338994707 - ], - "xyz": [ - 10.91850514671856, - 2.7028549467797567, - 10.921706564293626 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0976474600448203, - 0.7013290014477388, - 0.3011181389119611 - ], - "xyz": [ - 13.705276862512552, - 5.451851491129302, - 10.923462365763198 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10222427882568157, - 0.6981191972325584, - 0.4999178435150255 - ], - "xyz": [ - 16.379346774433632, - 8.232378711060125, - 10.942151942842566 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09756612856027315, - 0.7002919940338546, - 0.7007124259137861 - ], - "xyz": [ - 19.15428024872855, - 10.913920706629533, - 10.908172637644846 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09763528081560102, - 0.7002411685844936, - 0.9016340865218401 - ], - "xyz": [ - 21.900550150267872, - 13.661830921751372, - 10.9084231984372 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10241118349404338, - 0.8999041600484701, - 0.09867428961175162 - ], - "xyz": [ - 13.65238481963361, - 2.74920439291727, - 13.703474960151405 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09989877609564404, - 0.9024201991830197, - 0.29888198172259767 - ], - "xyz": [ - 16.423987182949038, - 5.452058740354593, - 13.70352461259434 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10008118741238403, - 0.9019186398958551, - 0.4978016607381558 - ], - "xyz": [ - 19.13672400061408, - 8.174146681001513, - 13.699161278989328 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09915000808337925, - 0.9015315736912163, - 0.6980375753895532 - ], - "xyz": [ - 21.869021483785446, - 10.899005147476906, - 13.681138463337549 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10151878718532233, - 0.9004903964215974, - 0.897582209625211 - ], - "xyz": [ - 24.582925016802875, - 13.659528990214184, - 13.699289196620757 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.299118484438048, - 0.10237979607907263, - 0.09854483154304344 - ], - "xyz": [ - 2.7470053424165988, - 5.436781276696606, - 5.48921222153958 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29842278942619405, - 0.10209387047606848, - 0.3006232928309605 - ], - "xyz": [ - 5.505876567644305, - 8.19005020832501, - 5.47579168118495 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30105015285831016, - 0.10136361298872712, - 0.4999516676279858 - ], - "xyz": [ - 8.221074279841186, - 10.951152709360949, - 5.501728572182841 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3013613514969049, - 0.10053108698491851, - 0.7005759305487557 - ], - "xyz": [ - 10.952590944457237, - 13.698306171417501, - 5.494601078284563 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30108005636490254, - 0.09749623648347568, - 0.9009474893402358 - ], - "xyz": [ - 13.650542899591134, - 16.433904239922423, - 5.449263332090314 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2999763492159296, - 0.30201388158793613, - 0.09788170046008199 - ], - "xyz": [ - 5.467300416555735, - 5.439443640721488, - 8.230302077308906 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29930921561115986, - 0.30252506751876906, - 0.29919337224686077 - ], - "xyz": [ - 8.226586199156532, - 8.182619650729043, - 8.228169988781424 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30241011029566484, - 0.2995194789481201, - 0.49960908842732205 - ], - "xyz": [ - 10.925541930014916, - 10.965062121484905, - 8.229472996814962 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3016023650137426, - 0.29904267299785964, - 0.6981173868772808 - ], - "xyz": [ - 13.632992849802141, - 13.66798849829873, - 8.211910843587782 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2998214014268075, - 0.2977442226935668, - 0.9017052203585973 - ], - "xyz": [ - 16.39865688450944, - 16.427055698258133, - 8.169809651161415 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2995419462474146, - 0.500683036037911, - 0.09790531146957693 - ], - "xyz": [ - 8.183792141219822, - 5.433827367000319, - 10.940531917308158 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3009246063327592, - 0.49749820800216993, - 0.30110659878354 - ], - "xyz": [ - 10.918381169509004, - 8.230862270733121, - 10.915893001480569 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2999640504888495, - 0.4992314976014217, - 0.4984471795090887 - ], - "xyz": [ - 13.640083291293017, - 10.91573462251041, - 10.92645767829153 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30252669447238417, - 0.4992855213854221, - 0.6992014679668141 - ], - "xyz": [ - 16.38549839076569, - 13.695447125799479, - 10.962232289009071 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3008134995887919, - 0.4982783180746786, - 0.8989505112500944 - ], - "xyz": [ - 19.102661053339016, - 16.4029575986673, - 10.925039494567788 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3000906555802715, - 0.7006972143260348, - 0.10157522441146076 - ], - "xyz": [ - 10.968524373380065, - 5.491503611388564, - 13.682591615542435 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29860927258878195, - 0.6985062897459707, - 0.3017847020980046 - ], - "xyz": [ - 13.675798388112296, - 8.2084783510023, - 13.632384487439516 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2980453108334251, - 0.6994154005691847, - 0.5020355794881642 - ], - "xyz": [ - 16.426021538167664, - 10.93856191791651, - 13.637103303368429 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30104154493841245, - 0.7013642973082582, - 0.6999632074051299 - ], - "xyz": [ - 19.158697405490592, - 13.685556793185487, - 13.704712242144875 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29847881537748144, - 0.702336555288144, - 0.8991158878521024 - ], - "xyz": [ - 21.89476954117368, - 16.373299215508286, - 13.68296760097371 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29970336189150354, - 0.9024712940710543, - 0.09891584384802103 - ], - "xyz": [ - 13.690784699944771, - 5.449850029413747, - 16.435915504882015 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3004165226688715, - 0.8977579166851035, - 0.29999269652492516 - ], - "xyz": [ - 16.375430788697134, - 8.208686771158131, - 16.38122526344846 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30082322899209885, - 0.8975863762216243, - 0.5001659480599226 - ], - "xyz": [ - 19.109818182158936, - 10.950979850603368, - 16.384440408753083 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29952887418288526, - 0.9023619685748309, - 0.6997514913490148 - ], - "xyz": [ - 21.90380684365603, - 13.661981287086341, - 16.432035261831796 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29857236253717456, - 0.9018442711320747, - 0.8985600995484935 - ], - "xyz": [ - 24.614804483158004, - 16.366979537792076, - 16.411880140531913 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49866153962855597, - 0.09978845491624096, - 0.10243668666382673 - ], - "xyz": [ - 2.7647857351572007, - 8.218106752188723, - 8.181900604417445 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4987130948942111, - 0.10186067473100555, - 0.300993160490197 - ], - "xyz": [ - 5.50774512145394, - 10.933439976489657, - 8.210936475037428 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5005680135606133, - 0.0975836634650213, - 0.5003366232383475 - ], - "xyz": [ - 8.174658534156851, - 13.684188031480767, - 8.17782206099261 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49768589115455153, - 0.10164814692435344, - 0.6999678561334182 - ], - "xyz": [ - 10.959549702925301, - 16.374106455246608, - 8.193987088487933 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5015765441318678, - 0.10082216097606374, - 0.8976778073451985 - ], - "xyz": [ - 13.651311836894, - 19.130353627611182, - 8.235886664468719 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.497799306492656, - 0.30013875881848723, - 0.10191747163044636 - ], - "xyz": [ - 5.496840412576338, - 8.199219841478993, - 10.909265600082193 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5017574347744778, - 0.29790632406669204, - 0.2994500370212259 - ], - "xyz": [ - 8.166948644649018, - 10.953964337045937, - 10.932858971399881 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4976837371640509, - 0.2999820752628563, - 0.5016519970331816 - ], - "xyz": [ - 10.959796742298415, - 13.662738277512407, - 10.905543407654438 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4984444587622499, - 0.29900538869175297, - 0.7003005831352536 - ], - "xyz": [ - 13.662331371743903, - 16.389026438715124, - 10.902590773418584 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4976458199568358, - 0.30125957287812877, - 0.9011923241317883 - ], - "xyz": [ - 16.439705894578122, - 19.124663315113732, - 10.922490727868924 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5023524646247082, - 0.5000081894463193, - 0.09847371613717801 - ], - "xyz": [ - 8.18233688639457, - 8.21438739466397, - 13.704094437541354 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5016148741566279, - 0.4993786319642165, - 0.30109579661981883 - ], - "xyz": [ - 10.943942302203785, - 10.974515802934839, - 13.685403036853081 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5018563121556274, - 0.4998892617987255, - 0.5004647856317641 - ], - "xyz": [ - 13.676660472741116, - 13.703553631151614, - 13.6956851729006 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49936453098950245, - 0.4996059961072025, - 0.6985820044744151 - ], - "xyz": [ - 16.38141067011177, - 16.378109402486295, - 13.65774523177127 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.497646790092744, - 0.501667930550957, - 0.900394984034471 - ], - "xyz": [ - 19.168751796887346, - 19.11377548834794, - 13.662450983990963 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4975075801571757, - 0.7005920987526174, - 0.10125961589171047 - ], - "xyz": [ - 10.962772309308614, - 8.186237326285083, - 16.380203152112486 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5022766203334921, - 0.6982066846468212, - 0.2999068416191069 - ], - "xyz": [ - 13.64602847067304, - 10.96730789879278, - 16.412791658695944 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49966430362498265, - 0.6995537836611528, - 0.49839817210763687 - ], - "xyz": [ - 16.378183507918852, - 13.645330516970741, - 16.39549383012033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4976813943089304, - 0.6998096436415877, - 0.7012430842035378 - ], - "xyz": [ - 19.15494070560754, - 16.39147966381633, - 16.37188192247265 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5006090833621442, - 0.6998092521148908, - 0.9017989412436346 - ], - "xyz": [ - 21.89689893012295, - 19.173470078965774, - 16.411903407341633 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500086954132474, - 0.8990469749091483, - 0.10233947399830859 - ], - "xyz": [ - 13.690775279901947, - 8.236265688646995, - 19.12870723374983 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4995278932775281, - 0.9021713370605275, - 0.29810669146290886 - ], - "xyz": [ - 16.409985155927288, - 10.905116468346, - 19.163779571320436 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500115784193788, - 0.9022238482183592, - 0.4981729067739526 - ], - "xyz": [ - 19.145972362838986, - 13.648423290946573, - 19.17253503320504 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5009024017862104, - 0.9018931120601572, - 0.6989587692771871 - ], - "xyz": [ - 21.88655876830553, - 16.40428595576798, - 19.178767762115044 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4992204641941219, - 0.9025296756183254, - 0.8990213842980311 - ], - "xyz": [ - 24.63048181198564, - 19.116510869051986, - 19.16447559649061 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.699910881080612, - 0.10036851788999582, - 0.09781370658301866 - ], - "xyz": [ - 2.7095117001946485, - 10.906346972111377, - 10.941275892434334 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7014128903143169, - 0.10087822251588142, - 0.30011296258033676 - ], - "xyz": [ - 5.482279304222177, - 13.692681186122183, - 10.96877968221416 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6996845470198962, - 0.1018857509803479, - 0.5005697287996189 - ], - "xyz": [ - 8.236662877565346, - 16.40966041323476, - 10.958924831605696 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.701582162364767, - 0.099970048803539, - 0.6976664833632304 - ], - "xyz": [ - 10.905143093208281, - 19.130275619636947, - 10.958677551695068 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6979961803891057, - 0.09923662050992592, - 0.9016416075355502 - ], - "xyz": [ - 13.6838269757567, - 21.869959901704068, - 10.899623351987398 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7013997488619513, - 0.29969023048028004, - 0.10117410768457137 - ], - "xyz": [ - 5.480545075808978, - 10.972645303409879, - 13.686722001370704 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998232004908146, - 0.3010532446726126, - 0.29768624916167397 - ], - "xyz": [ - 8.185858586593474, - 13.637769643947886, - 13.683802600514246 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6979393324146782, - 0.302041894084351, - 0.4997410451950817 - ], - "xyz": [ - 10.961832024899332, - 16.374470540212666, - 13.671563332073957 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000137984924424, - 0.30128559162005564, - 0.7010913864191003 - ], - "xyz": [ - 13.704317615895292, - 19.155657889177327, - 13.689585027727851 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6987170989908137, - 0.2990486979750368, - 0.8997917278318799 - ], - "xyz": [ - 16.39033051035552, - 21.854524948731036, - 13.641274378273653 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6980661051160004, - 0.49910367286212676, - 0.10133947092635605 - ], - "xyz": [ - 8.209150582110254, - 10.929329142647408, - 16.367489713956918 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7002530485114227, - 0.5018286963742985, - 0.30018078178167856 - ], - "xyz": [ - 10.96492922364245, - 13.677751249677828, - 16.434645241363498 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6984217185750813, - 0.5011393691374292, - 0.4986906630468607 - ], - "xyz": [ - 13.669496230617817, - 16.3667050013065, - 16.400183270209652 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7007219285538666, - 0.5020185329475336, - 0.6989531515573293 - ], - "xyz": [ - 16.41946869564727, - 19.136105753765847, - 16.44365109636407 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6977757647108229, - 0.49978176574495803, - 0.901760769480388 - ], - "xyz": [ - 19.161637263944588, - 21.86857557888608, - 16.372790996035953 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6978799145163085, - 0.6995220755938046, - 0.10177956246575318 - ], - "xyz": [ - 10.955251761255422, - 10.93280043059289, - 19.105028476427247 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6986975180112953, - 0.6988961461293711, - 0.3023757066538089 - ], - "xyz": [ - 13.689208542318134, - 13.686492934440864, - 19.107649009271643 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6980963109451018, - 0.6999078335606373, - 0.499786394275757 - ], - "xyz": [ - 16.40200353801817, - 16.37723672689264, - 19.113261022936452 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7003833083461871, - 0.7021252528060822, - 0.6981334251129199 - ], - "xyz": [ - 19.14408459794657, - 19.120269046840885, - 19.174844596532814 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7021048773264966, - 0.7006281624870857, - 0.8986368690968897 - ], - "xyz": [ - 21.86486364411042, - 21.885053023586178, - 19.17791362838413 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7013824755328357, - 0.901480605302701, - 0.09899144087916034 - ], - "xyz": [ - 13.678273730430094, - 10.942568117879855, - 21.914055525828907 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6980443268053383, - 0.9020492104976514, - 0.30046877816027845 - ], - "xyz": [ - 16.44060948769326, - 13.651491438731018, - 21.87619082516976 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6988677660491158, - 0.9007753107801943, - 0.4983600673278369 - ], - "xyz": [ - 19.12872704512494, - 16.368283436919686, - 21.870032210656497 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6995819947160631, - 0.8979034700545538, - 0.7019007981160394 - ], - "xyz": [ - 21.872235989660076, - 19.160820476697793, - 21.840533726960214 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7023715157774658, - 0.8996218322439293, - 0.8996381711870025 - ], - "xyz": [ - 24.59915890010708, - 21.902388078434555, - 21.902164695345867 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9019259140404885, - 0.09834365449293402, - 0.10088278981524852 - ], - "xyz": [ - 2.723788085821496, - 13.71022009354894, - 13.675505492466614 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.898378212832132, - 0.09923550526039092, - 0.30007554163912303 - ], - "xyz": [ - 5.459308757221712, - 16.385044009455193, - 13.639195183291715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.897917044746893, - 0.10198501080164446, - 0.5004205270163801 - ], - "xyz": [ - 8.235980080051224, - 19.11781958038455, - 13.670480921089604 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8984045697652201, - 0.10238757555727812, - 0.6996142027960739 - ], - "xyz": [ - 10.964823953326924, - 21.847825015078946, - 13.682650068263035 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9001618577876864, - 0.09972546928948686, - 0.8980006175721235 - ], - "xyz": [ - 13.6407314688763, - 24.584153693873752, - 13.670279556080237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9006605789569757, - 0.3018349883061302, - 0.09784601596913936 - ], - "xyz": [ - 5.464366747870716, - 13.651402434642756, - 16.440302946419074 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8996529904110171, - 0.3005996961743561, - 0.29786767857430846 - ], - "xyz": [ - 8.182138223436286, - 16.372287032646952, - 16.409638685511634 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8984468015302591, - 0.3008686543118629, - 0.49873625420858075 - ], - "xyz": [ - 10.93205438040797, - 19.102035245111384, - 16.39682503549144 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9006811873025588, - 0.29958051722333356, - 0.701854802085281 - ], - "xyz": [ - 13.6914434272299, - 21.90958359043245, - 16.409761977171183 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8995125418987276, - 0.29894839541511903, - 0.9025061988950848 - ], - "xyz": [ - 16.42607095158213, - 24.63687586075966, - 16.385142211986192 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9004639759039101, - 0.5000477610335938, - 0.10177038186739173 - ], - "xyz": [ - 8.227949322476551, - 13.70236773726484, - 19.147544375296903 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994582605901857, - 0.4978639591241759, - 0.3015822695907718 - ], - "xyz": [ - 10.929884938669595, - 16.42040994133862, - 19.1039378699352 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.898392874512405, - 0.4987520015657388, - 0.5010130416222163 - ], - "xyz": [ - 13.668607712757947, - 19.132425792327638, - 19.101513259662685 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9001476774937656, - 0.4975823129006704, - 0.7008937771150273 - ], - "xyz": [ - 16.385349376998413, - 21.889150579949582, - 19.109512837274455 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8999293248176169, - 0.4977239854084725, - 0.9017306415323996 - ], - "xyz": [ - 19.13309175770275, - 24.631970761143478, - 19.10846447981525 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8982389970981964, - 0.7022860449920053, - 0.09995531539343941 - ], - "xyz": [ - 10.96809947574493, - 13.647132965409394, - 21.882090280949658 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8992326314505924, - 0.7004115288210503, - 0.2982108978085738 - ], - "xyz": [ - 13.652986064843427, - 16.371232392196053, - 21.870047023285046 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.901518209303456, - 0.699806391411712, - 0.5009717353901763 - ], - "xyz": [ - 16.41682240957259, - 19.174590075661293, - 21.893021702549646 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9022109985534944, - 0.6984706385710009, - 0.7004008341135306 - ], - "xyz": [ - 19.12511897767783, - 21.910620506093682, - 21.884231220071417 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9016463477120789, - 0.6994870016238642, - 0.9010055855633771 - ], - "xyz": [ - 21.881646563358267, - 24.64553275439404, - 21.89040694811813 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9017121917890192, - 0.9007037019503922, - 0.09984438494924512 - ], - "xyz": [ - 13.679313345436197, - 13.693101236981734, - 24.642305664344356 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9018474734730316, - 0.9010176317036083, - 0.29850945345752256 - ], - "xyz": [ - 16.39971839344765, - 16.411063840747687, - 24.648447202256087 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000317392648961, - 0.8995391518861444, - 0.49818300115362063 - ], - "xyz": [ - 19.109405686372117, - 19.116140252348682, - 24.603409301056615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8989764871800934, - 0.9021501031980415, - 0.7004984834500549 - ], - "xyz": [ - 21.911122999907175, - 21.867733892960672, - 24.624678540863588 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.900418705194513, - 0.8998115080006153, - 0.9019248113689773 - ], - "xyz": [ - 24.63301464588358, - 24.641316136623054, - 24.612423433365414 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14870087180062933, - 0.14927108673062078, - 0.15247763752500434 - ], - "xyz": [ - 4.12545424325254, - 4.117658367368385, - 4.073818982086715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15012124378404518, - 0.15064915931004386, - 0.3515930558456006 - ], - "xyz": [ - 6.866565162009242, - 6.859347595962583, - 4.112078812429828 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14863286414156268, - 0.1502144586213939, - 0.5523055707587609 - ], - "xyz": [ - 9.604727388080185, - 9.58310411303894, - 4.085786804297045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15127086190919736, - 0.14756711835302788, - 0.7501622468596121 - ], - "xyz": [ - 12.273594289901474, - 12.324231205127584, - 4.085659075308696 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.148936410834623, - 0.15251660692948188, - 0.9491325828318891 - ], - "xyz": [ - 15.061549425563305, - 15.01260162898969, - 4.121411397327644 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14988261496555758, - 0.3503003829441301, - 0.147854344323424 - ], - "xyz": [ - 6.8106817633510905, - 4.070606114746283, - 6.838411914481625 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15087536400868837, - 0.35193143265662025, - 0.34834747826737406 - ], - "xyz": [ - 9.574087219948883, - 6.825284839486716, - 6.874284018784699 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14937415499825918, - 0.3488417814678906, - 0.5492741196137084 - ], - "xyz": [ - 12.278878938725425, - 9.55179345380539, - 6.8115186044966345 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1482969487372981, - 0.34912767968937236, - 0.7521771455254123 - ], - "xyz": [ - 15.056841335467995, - 12.311119731422806, - 6.800699983416321 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15230049998297077, - 0.3500223575728911, - 0.9493720687884464 - ], - "xyz": [ - 17.76508670621546, - 15.061869059180435, - 6.867667690389382 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15009775994238383, - 0.5501563461109592, - 0.15193372193628132 - ], - "xyz": [ - 9.598849034129623, - 4.129320054578371, - 9.573748092222216 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14994228291100836, - 0.549511505569311, - 0.35229408836348824 - ], - "xyz": [ - 12.329323755242322, - 6.8664852655180875, - 9.562806294421 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14868462968231155, - 0.5517017024594046, - 0.5511959445001416 - ], - "xyz": [ - 15.078618107654462, - 9.568641231719146, - 9.575555863501757 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15031720112408029, - 0.5482350766802838, - 0.7521895268674127 - ], - "xyz": [ - 17.779171103275466, - 12.338909533888652, - 9.55048100273126 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15047153161147678, - 0.5494831631113484, - 0.9480139983331354 - ], - "xyz": [ - 20.47351164177992, - 15.018296438007345, - 9.569654594405414 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15177746620444688, - 0.749737930940339, - 0.15068860575218607 - ], - "xyz": [ - 12.310469532883598, - 4.135261691898133, - 12.325356236992025 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15200287967480247, - 0.7491424924093826, - 0.3506837151849183 - ], - "xyz": [ - 15.036625941511915, - 6.872640641335027, - 12.320297320968 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14861917453681592, - 0.7488752595663503, - 0.550192305999768 - ], - "xyz": [ - 17.760617924258163, - 9.554024775829678, - 12.270382354060349 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15164705142427765, - 0.7492586082486402, - 0.7479839486330133 - ], - "xyz": [ - 20.470030734025727, - 12.299593099203271, - 12.31702001602939 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15017205366339037, - 0.7510607584022957, - 0.951206387058269 - ], - "xyz": [ - 23.273090004650655, - 15.057847793427195, - 12.321492784655886 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1512176611677065, - 0.9510909787051316, - 0.14757642227531112 - ], - "xyz": [ - 15.020782946072435, - 4.085058925897917, - 15.070565308786264 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15159639082782372, - 0.9495096878840535, - 0.3510530892577081 - ], - "xyz": [ - 17.781060187782277, - 6.872133214822975, - 15.054124109054616 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14789789675309026, - 0.9493835345278869, - 0.5511780424317124 - ], - "xyz": [ - 20.515407779107786, - 9.557640406865568, - 15.001834217815889 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14794559894483317, - 0.9515786176136978, - 0.7511690444322839 - ], - "xyz": [ - 23.279659540913492, - 12.292533563616136, - 15.032497174429253 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14893897917303392, - 0.9498146535499453, - 0.9524429416932212 - ], - "xyz": [ - 26.007323435797428, - 15.057895373337683, - 15.02196189093468 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34926524015374855, - 0.14942932630096847, - 0.14880308788029842 - ], - "xyz": [ - 4.077379884851728, - 6.8095005285824435, - 6.818062347546928 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3513597940968455, - 0.14818226491715183, - 0.3515138473667178 - ], - "xyz": [ - 6.831755301844854, - 9.609561908834372, - 6.829649113268748 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35023627680328645, - 0.14949302597425665, - 0.5521614760835406 - ], - "xyz": [ - 9.592894054323832, - 12.33741964587318, - 6.832209076300069 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3509488642551998, - 0.15174678488716475, - 0.7493503910064152 - ], - "xyz": [ - 12.319638391325363, - 15.04309336407085, - 6.872764429857561 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3507289828052196, - 0.15134205215582452, - 0.9503932512424692 - ], - "xyz": [ - 15.062726755706858, - 17.78870898189787, - 6.864224817201101 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3490164934676514, - 0.35252262004055335, - 0.14908121056173684 - ], - "xyz": [ - 6.857837283305002, - 6.80990215190307, - 9.591316482843743 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34974495801507843, - 0.35028596985959226, - 0.3520354589659454 - ], - "xyz": [ - 9.60201215704556, - 9.5946155404895, - 9.57069684033548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3524728044776056, - 0.349658760841969, - 0.5487655735609915 - ], - "xyz": [ - 12.283095783577082, - 12.32156888163565, - 9.599416377367465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3523809194590023, - 0.3498941692604171, - 0.7492444772335783 - ], - "xyz": [ - 15.027225729909535, - 15.061224131009556, - 9.601378603455931 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34801344086245883, - 0.35032873919251833, - 0.9520801499181418 - ], - "xyz": [ - 17.806299898320905, - 17.77464555630603, - 9.547608584119237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3493910440558186, - 0.5481752007605561, - 0.15219093385267374 - ], - "xyz": [ - 9.575279726527848, - 6.857538517208883, - 12.271364137205406 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35251130967652683, - 0.5492054604130538, - 0.3488693524578795 - ], - "xyz": [ - 12.278317188105083, - 9.589150164182417, - 12.328109371646129 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34824440521630795, - 0.5515114890648479, - 0.5513797028332065 - ], - "xyz": [ - 15.078529855215656, - 12.299498872913512, - 12.301300630550992 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3491654733245347, - 0.5499369410401292, - 0.7485179080773325 - ], - "xyz": [ - 17.752240975261095, - 15.007329607517674, - 12.292366370759098 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35126571389929484, - 0.548387926700395, - 0.9516393104133809 - ], - "xyz": [ - 20.508102380916863, - 17.813082969498524, - 12.299902636623651 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34813380871949196, - 0.7516103399703851, - 0.1512350115346745 - ], - "xyz": [ - 12.343539133613902, - 6.827280624127317, - 15.035504046941233 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35066027777741116, - 0.7479745388123724, - 0.3519254815461826 - ], - "xyz": [ - 15.037635096338498, - 9.605626036035494, - 15.020337458148534 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.352291377078123, - 0.7501858149842621, - 0.5490828822513487 - ], - "xyz": [ - 17.763367760239767, - 12.323426626185856, - 15.072869723982356 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34878268654796096, - 0.7515333230600459, - 0.7483127780321143 - ], - "xyz": [ - 20.505625921833815, - 14.999291714555163, - 15.04332242647894 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3523745166615678, - 0.7492200512286784, - 0.9499244847545091 - ], - "xyz": [ - 23.23039824994566, - 17.804797533540345, - 15.060802645173224 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34750834739252945, - 0.9511115043512832, - 0.1504039852362952 - ], - "xyz": [ - 15.059721500853245, - 6.807367787481416, - 17.75449686146809 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.350697273145455, - 0.9508738004188205, - 0.3509574520113288 - ], - "xyz": [ - 17.798402553599562, - 9.59289710449302, - 17.794845434977532 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.352389368313074, - 0.9499620446301162, - 0.548618405219532 - ], - "xyz": [ - 20.488322165863416, - 12.31841609833855, - 17.805514094504964 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35185373827300676, - 0.9491136201150658, - 0.748125283973045 - ], - "xyz": [ - 23.204344793689913, - 15.038715195924013, - 17.786591549757215 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35046578946809015, - 0.951230942533036, - 0.9475102559409536 - ], - "xyz": [ - 25.959247892120658, - 17.745694857144272, - 17.796563414507634 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5513356348159041, - 0.14792384332106748, - 0.15141700343090062 - ], - "xyz": [ - 4.092534175440492, - 9.607907574635428, - 9.56014971838261 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5511639389768067, - 0.14869013654811067, - 0.35172806491883457 - ], - "xyz": [ - 6.84162757517981, - 12.344176956700505, - 9.568278946843074 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5494806985252773, - 0.15155256104097203, - 0.5511182923065437 - ], - "xyz": [ - 9.606789426213632, - 15.047191294834304, - 9.584400538803036 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5476846061870843, - 0.15058093180839377, - 0.7500434702802281 - ], - "xyz": [ - 12.313174712963262, - 17.74230467040733, - 9.546560747677335 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5513139374119407, - 0.14943802709125664, - 0.9513896483116981 - ], - "xyz": [ - 15.050317829127623, - 20.544692937368158, - 9.580554723334101 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5510937840943546, - 0.34852926225311287, - 0.1485870098802251 - ], - "xyz": [ - 6.796484191678012, - 9.565909872677537, - 12.299484357514231 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5490768871975623, - 0.3508272020163073, - 0.3519213044116055 - ], - "xyz": [ - 9.607851085151266, - 12.31828509600605, - 12.303326724995966 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508237390224056, - 0.35124796301653355, - 0.5504094760395463 - ], - "xyz": [ - 12.327298208435693, - 15.055862294348293, - 12.332961937370007 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5481557799046105, - 0.34984873085620505, - 0.7522517091696959 - ], - "xyz": [ - 15.06771883795491, - 17.77893711727588, - 12.277356030309932 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5515064424251831, - 0.3510182848766515, - 0.9477211531699147 - ], - "xyz": [ - 17.7561318238738, - 20.497169826008967, - 12.339155617219767 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.549637115425117, - 0.5477875404888001, - 0.15161707458366397 - ], - "xyz": [ - 9.562134004440015, - 9.58742106004585, - 15.003792359217007 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5492908798649228, - 0.5482583023249893, - 0.3502203574572183 - ], - "xyz": [ - 12.28383851038358, - 12.297955724645593, - 15.005494860047682 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5521146065318223, - 0.5505576866118934, - 0.5483423549932304 - ], - "xyz": [ - 15.023963566817763, - 15.045249495717444, - 15.075537110848114 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497282087534804, - 0.551393165481233, - 0.7511592478123521 - ], - "xyz": [ - 17.8082621351155, - 17.785499146425877, - 15.054333226689637 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5482526642657547, - 0.5521013464360897, - 0.9491059269567926 - ], - "xyz": [ - 20.524235624518273, - 20.471617134648245, - 15.043841970593688 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5474699029239021, - 0.7509716436619829, - 0.15077827553635784 - ], - "xyz": [ - 12.328562580294257, - 9.54632341123655, - 17.75205910544383 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5489311451796057, - 0.7523958137571353, - 0.3499678242445637 - ], - "xyz": [ - 15.071317233304386, - 12.289584908152747, - 17.79150794373051 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.550419360150109, - 0.7475079027819115, - 0.551148934060227 - ], - "xyz": [ - 17.755002515075084, - 15.060443436150754, - 17.745027911899253 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500124511562655, - 0.7477164814251781, - 0.7517545600532743 - ], - "xyz": [ - 20.500498174305935, - 17.79752425919481, - 17.74231637504563 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5525180705959521, - 0.7489216367197262, - 0.9491802777186227 - ], - "xyz": [ - 23.216143715856507, - 20.530949512454168, - 17.793049419272638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5501114328163943, - 0.9516997636855089, - 0.1505118012531383 - ], - "xyz": [ - 15.069238117759493, - 9.578794744016516, - 20.53249235255865 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5504925139053457, - 0.9480861781093903, - 0.34936074092480845 - ], - "xyz": [ - 17.738460736590138, - 12.302631726451997, - 20.488298133060905 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5511825005815444, - 0.9482019100522132, - 0.551675084471752 - ], - "xyz": [ - 20.506048291272634, - 15.078070388483356, - 20.499313772990817 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5513785527651206, - 0.9509898317875612, - 0.7476168340869167 - ], - "xyz": [ - 23.223044586636, - 17.759631109871417, - 20.540110127295044 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5491421814666737, - 0.9491207899962553, - 0.9492038257067194 - ], - "xyz": [ - 25.95355244746024, - 20.485116907793337, - 20.4839816585063 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.751158460052416, - 0.14749422915107765, - 0.15054849046657934 - ], - "xyz": [ - 4.074786414923075, - 12.32797512024461, - 12.286217809306107 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7475164917757473, - 0.15101766584171625, - 0.350357375494157 - ], - "xyz": [ - 6.854709317636618, - 15.009933896018023, - 12.28459726679759 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7524518098086957, - 0.14939715529980552, - 0.5495632386237763 - ], - "xyz": [ - 9.556060692852304, - 17.800915379460037, - 12.329916718149708 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7507864434839924, - 0.14879402842974815, - 0.7519984800997522 - ], - "xyz": [ - 12.315473033963793, - 20.54580497395071, - 12.298902287519715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499929236238783, - 0.15233732813078196, - 0.9483980197615294 - ], - "xyz": [ - 15.049055544021058, - 23.220095267595482, - 12.336496782544398 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503760274749206, - 0.3483523756357544, - 0.1490712967796326 - ], - "xyz": [ - 6.800686913002135, - 12.297081916689883, - 15.021616956216587 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.750209747911165, - 0.3477411637247939, - 0.3502139407384257 - ], - "xyz": [ - 9.542316556302335, - 15.044794594953247, - 15.010987232722735 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7521767480032204, - 0.3481503572135216, - 0.5494199358472032 - ], - "xyz": [ - 12.271419484073476, - 17.795195574199898, - 15.043474123644357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7511725281342189, - 0.35118817802593116, - 0.7500416978430995 - ], - "xyz": [ - 15.055816641503728, - 20.52433067900122, - 15.071277149694462 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7475828061206498, - 0.35015188707009204, - 0.951385803112628 - ], - "xyz": [ - 17.794389023393915, - 23.227993011087708, - 15.008031133059045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7501529832359419, - 0.5523314691118173, - 0.148672717586475 - ], - "xyz": [ - 9.584003059785445, - 12.288583193017935, - 17.80733298529714 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7477438064853329, - 0.5517701858576187, - 0.34991300073437853 - ], - "xyz": [ - 12.3276502241122, - 15.006966290082595, - 17.76672139079421 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7507373851968833, - 0.5505767000149187, - 0.5474963194837256 - ], - "xyz": [ - 15.012656669441952, - 17.74921752832644, - 17.791331936480415 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7504323096690834, - 0.5476991291404202, - 0.751750740676338 - ], - "xyz": [ - 17.76584471915815, - 20.537576271373535, - 17.747819367744544 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7516738950995081, - 0.548840579347166, - 0.9482796582145638 - ], - "xyz": [ - 20.468358406301206, - 23.24145898927039, - 17.780399802029525 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7513103053481113, - 0.7510817472554775, - 0.1476182591683554 - ], - "xyz": [ - 12.286864721825486, - 12.289989526927517, - 20.540433712626793 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7490116616649739, - 0.7482997994816606, - 0.35207852343644874 - ], - "xyz": [ - 15.044174362838264, - 15.053906814473331, - 20.470972780733778 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7517035023849548, - 0.7511262570310258, - 0.5481459571673399 - ], - "xyz": [ - 17.7634158435215, - 17.771307838096252, - 20.546417961378587 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503145514253795, - 0.7486366975771277, - 0.7522639727982671 - ], - "xyz": [ - 20.520043803251728, - 20.542983119051335, - 20.493391665137455 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7494725236513539, - 0.7516099747936223, - 0.9510562052174913 - ], - "xyz": [ - 23.27854553319954, - 23.24932268592365, - 20.522529723889992 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7508840380779801, - 0.9519360820672432, - 0.1484265431088464 - ], - "xyz": [ - 15.043959746134965, - 12.295212390081677, - 23.280650175003863 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7475161528909215, - 0.9507319602423654, - 0.3512759789925407 - ], - "xyz": [ - 17.80081818379057, - 15.022488244526956, - 23.218142518097935 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7496499618462895, - 0.9491452279012337, - 0.5524706833482478 - ], - "xyz": [ - 20.529822447738884, - 17.802359079383578, - 23.22562205109398 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7475148883768903, - 0.9507794683354932, - 0.750451627941129 - ], - "xyz": [ - 23.258925326696644, - 20.47992857712702, - 23.218774751987496 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7514865694175409, - 0.9480900005050037, - 0.9490688590258185 - ], - "xyz": [ - 25.937614438910682, - 23.249687717700485, - 23.23630494019844 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9502585402504504, - 0.1501819825450283, - 0.1518245958194424 - ], - "xyz": [ - 4.128979578214937, - 15.06748226138308, - 15.04502474836568 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9506807880311713, - 0.15198746405688843, - 0.34920744695578676 - ], - "xyz": [ - 6.852246608281312, - 17.77183796885939, - 15.075481862262574 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.950492407693655, - 0.15181687416717105, - 0.5477613884705134 - ], - "xyz": [ - 9.564508082695145, - 20.483856215473196, - 15.070574085930476 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9521552759068632, - 0.14995973333975507, - 0.74985802944392 - ], - "xyz": [ - 12.302146485581103, - 23.269619548360943, - 15.067918025718098 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9516167113757316, - 0.1478360833688624, - 0.9510198818305089 - ], - "xyz": [ - 15.023360962132067, - 26.01250502772894, - 15.031520708245033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9509302244578823, - 0.34800662862757686, - 0.14927541158466034 - ], - "xyz": [ - 6.798750543014468, - 15.041813418959155, - 17.75883084675084 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9517449536833121, - 0.3478251800281499, - 0.3508034801567972 - ], - "xyz": [ - 9.551525288889762, - 17.80820772874388, - 17.767488945479037 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9486328221004782, - 0.3509083650176468, - 0.5519265092526839 - ], - "xyz": [ - 12.343395890746592, - 20.515377077580787, - 17.76709319286532 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.952443413266393, - 0.34858462572680604, - 0.7493158509315855 - ], - "xyz": [ - 15.01029769478773, - 23.266146343447204, - 17.787421164067997 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499589415852969, - 0.3476561193955655, - 0.9515244663529434 - ], - "xyz": [ - 17.76216311584818, - 25.99673888631819, - 17.740759543019372 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9498662244855809, - 0.5503146143419828, - 0.15196221834512394 - ], - "xyz": [ - 9.601402446668239, - 15.064000141261685, - 20.51020239589946 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494934491507093, - 0.5508829388807939, - 0.3517422028536154 - ], - "xyz": [ - 12.34052846526733, - 17.790259611785764, - 20.512875909416863 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.947637046203092, - 0.550644969922441, - 0.5515954027628414 - ], - "xyz": [ - 15.069631972086096, - 20.497236180421424, - 20.48424203370538 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9480471155744672, - 0.5501340527548876, - 0.7496696434957105 - ], - "xyz": [ - 17.77068217047285, - 23.210877940990834, - 20.482863260788637 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.95080249839945, - 0.5474668377860293, - 0.9508392565459819 - ], - "xyz": [ - 20.484571226610274, - 25.99890377809805, - 20.484068675847357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9518353126421938, - 0.7479065069105794, - 0.15075176934245138 - ], - "xyz": [ - 12.286294194441709, - 15.074372119219309, - 23.238564203397992 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9489735995040243, - 0.7482890623025559, - 0.3507234726241017 - ], - "xyz": [ - 15.025501555260973, - 17.769224424662752, - 23.204669604940435 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499367193061787, - 0.7490370676593248, - 0.5523975259526146 - ], - "xyz": [ - 17.792979505635582, - 20.539643381014073, - 23.228063800110707 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9494852851872091, - 0.7494061264396173, - 0.7486401662236501 - ], - "xyz": [ - 20.481019264959514, - 23.216465509108012, - 23.226937579307876 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9520275041493471, - 0.7504032630040464, - 0.9479684778478376 - ], - "xyz": [ - 23.2198327340136, - 25.976403066588745, - 23.275327010983105 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9476693089409884, - 0.9515731420813184, - 0.14995096851389283 - ], - "xyz": [ - 15.059839365717819, - 15.006466861713193, - 25.96610092673579 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9484262985496065, - 0.9510628832919098, - 0.3487024847074397 - ], - "xyz": [ - 17.770158153520864, - 17.734111241509346, - 25.969474186084476 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9492565763913525, - 0.9519050414428478, - 0.5507799506859448 - ], - "xyz": [ - 20.544438729086266, - 20.50822939162593, - 25.992339429937974 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9480746534421983, - 0.9512512216139488, - 0.7491001033301251 - ], - "xyz": [ - 23.246897251396884, - 23.203467783134982, - 25.96724148511013 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.949539756618862, - 0.9514320093515538, - 0.9512207560581075 - ], - "xyz": [ - 26.012726131183115, - 25.986855592427244, - 25.989743809429648 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1030347040890365, - 0.09919137455707751, - 0.09816800852176609 - ], - "xyz": [ - 2.698261960764995, - 2.750807270326623, - 2.764798546555514 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09848215362714016, - 0.09839868947809258, - 0.30290905586862926 - ], - "xyz": [ - 5.4866072589862185, - 5.48774836580845, - 2.6917194483829827 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10030328930701554, - 0.10274799941627583, - 0.49774082484311755 - ], - "xyz": [ - 8.209775117286059, - 8.176351480720072, - 2.776080670192869 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09935750441881606, - 0.10192254593827944, - 0.7014150360823617 - ], - "xyz": [ - 10.98308682062144, - 10.94801803467481, - 2.7518646180731454 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09950890967137965, - 0.10298555667895595, - 0.8994973814589097 - ], - "xyz": [ - 13.705766283292032, - 13.658234191200911, - 2.768467894937845 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09992717203186952, - 0.3025854936210187, - 0.1000718192673114 - ], - "xyz": [ - 5.5050583034929295, - 2.734350209223967, - 5.50308071252647 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10108355740340445, - 0.29974491960774574, - 0.30201397603963903 - ], - "xyz": [ - 8.227139304689826, - 5.51107691967727, - 5.480054788570583 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09775972631367462, - 0.2986675412017076, - 0.5014714693186535 - ], - "xyz": [ - 10.939356526812482, - 8.192581045069975, - 5.419882244562152 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10240271246550711, - 0.29980469066124005, - 0.7004974408842978 - ], - "xyz": [ - 13.675950688106912, - 10.977106374570928, - 5.498907218216324 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10137038501911098, - 0.29777136717355646, - 0.8986738821166091 - ], - "xyz": [ - 16.35758408815027, - 13.67242521231148, - 5.456994190462754 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10058334571173402, - 0.5022186144070876, - 0.09715216660892476 - ], - "xyz": [ - 8.194489431310338, - 2.703404332055829, - 8.241399894391707 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09979851718729571, - 0.4975607334810577, - 0.3027163342813964 - ], - "xyz": [ - 10.941244020576073, - 5.503110596606693, - 8.166988150472607 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10297178490296895, - 0.5000308794226049, - 0.4986297134645245 - ], - "xyz": [ - 13.653507867046113, - 8.224987397410663, - 8.244143886179666 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09742422944329224, - 0.4994181763910033, - 0.7007372246389323 - ], - "xyz": [ - 16.408308614909092, - 10.912319731150438, - 8.159921940933437 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10296144547867823, - 0.4980570681106524, - 0.8998850608891332 - ], - "xyz": [ - 19.112413158101848, - 13.71073692268957, - 8.217016934460881 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09776000388014272, - 0.7028576406399447, - 0.09967764137171964 - ], - "xyz": [ - 10.97211791931271, - 2.6993319471073165, - 10.94590032470262 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09836608822574738, - 0.700367868269088, - 0.2984230021079596 - ], - "xyz": [ - 13.655288997438324, - 5.424829021006181, - 10.92014688108522 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09757561350630758, - 0.7013337269272157, - 0.4989447744179022 - ], - "xyz": [ - 16.409991620260207, - 8.15551937002997, - 10.922544698725853 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09816157979135974, - 0.7019131699708325, - 0.6981832994709603 - ], - "xyz": [ - 19.14186691284369, - 10.88748384719617, - 10.938477965293734 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09815723496758653, - 0.6981981367360801, - 0.9020352103569151 - ], - "xyz": [ - 21.878102279452953, - 13.674451077836427, - 10.887627297965622 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1014154652914301, - 0.8999403326055565, - 0.0970364277011319 - ], - "xyz": [ - 13.630486811096187, - 2.7131985596535686, - 13.690356224803978 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10274019933897281, - 0.8978815632433312, - 0.30045887205358773 - ], - "xyz": [ - 16.38349473010112, - 5.5124651282462365, - 13.680320626107994 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09864665972148302, - 0.8981899501861832, - 0.5003043006648045 - ], - "xyz": [ - 19.11996166866955, - 8.188749719228452, - 13.628570700067828 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09853026897037333, - 0.902487540482367, - 0.6979896182516179 - ], - "xyz": [ - 21.881435628322468, - 10.889876524519362, - 13.685735307632163 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10063061640572385, - 0.9026694724873661, - 0.8978995403427629 - ], - "xyz": [ - 24.617055440991212, - 13.651724567637094, - 13.716938221330324 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3018657821252262, - 0.09757820081520548, - 0.09888625248585706 - ], - "xyz": [ - 2.6860266419305328, - 5.4790096818365, - 5.461126234844651 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30018985696690986, - 0.10032698443236568, - 0.3023007075195288 - ], - "xyz": [ - 5.50465333138175, - 8.237142549356982, - 5.475794162579443 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2994679498381023, - 0.10275837184183638, - 0.4976611037107446 - ], - "xyz": [ - 8.208826994249288, - 10.898204936890195, - 5.499165869270219 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2989114916344944, - 0.09872116434488962, - 0.6992148688793888 - ], - "xyz": [ - 10.909237817756352, - 13.646203938200916, - 5.4363620986720615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3019400830714324, - 0.09719377401637987, - 0.8996081856701221 - ], - "xyz": [ - 13.62809696848111, - 16.427351651546157, - 5.456886250010292 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30005463430276114, - 0.29736503067985975, - 0.10253509498872417 - ], - "xyz": [ - 5.467362536118259, - 5.504134312721914, - 8.167814124102694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30261751875035053, - 0.2974762002517561, - 0.299679790646363 - ], - "xyz": [ - 8.164209219480723, - 8.234500400556175, - 8.20437330932738 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2971954194309925, - 0.3009893735515001, - 0.49970702426595065 - ], - "xyz": [ - 10.946977025608577, - 10.895106767784739, - 8.1782748163939 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30194710387249324, - 0.2979118085421364, - 0.7016850238295423 - ], - "xyz": [ - 13.666307964755763, - 13.721477796159244, - 8.201163075928582 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29902613890909907, - 0.30292146318396046, - 0.8980274817835183 - ], - "xyz": [ - 16.419157804785275, - 16.36590163245774, - 8.229719265247931 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3016208916420294, - 0.5017782978576736, - 0.09734963612099229 - ], - "xyz": [ - 8.191169270328203, - 5.454653240881035, - 10.983929106985828 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3003759103681959, - 0.5004001968199029, - 0.2970848765410796 - ], - "xyz": [ - 10.903072375678146, - 8.16837633568197, - 10.948066797776391 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3027476204397969, - 0.49782443868344095, - 0.5003953992841268 - ], - "xyz": [ - 13.64748194512175, - 10.980426799921934, - 10.945277089362264 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29930872010144605, - 0.49792585103061576, - 0.7029272275012514 - ], - "xyz": [ - 16.41784713613355, - 13.70238947315351, - 10.899647554294745 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29696248434602457, - 0.5011058304009404, - 0.9016937627131275 - ], - "xyz": [ - 19.178823533128774, - 16.387812451668257, - 10.911046346923849 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2987055159920293, - 0.6988955183616828, - 0.09924990403980911 - ], - "xyz": [ - 10.912100548897165, - 5.440774870699689, - 13.639021773497767 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30222121052725265, - 0.6972676265369394, - 0.3009053955819699 - ], - "xyz": [ - 13.646841887265746, - 8.24583839593619, - 13.664831472350961 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2992923102742999, - 0.6976109071092129, - 0.500459543152713 - ], - "xyz": [ - 16.379803543300003, - 10.934063384720503, - 13.629481345488257 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29928183367876654, - 0.7030931723865785, - 0.6992977784855762 - ], - "xyz": [ - 19.17323664995294, - 13.652400713180702, - 13.704290655424305 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2986871495939717, - 0.6978145517256473, - 0.9023639640724916 - ], - "xyz": [ - 21.87735263585931, - 16.420554636847424, - 13.623991890135592 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3004825900224281, - 0.8982636518086279, - 0.09846573950746171 - ], - "xyz": [ - 13.627104826783139, - 5.454349750633338, - 16.389042843990666 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3023637344414196, - 0.8982226113234563, - 0.30119956785059526 - ], - "xyz": [ - 16.39828413767538, - 8.251808827542014, - 16.414200413755143 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2989583732501227, - 0.8986085359227212, - 0.5031392619080401 - ], - "xyz": [ - 19.164443577338556, - 10.966134490308072, - 16.372919220167468 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29863186960824756, - 0.897877695573263, - 0.702418744330577 - ], - "xyz": [ - 21.878964873006115, - 13.686183804661098, - 16.358463403439877 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29805143823065655, - 0.8993779421835274, - 0.8995696597610406 - ], - "xyz": [ - 24.59488780321778, - 16.373660079944845, - 16.371038951734246 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5001300861854068, - 0.09700460727832189, - 0.10180716010455518 - ], - "xyz": [ - 2.718118697540566, - 8.229577682572026, - 8.163918044791274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49854782690196037, - 0.09833554503619273, - 0.3002094442788705 - ], - "xyz": [ - 5.448835355817467, - 10.920465635275505, - 8.160482022131479 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5021882360368695, - 0.0994083331958835, - 0.5010674375319527 - ], - "xyz": [ - 8.209596651752245, - 13.716330983011693, - 8.224920007167736 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49882474603792665, - 0.10316459449679505, - 0.6990149057732594 - ], - "xyz": [ - 10.967253735382135, - 16.376648108425208, - 8.230289905709418 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4981376472474085, - 0.09935979522189556, - 0.8994672966386226 - ], - "xyz": [ - 13.655784211040467, - 19.107803223919916, - 8.16887748390068 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5015310381368634, - 0.30095960472136285, - 0.09688275021144606 - ], - "xyz": [ - 5.439229065017475, - 8.181405599816184, - 10.971507620841953 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5011797004810843, - 0.3013281523198314, - 0.30062682568871985 - ], - "xyz": [ - 8.22982010743687, - 10.96215450061885, - 10.971742912080614 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4979208566523521, - 0.30288051803374133, - 0.49913375944268384 - ], - "xyz": [ - 10.964994839087739, - 13.631551241420434, - 10.948412250460825 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5022245210305427, - 0.2971510352455332, - 0.7000726988803195 - ], - "xyz": [ - 13.633863392696515, - 16.43759117712172, - 10.92891871780638 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5026225432467621, - 0.2981520393572788, - 0.8984332764693753 - ], - "xyz": [ - 16.359499052625164, - 19.15498297711148, - 10.948045953937578 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5017376879596613, - 0.5008937013411908, - 0.09693867722072631 - ], - "xyz": [ - 8.173456669870388, - 8.184995503000527, - 13.707795880871176 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5020121260906376, - 0.5016306081637456, - 0.29830612929401246 - ], - "xyz": [ - 10.936591085909726, - 10.941807130332965, - 13.721622807033759 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5009827127752253, - 0.5011782620549151, - 0.501003483495268 - ], - "xyz": [ - 13.701648432447904, - 13.698974917894855, - 13.70136445890221 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49938620352169727, - 0.4988426247244388, - 0.6986394766686493 - ], - "xyz": [ - 16.371759743468047, - 16.379191454939985, - 13.647604858592087 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49841048603648724, - 0.5031030517869949, - 0.8990509837441457 - ], - "xyz": [ - 19.169997586055356, - 19.10584167177625, - 13.692512816685838 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5005152195062953, - 0.7027569900792887, - 0.0980857960664247 - ], - "xyz": [ - 10.948978420482687, - 8.183965336727423, - 16.450921060456377 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5014267034593091, - 0.6981468245545641, - 0.2982366075103536 - ], - "xyz": [ - 13.62237493417378, - 10.932852848181252, - 16.40035335177063 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4997781522801343, - 0.6971848206941876, - 0.5008905867754204 - ], - "xyz": [ - 16.379871317351135, - 13.680962879994512, - 16.36466231316979 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5001878273342399, - 0.7028920458241058, - 0.6988012261350883 - ], - "xyz": [ - 19.16369810943715, - 16.39236252100303, - 16.44829147144373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4984165315080803, - 0.6993231534713796, - 0.899148391151322 - ], - "xyz": [ - 21.85401523320354, - 19.10725606091327, - 16.375281379895878 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5023751698214147, - 0.8974002456084221, - 0.09942329743912807 - ], - "xyz": [ - 13.628392052308357, - 8.227680320662033, - 19.13747752018195 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49796085643062094, - 0.9008573765657268, - 0.29861815521469365 - ], - "xyz": [ - 16.399013564906188, - 10.890684862992643, - 19.124391094244125 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5010387059297349, - 0.9016135047890392, - 0.5004310774606492 - ], - "xyz": [ - 19.168501160492934, - 13.691914613952319, - 19.176808547549147 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49752208515425006, - 0.8989713695923623, - 0.701633420255352 - ], - "xyz": [ - 21.883180577935775, - 16.394638221969103, - 19.092607144473828 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49992845414130505, - 0.897320824276073, - 0.9024727361840181 - ], - "xyz": [ - 24.60645359576948, - 19.17337664191356, - 19.102940629652274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6975902315611598, - 0.1027309702485078, - 0.09966905567904166 - ], - "xyz": [ - 2.767176722476789, - 10.89998546847633, - 10.94184741332545 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6969857671799474, - 0.10183577354817042, - 0.3002540025891667 - ], - "xyz": [ - 5.497299043189967, - 13.634082629124768, - 10.921344316957494 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7008248286576274, - 0.09949945988461055, - 0.5023269657341134 - ], - "xyz": [ - 8.228062562302581, - 16.449274765600887, - 10.941889614577539 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7010002512865785, - 0.10244904104774535, - 0.6978129211385407 - ], - "xyz": [ - 10.941037499857707, - 19.12432190702519, - 10.984614103922254 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7009484679798607, - 0.10153811757324623, - 0.9006299197651457 - ], - "xyz": [ - 13.701461016243773, - 21.89649143313993, - 10.971452150096676 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7026591613441462, - 0.30049360025356114, - 0.099161883509054 - ], - "xyz": [ - 5.464017836015396, - 10.96235299744488, - 13.714923989066767 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7009740408228349, - 0.3018962871712343, - 0.2970301129774555 - ], - "xyz": [ - 8.18841393608086, - 13.644533150009885, - 13.711062607675874 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6982895157323781, - 0.2994148257951794, - 0.503080650011196 - ], - "xyz": [ - 10.971573696039117, - 16.424916659416308, - 13.640434170583289 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6987179945437381, - 0.2978212176185765, - 0.7024359591542901 - ], - "xyz": [ - 13.675336074546811, - 19.156324647247775, - 13.624504731624974 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6974559591924933, - 0.30257437142653704, - 0.900355516253225 - ], - "xyz": [ - 16.446240896977923, - 21.844990886228278, - 13.672234674763871 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7016655472642539, - 0.49915822423028944, - 0.10177361964206287 - ], - "xyz": [ - 8.215832001690902, - 10.984475670893119, - 16.417446455594526 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7000214398004776, - 0.5027552336516465, - 0.2995935165259801 - ], - "xyz": [ - 10.969567689653479, - 13.66655575220319, - 16.444146179636217 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6968540477588702, - 0.5007041655634207, - 0.5012011987549685 - ], - "xyz": [ - 13.697869797995438, - 16.37959568039283, - 16.37280033206396 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7019347335480338, - 0.500188857916188, - 0.7008540748166628 - ], - "xyz": [ - 16.420442788595643, - 19.178676085976626, - 16.435217360252373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6990532561519832, - 0.49785659063923643, - 0.902792022966254 - ], - "xyz": [ - 19.149415728463815, - 21.900140323954297, - 16.36393598155713 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6983471500032504, - 0.6988025672140017, - 0.10302935258813271 - ], - "xyz": [ - 10.962501677789215, - 10.956275295658923, - 19.10157944684517 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6973788540518635, - 0.699647825425353, - 0.30049669788607075 - ], - "xyz": [ - 13.673795896699588, - 13.642774928496086, - 19.099897297010195 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6983076229190427, - 0.6984106205438508, - 0.5027809596829634 - ], - "xyz": [ - 16.422475070376564, - 16.421066905389758, - 19.095680415340855 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.702590672060267, - 0.697675381205851, - 0.7006492696838831 - ], - "xyz": [ - 19.11764292852728, - 19.184843900336503, - 19.144185432364775 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7017581943450862, - 0.7011275589804005, - 0.8970001424847713 - ], - "xyz": [ - 21.84931427144556, - 21.85793620463718, - 19.180001500030453 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6978402203301317, - 0.9025295811901849, - 0.10087410719185105 - ], - "xyz": [ - 13.718354614895285, - 10.919878517301592, - 21.87996785982149 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7026593440204668, - 0.8989778117225468, - 0.29778183602360897 - ], - "xyz": [ - 16.361882487248845, - 13.677851734150195, - 21.897294898630445 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6989715884894201, - 0.8989660190304325, - 0.49889562567983003 - ], - "xyz": [ - 19.11131279138266, - 16.377024936023435, - 21.846715341242067 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7003829544500614, - 0.897230270845998, - 0.7000296861347052 - ], - "xyz": [ - 21.837450625047914, - 19.146189547799622, - 21.842280445867168 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6994883143273015, - 0.8997706206141172, - 0.8978421164592653 - ], - "xyz": [ - 24.576637770974607, - 21.838414130236398, - 21.864780291910787 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9031040209462046, - 0.09909179742981657, - 0.0983999880466284 - ], - "xyz": [ - 2.7000721425125693, - 13.692382540228392, - 13.701840833589653 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9015332512331732, - 0.09794005957434856, - 0.29844099901524074 - ], - "xyz": [ - 5.4192504844463185, - 16.405831954031267, - 13.66461920016449 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9002791767490564, - 0.10141416839000833, - 0.5013740571207559 - ], - "xyz": [ - 8.241212117302576, - 19.163150715885976, - 13.694971109939166 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8992132071632629, - 0.09793901892600584, - 0.6999317061002847 - ], - "xyz": [ - 10.908344935828937, - 21.863221408054834, - 13.632885747691784 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.89938263550703, - 0.09829101912028619, - 0.8992439142975035 - ], - "xyz": [ - 13.638118053400005, - 24.590498436148614, - 13.640014624806833 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8979437483807462, - 0.29843626228483316, - 0.10208311893653275 - ], - "xyz": [ - 5.475828886569894, - 13.67218732512572, - 16.35669215741788 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.900539737574017, - 0.3023314297496355, - 0.29989221889515877 - ], - "xyz": [ - 8.233493324014871, - 16.412089631094403, - 16.445438082838855 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9007530203409275, - 0.3023002826853168, - 0.4972785406077795 - ], - "xyz": [ - 10.931697747875019, - 19.113635855609747, - 16.447928209380265 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9027484941250211, - 0.299695427998088, - 0.6999488164056937 - ], - "xyz": [ - 13.666956173524511, - 21.911789144060037, - 16.439596863361164 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8983539832770155, - 0.30218002235136393, - 0.9014315777662963 - ], - "xyz": [ - 16.45556114672063, - 24.60634422918317, - 16.41348482883019 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9024189190169676, - 0.4999607870197601, - 0.09727871069368935 - ], - "xyz": [ - 8.165350909628692, - 13.667686047830752, - 19.173082912587052 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9020074011966916, - 0.499054695288066, - 0.30145484153966046 - ], - "xyz": [ - 10.944422295792046, - 16.453519159487712, - 19.155068791962236 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9019566647235815, - 0.5016895476421596, - 0.4983256572257511 - ], - "xyz": [ - 13.672027878217197, - 19.14440785487332, - 19.190398359146183 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.899256802730219, - 0.4988470782157882, - 0.7031498311922003 - ], - "xyz": [ - 16.433485385982323, - 21.90781506579321, - 19.11462460159524 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9026339382990841, - 0.4985877051958485, - 0.9007486611497406 - ], - "xyz": [ - 19.131474920130948, - 24.655522290796426, - 19.157250089966887 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8999163832129508, - 0.6992547860392299, - 0.09791751873322785 - ], - "xyz": [ - 10.898796259834182, - 13.642205497305802, - 21.863580375205345 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8990098615504792, - 0.7005288273342755, - 0.3026809989025384 - ], - "xyz": [ - 13.715704166540997, - 16.429301139758774, - 21.868605037468363 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9015588036558024, - 0.6970580947445073, - 0.5015081416092454 - ], - "xyz": [ - 16.38658184150596, - 19.182478723613585, - 21.85600248388732 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8997976829687505, - 0.6976965971942012, - 0.6996893880017026 - ], - "xyz": [ - 19.10480966012106, - 21.867899326635257, - 21.840654249417444 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8994453306404215, - 0.7003178254346333, - 0.8975749909274907 - ], - "xyz": [ - 21.846102964596014, - 24.56853837281861, - 21.871673912490053 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9028954818182132, - 0.9001290727252365, - 0.09893513845554257 - ], - "xyz": [ - 13.659026063705598, - 13.696847910871139, - 24.65062716529822 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8996338232443406, - 0.9025866789275557, - 0.3003188208592009 - ], - "xyz": [ - 16.445907470094575, - 16.40553655870768, - 24.639634306003774 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9024992845099926, - 0.8976306301072491, - 0.49906727952302127 - ], - "xyz": [ - 19.09540241484132, - 19.16196578147784, - 24.611052169262294 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8970672492186458, - 0.9018838855496429, - 0.6999436183424721 - ], - "xyz": [ - 21.899897304262296, - 21.83404511933944, - 24.59493610334778 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8970474786044585, - 0.9001886632846473, - 0.9020153204164886 - ], - "xyz": [ - 24.63940846844486, - 24.59646275691056, - 24.57148902940231 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1488487268706593, - 0.14760238998787728, - 0.15181658491368902 - ], - "xyz": [ - 4.093602329438732, - 4.110642022959489, - 4.053026308488877 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15241632365817606, - 0.14729355388404294, - 0.3498541614460866 - ], - "xyz": [ - 6.796914077404772, - 6.86695166365816, - 4.09757949797926 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1501874501604139, - 0.14884544361561225, - 0.5480815730688172 - ], - "xyz": [ - 9.528260725246515, - 9.546608397165866, - 4.088323897784949 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14718252857876585, - 0.14991234443417545, - 0.7506750381325263 - ], - "xyz": [ - 12.312668588723083, - 12.275347037714777, - 4.0618276267557905 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15266686390836237, - 0.14886672770289724, - 0.9478543676074251 - ], - "xyz": [ - 14.99417340528557, - 15.046128183462173, - 4.122512988462651 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14943945656481047, - 0.34875101718094065, - 0.14868401529928385 - ], - "xyz": [ - 6.800842225763782, - 4.075890445100962, - 6.811170482766634 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14741268423026418, - 0.35069996230130923, - 0.34945881987003474 - ], - "xyz": [ - 9.572444841265824, - 6.793137767188548, - 6.810106443103296 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15158002058963504, - 0.35030533329239777, - 0.5469350803332569 - ], - "xyz": [ - 12.266909431815495, - 9.549972727099611, - 6.861686218911453 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14858973799166555, - 0.35031727075027697, - 0.7482347877235035 - ], - "xyz": [ - 15.019206004083, - 12.26122348716316, - 6.820966820258264 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15168877648947085, - 0.3513549977291108, - 0.9470542912967184 - ], - "xyz": [ - 17.75161808588911, - 15.021817449020576, - 6.877523933237088 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1485300681251677, - 0.5492821080608334, - 0.1490560887530374 - ], - "xyz": [ - 9.547554125963815, - 4.0685443713305816, - 9.540362466623293 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14898456864169307, - 0.5531664939300444, - 0.34888274497411714 - ], - "xyz": [ - 12.332654825434691, - 6.806752295638906, - 9.59968294028953 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1487781420449678, - 0.5489090097086434, - 0.5531585444122437 - ], - "xyz": [ - 15.067269227781026, - 9.596752028639433, - 9.538653155088056 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15296107653944227, - 0.5496418285604184, - 0.7494371213986896 - ], - "xyz": [ - 17.76077356962993, - 12.337425730534507, - 9.605860450002377 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14975866450159314, - 0.5482617083413863, - 0.9530313128968503 - ], - "xyz": [ - 20.525407953625347, - 15.077146068795585, - 9.543208893842102 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15018181365550085, - 0.7512487881019899, - 0.1516040700342288 - ], - "xyz": [ - 12.343641762923916, - 4.125962280346919, - 12.324196929720095 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1497040497537678, - 0.7486414357193867, - 0.35307145075715174 - ], - "xyz": [ - 15.062420275587666, - 6.873856143395199, - 12.282017775201581 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1504831479867972, - 0.7468909933795858, - 0.5511948603488943 - ], - "xyz": [ - 17.747196136722106, - 9.593215427924074, - 12.26873773341574 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14944648254388618, - 0.7487083101353681, - 0.7531245984580831 - ], - "xyz": [ - 20.532789196366117, - 12.339789356664342, - 12.27941065764808 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1491102332493104, - 0.7504062469551016, - 0.9527217986406007 - ], - "xyz": [ - 23.284860076336233, - 15.064049210233122, - 12.298027404388282 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14776761953207637, - 0.9522846859491666, - 0.15123283914092425 - ], - "xyz": [ - 15.087092969877204, - 4.087880450894703, - 15.039717111124565 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15192599067538676, - 0.9500233743865414, - 0.34705493641817153 - ], - "xyz": [ - 17.73342119122609, - 6.821977418656251, - 15.06565336824097 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15103319360987894, - 0.948212389026403, - 0.5524780640647219 - ], - "xyz": [ - 20.5171697503803, - 9.61827928290076, - 15.028687741598372 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15115753468449025, - 0.9480032738911094, - 0.752381212222129 - ], - "xyz": [ - 23.247350624932693, - 12.353019110732854, - 15.027528725900053 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1518905347550073, - 0.9508484868065368, - 0.9469980630479867 - ], - "xyz": [ - 25.947016417232067, - 15.023807109214928, - 15.076449409765548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.352308927118902, - 0.1505707580468938, - 0.1472238193289638 - ], - "xyz": [ - 4.071393858858797, - 6.829521793540859, - 6.875280537243429 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3513265856931812, - 0.1500735869623363, - 0.3469945595658015 - ], - "xyz": [ - 6.795826227066324, - 9.547321000174664, - 6.855052908515157 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3486586038292034, - 0.15304562849827522, - 0.5484969610537359 - ], - "xyz": [ - 9.591364006688975, - 12.265749395077865, - 6.859209957619468 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34761662470420684, - 0.14887713609241698, - 0.7513745409071153 - ], - "xyz": [ - 12.308078882635744, - 15.025209397828185, - 6.7879733287344965 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.352817568128099, - 0.15042046413118076, - 0.9482890741619243 - ], - "xyz": [ - 15.021359039826438, - 17.788495814193585, - 6.880179794203065 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3515567069995021, - 0.3507778486092323, - 0.14688062826848108 - ], - "xyz": [ - 6.803897117346258, - 6.814545529063517, - 9.602191624062606 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34957172736081377, - 0.34846829366082777, - 0.353092393442786 - ], - "xyz": [ - 9.591611433156928, - 9.60669738008507, - 9.543477520204098 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3498581895802759, - 0.3529265004147818, - 0.5479319933156714 - ], - "xyz": [ - 12.316375171753885, - 12.27442577832047, - 9.608345780368229 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3485508418789297, - 0.34901239229576614, - 0.7531328618765161 - ], - "xyz": [ - 15.06833152889769, - 15.062021294677777, - 9.536958976254288 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35295526676279043, - 0.34799313453790565, - 0.9498121194077898 - ], - "xyz": [ - 17.743359826999836, - 17.81120120559466, - 9.58324037187088 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35039409116919573, - 0.5497997118675585, - 0.1473378890853939 - ], - "xyz": [ - 9.531139795460593, - 6.804902042284303, - 12.307287640233955 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3504733983834476, - 0.5493717649291174, - 0.35260170328737395 - ], - "xyz": [ - 12.33161890223159, - 9.61231623652517, - 12.302521100679991 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34809568954031833, - 0.5519470073451959, - 0.5482528685398783 - ], - "xyz": [ - 15.041734667123073, - 12.254716143331994, - 12.30522174413331 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3483345690204427, - 0.5481878480961121, - 0.7525358031295656 - ], - "xyz": [ - 17.783259629300243, - 15.050901571367925, - 12.257093112782455 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.352948964995445, - 0.5479560576342394, - 0.9493339780669968 - ], - "xyz": [ - 20.470679855900872, - 17.80457798661995, - 12.31701130648897 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34695254139966775, - 0.7502081523099388, - 0.15133706962093335 - ], - "xyz": [ - 12.325763996098935, - 6.8125258697436735, - 15.000183515472871 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3479569376189377, - 0.748471089353299, - 0.35227773552156816 - ], - "xyz": [ - 15.049239798900704, - 9.57348240893583, - 14.990166627719564 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34742406189081393, - 0.7498282468482421, - 0.5525852377154171 - ], - "xyz": [ - 17.806362726527126, - 12.304765142542461, - 15.0014360596648 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35012255579112617, - 0.7512456335218354, - 0.7516474507212098 - ], - "xyz": [ - 20.547283727015746, - 15.063201210435482, - 15.057707638012731 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35195054009264615, - 0.7471123185054528, - 0.9498391370600421 - ], - "xyz": [ - 23.200414849229443, - 17.797834143889663, - 15.02618957143866 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3513924102339148, - 0.9516311416301886, - 0.1499381273875634 - ], - "xyz": [ - 15.06045676354228, - 6.854100870864078, - 17.814703456846683 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3501802368436967, - 0.947812703638165, - 0.35281238393204284 - ], - "xyz": [ - 17.781912084744118, - 9.611188572574171, - 17.745925843538725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3479026664538259, - 0.9514408923460942, - 0.5521563843243333 - ], - "xyz": [ - 20.556911319128282, - 12.305445331609851, - 17.76439125407192 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35309530990319404, - 0.9489722468751057, - 0.7495140290993351 - ], - "xyz": [ - 23.221398637592877, - 15.074676413161555, - 17.80163326411269 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35294968033601554, - 0.950099997455862, - 0.9485585894990348 - ], - "xyz": [ - 25.958118442301696, - 17.793986793696238, - 17.815060645828545 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5527638253620859, - 0.149995476620513, - 0.14960248359176648 - ], - "xyz": [ - 4.096049384389446, - 9.602625750081456, - 9.607998680031734 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5520730914170602, - 0.14711678648874693, - 0.34993814327679024 - ], - "xyz": [ - 6.795645529867065, - 12.332135238712077, - 9.55919815655017 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5474301693445955, - 0.14950248730098448, - 0.5524873370737395 - ], - "xyz": [ - 9.597478520682838, - 15.03787416260032, - 9.528337833780173 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508303538091613, - 0.15253340593705342, - 0.747765974954971 - ], - "xyz": [ - 12.308731081667196, - 17.75417525952404, - 9.616262717773493 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.549174653686318, - 0.1479885083865242, - 0.952938892857813 - ], - "xyz": [ - 15.051681262880352, - 20.536626027912977, - 9.531489262490725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5476896968270257, - 0.35280074797082417, - 0.14994562242045295 - ], - "xyz": [ - 6.873457881642869, - 9.537944510394063, - 12.311343272996139 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5468879811867057, - 0.35159190388619116, - 0.3507774889608334 - ], - "xyz": [ - 9.602667912513805, - 12.272720728072526, - 12.283855262337331 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5509793842636279, - 0.3474051757874943, - 0.5522871915259234 - ], - "xyz": [ - 12.30043210128293, - 15.083662036211102, - 12.282551995798132 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5480988256110387, - 0.3512783134831934, - 0.7483199141694156 - ], - "xyz": [ - 15.03350904078549, - 17.72440365490521, - 12.296122357811303 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5483115141217105, - 0.35164403762448593, - 0.9519995922503964 - ], - "xyz": [ - 17.823181051796013, - 20.511983390320296, - 12.304030311474682 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5484405598934333, - 0.5514696458725906, - 0.15214001734601387 - ], - "xyz": [ - 9.61962466578538, - 9.578211547513819, - 15.03777434939604 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5489546121515828, - 0.5480860790462108, - 0.3529356966434138 - ], - "xyz": [ - 12.318607533308922, - 12.330481961589609, - 14.998542862731815 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5477089908737299, - 0.5511261781726239, - 0.5488246632447479 - ], - "xyz": [ - 15.03832991270685, - 14.991610743050085, - 15.02307664087132 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5527739375972247, - 0.5485881403306246, - 0.7504935026119877 - ], - "xyz": [ - 17.760810387615663, - 17.818037854401112, - 15.057624084255528 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5493560190410544, - 0.5525825559881985, - 0.9475455427968398 - ], - "xyz": [ - 20.50948134353126, - 20.465368711166555, - 15.06550584885644 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5508223925198733, - 0.7515072330405147, - 0.15079900276183097 - ], - "xyz": [ - 12.336168440767224, - 9.59244142444031, - 17.805216221329022 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497727194600374, - 0.7503644295254602, - 0.347364235288142 - ], - "xyz": [ - 15.007948714171903, - 12.265494960665253, - 17.775241076242903 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5501971467506286, - 0.7527255633635632, - 0.5494431121317195 - ], - "xyz": [ - 17.803015741009915, - 15.034083684192863, - 17.813324766593407 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5481508582547484, - 0.7505773901925804, - 0.7527350923984101 - ], - "xyz": [ - 20.553017665737155, - 17.785478557858863, - 17.755978841687156 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.548768290090389, - 0.7506607442066285, - 0.9479129200638979 - ], - "xyz": [ - 23.222593394647067, - 20.46235610261158, - 17.765559859682647 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.552764360342166, - 0.9490318445329036, - 0.15036336741956563 - ], - "xyz": [ - 15.030733446676006, - 9.613035730967397, - 20.53228738973507 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5493454833216173, - 0.9505784582093446, - 0.3475271625455481 - ], - "xyz": [ - 17.747466387949157, - 12.261881377219627, - 20.50669014230183 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5507271434492447, - 0.9510735860933188, - 0.5513437568106396 - ], - "xyz": [ - 20.540779477061193, - 15.06731497559109, - 20.532349250174608 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5525530224248105, - 0.9504785033520126, - 0.7474760609712435 - ], - "xyz": [ - 23.214129171605975, - 17.773763622955837, - 20.549176474746083 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5490693384947104, - 0.9504009387141135, - 0.9527354499569959 - ], - "xyz": [ - 26.01933814136144, - 20.532404742849806, - 20.50048772534914 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7486548308845529, - 0.15060496015896466, - 0.15270734538307443 - ], - "xyz": [ - 4.14683124515576, - 12.323261428739272, - 12.294517996384583 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7520168183701098, - 0.1485485668722762, - 0.34784104023514856 - ], - "xyz": [ - 6.786549358243431, - 15.037058668436542, - 12.312367845264555 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7521796676029873, - 0.14943125169254562, - 0.5473233314512739 - ], - "xyz": [ - 9.525903244917334, - 17.766571092530025, - 12.326662198643051 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7517601822166018, - 0.1475359961470128, - 0.748945219200235 - ], - "xyz": [ - 12.256529809608809, - 20.517374121198735, - 12.295015477275232 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7470301835292725, - 0.1518801034940061, - 0.9500830852877818 - ], - "xyz": [ - 15.065842363650622, - 23.202627130878376, - 12.2897396403306 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7475019743394113, - 0.35258239903141697, - 0.15043860697921255 - ], - "xyz": [ - 6.877212650396244, - 12.276481998483588, - 15.040155537538757 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.749472155027816, - 0.3497485613162399, - 0.34786681422262505 - ], - "xyz": [ - 9.537671843599764, - 15.002620866577562, - 15.028347774126987 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7525563545441515, - 0.347916067792481, - 0.5486716606216845 - ], - "xyz": [ - 12.257986037087356, - 17.79015520230458, - 15.045460873150418 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7468460860458291, - 0.35085527237827957, - 0.751314033975934 - ], - "xyz": [ - 15.068660365999662, - 20.482575492115938, - 15.007575386129895 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7509375197438157, - 0.3485900788352026, - 0.9525161567380168 - ], - "xyz": [ - 17.788490253634652, - 23.289312043197846, - 15.032543412804593 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7504405112471576, - 0.5469574781524762, - 0.15078207247532785 - ], - "xyz": [ - 9.539369543064222, - 12.32135294458875, - 17.7377917794337 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7521775066735752, - 0.5485732203243789, - 0.35140168045351955 - ], - "xyz": [ - 12.304294847953287, - 15.087936002147956, - 17.783629804385168 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7494519864435709, - 0.5500852640874135, - 0.5476857761674718 - ], - "xyz": [ - 15.008528063577545, - 17.734234005620905, - 17.76703937255452 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503497513715628, - 0.5486616326721486, - 0.7528365897296084 - ], - "xyz": [ - 17.79384942699679, - 20.551293081993812, - 17.759849820596493 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7516658319185849, - 0.551778500469886, - 0.9474103579318432 - ], - "xyz": [ - 20.496640218073928, - 23.229463833920878, - 17.820456292435342 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7508719115424456, - 0.7474545821502212, - 0.14929806734444495 - ], - "xyz": [ - 12.260240808414164, - 12.306961920745366, - 20.484850122997273 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.747950923168844, - 0.7484086025125662, - 0.3519124679351183 - ], - "xyz": [ - 15.04339161736806, - 15.037134307762972, - 20.45795809040162 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7528230388317932, - 0.7483049754624149, - 0.5504096295752848 - ], - "xyz": [ - 17.755792311446523, - 17.817562460581257, - 20.52315200838784 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7517399563053293, - 0.7469320419359108, - 0.7508270844838056 - ], - "xyz": [ - 20.477093179767607, - 20.54282611960171, - 20.48957379899455 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7527212628775483, - 0.7490514780034859, - 0.9477910315962061 - ], - "xyz": [ - 23.19892535959526, - 23.249097997832163, - 20.531966594232138 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7475695342223106, - 0.9491022407507372, - 0.15091473777211065 - ], - "xyz": [ - 15.03923412730824, - 12.283915239538768, - 23.196591106512013 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7488144012278904, - 0.9476367695799011, - 0.3515656028357537 - ], - "xyz": [ - 17.762460979239798, - 15.044197347157409, - 23.193575046073377 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7501688121124607, - 0.9489265176745945, - 0.5528797540606087 - ], - "xyz": [ - 20.532425022034783, - 17.815045447976292, - 23.229725511689253 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.750450169052269, - 0.952293523717979, - 0.7471880193749774 - ], - "xyz": [ - 23.23500575048914, - 20.475439737303393, - 23.27960527369013 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.751176422663854, - 0.9468774484177825, - 0.9513894740748735 - ], - "xyz": [ - 25.95276367627354, - 23.277174478350467, - 23.215486875731337 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9523465720409363, - 0.14727633498724974, - 0.14975325894445457 - ], - "xyz": [ - 4.060935142907353, - 15.067710511262685, - 15.033846452766094 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9479355252702704, - 0.14882631818198216, - 0.35273540879250775 - ], - "xyz": [ - 6.85726165008437, - 17.78253888973817, - 14.994730506547373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9529717420151731, - 0.14996105606370472, - 0.5481861948822376 - ], - "xyz": [ - 9.544943548427753, - 20.523561104832755, - 15.079098687430761 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9509338445661215, - 0.14686855955589032, - 0.7507232298779126 - ], - "xyz": [ - 12.271713378616854, - 23.26474922352543, - 15.008956864723404 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9496407716359806, - 0.1506748411882771, - 0.9523661329802533 - ], - "xyz": [ - 15.080577651456796, - 26.003896038670316, - 15.04331700172294 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.952979818826137, - 0.3500181069208907, - 0.14847482646418708 - ], - "xyz": [ - 6.815305656512773, - 15.058889648573158, - 17.81435310118673 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9492698245421137, - 0.3527091414819735, - 0.3503416902404429 - ], - "xyz": [ - 9.611984422159168, - 17.76805470003445, - 17.800422067267434 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501261235723792, - 0.351975720145938, - 0.5470455878297976 - ], - "xyz": [ - 12.29125749880882, - 20.46906214738251, - 17.80210202898496 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9475020552949842, - 0.3503024665222675, - 0.7526198306647192 - ], - "xyz": [ - 15.078955121126986, - 23.24376040290159, - 17.743349817471536 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9496847618921412, - 0.3475036290109487, - 0.9501626260716006 - ], - "xyz": [ - 17.741459459562698, - 25.974371515710445, - 17.73492618651668 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9477758055096825, - 0.5510046164268695, - 0.14878293095501854 - ], - "xyz": [ - 9.567369386046643, - 14.99195366437283, - 20.491056148240588 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9490152269153631, - 0.5530839241236696, - 0.3495383096376595 - ], - "xyz": [ - 12.340488707982812, - 17.753590212116343, - 20.536429215158467 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9481785955632387, - 0.5481758535104717, - 0.5520286348466672 - ], - "xyz": [ - 15.041797728010897, - 20.510563216862757, - 20.457888683934932 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500178904309875, - 0.5529244757290033, - 0.7480322467737075 - ], - "xyz": [ - 17.78644613784701, - 23.21543582683789, - 20.547957500513483 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9480142656380759, - 0.5491680512395254, - 0.9529531622373962 - ], - "xyz": [ - 20.536730848838044, - 25.989684499776434, - 20.469207143533524 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.950280891419836, - 0.7495918737792938, - 0.15262498814069567 - ], - "xyz": [ - 12.33494653713495, - 15.078730662293266, - 23.240354468704762 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9518147427431715, - 0.7502867219990401, - 0.34697553718539914 - ], - "xyz": [ - 15.001572100363, - 17.756826924933026, - 23.27082484769186 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9507422849128907, - 0.7508927692124132, - 0.5468705390355799 - ], - "xyz": [ - 17.742786352971077, - 20.475092958715177, - 23.26444816569141 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9481214270144666, - 0.7495049240931083, - 0.749345145817984 - ], - "xyz": [ - 20.492008362811866, - 23.20745743978215, - 23.20964189959956 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9530874330729064, - 0.7495476320624787, - 0.9489706840372513 - ], - "xyz": [ - 23.221836684418605, - 26.004596206668992, - 23.278120136219258 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9469626184417431, - 0.9518581232707436, - 0.1506137912330023 - ], - "xyz": [ - 15.072797570150602, - 15.005867109319377, - 25.960335392959607 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9519867420192969, - 0.9476603270289532, - 0.3515713324760094 - ], - "xyz": [ - 17.762861387053135, - 17.822011354046417, - 25.971632791555244 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9523254221157065, - 0.9512481108677745, - 0.5483236050188043 - ], - "xyz": [ - 20.501874576692444, - 20.516603382158145, - 26.02531469971421 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9481298446945302, - 0.9529029428301736, - 0.7488065100444301 - ], - "xyz": [ - 23.265465332000062, - 23.20020839344721, - 25.990578085135994 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.948930256353339, - 0.952638257441321, - 0.9477944883878336 - ], - "xyz": [ - 25.98237442308195, - 25.931679299647257, - 25.997902438268106 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09815288751576105, - 0.09774784994105128, - 0.10096019723846612 - ], - "xyz": [ - 2.7167006535898692, - 2.722238254404538, - 2.678319620376796 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09814550960236808, - 0.09994093282277051, - 0.2983123280619464 - ], - "xyz": [ - 5.44484689722889, - 5.420300194135727, - 2.708202185276858 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10243235990660247, - 0.09790125431829821, - 0.49772571136161864 - ], - "xyz": [ - 8.143304661922, - 8.20525312192629, - 2.7389251136322814 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10338838898477706, - 0.0999831247807884, - 0.6972908426773508 - ], - "xyz": [ - 10.900186173773536, - 10.946742333022911, - 2.780458729330333 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10241246740754571, - 0.09928343185915685, - 0.9015487364210973 - ], - "xyz": [ - 13.683197254937344, - 13.725976865728517, - 2.757550029512489 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09855737838767102, - 0.2982244836454141, - 0.09950575104354585 - ], - "xyz": [ - 5.437696177225216, - 2.7078834542202994, - 5.424730196981173 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10075416867091551, - 0.3019967781409809, - 0.3009611873131218 - ], - "xyz": [ - 8.24353277125471, - 5.492180038249681, - 5.506338449641821 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09825432135986494, - 0.2995708573361441, - 0.498473674537847 - ], - "xyz": [ - 10.910721191765468, - 8.158357748874256, - 5.43899423459967 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10342454940894154, - 0.2973292783114376, - 0.6998631830301207 - ], - "xyz": [ - 13.633435836818743, - 10.98240528611502, - 5.479034196904033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10312663957026012, - 0.2970964569161572, - 0.8991713776049962 - ], - "xyz": [ - 16.355158505362994, - 13.703238077177012, - 5.4717781350049295 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09729120502954441, - 0.49923634311479553, - 0.10010680714091641 - ], - "xyz": [ - 8.194111668529047, - 2.6987900907523494, - 8.155617263270749 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10348070627114098, - 0.49879904550771786, - 0.2976144371080653 - ], - "xyz": [ - 10.888421779896115, - 5.483700603154699, - 8.234260355965237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.096667956693012, - 0.5018335073593693, - 0.4993941577731504 - ], - "xyz": [ - 13.688604416712083, - 8.149253937800767, - 8.182604286260625 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10026037308277115, - 0.5001332492902866, - 0.7028932288892343 - ], - "xyz": [ - 16.447561464904336, - 10.980571478512903, - 8.208473534232418 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10287477721466246, - 0.49707102989527746, - 0.8989282252518164 - ], - "xyz": [ - 19.085850536505138, - 13.696470325181252, - 8.202351084561817 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10002003065983157, - 0.6974122891034741, - 0.10343634729966282 - ], - "xyz": [ - 10.949058404149133, - 2.7816189773141744, - 10.902351137986356 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10213880354136594, - 0.7020306593844426, - 0.29694845793711006 - ], - "xyz": [ - 13.657862675779148, - 5.456249203226657, - 10.994460146618326 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09749536591951395, - 0.7025643109915568, - 0.5017602803584139 - ], - "xyz": [ - 16.465309034510355, - 8.192915329895499, - 10.938271891986314 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10264250961667915, - 0.7016433233559225, - 0.6974142724475338 - ], - "xyz": [ - 19.127663619457607, - 10.938232314161148, - 10.996051136951474 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1029794186087137, - 0.6995539901034307, - 0.8968658409301066 - ], - "xyz": [ - 21.82596457432093, - 13.669704416268033, - 10.972092307898869 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09808356578530955, - 0.8975739492818177, - 0.10254048781777789 - ], - "xyz": [ - 13.67338456342699, - 2.7428959485317623, - 13.61245032764505 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09906550599001218, - 0.8973599675839241, - 0.30020169638322497 - ], - "xyz": [ - 16.372847508659348, - 5.458709322750471, - 13.622949718117612 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09927232750775354, - 0.8973701205235702, - 0.4999213114450344 - ], - "xyz": [ - 19.103516945417006, - 8.192067576907505, - 13.625916153843612 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09887570303544015, - 0.9035186900159318, - 0.6999749664336664 - ], - "xyz": [ - 21.92267664212074, - 10.92174255986112, - 13.704555710807606 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10375732943559493, - 0.8992844069158583, - 0.898434208690021 - ], - "xyz": [ - 24.578085323212772, - 13.701782314776557, - 13.713406071884524 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2983034654303054, - 0.09836922662679375, - 0.10368684127458704 - ], - "xyz": [ - 2.7624741902554555, - 5.495939115014082, - 5.423237644720088 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3027344231617278, - 0.09680273747680385, - 0.3010837829643843 - ], - "xyz": [ - 5.439832887898245, - 8.2552938268791, - 5.462400143561088 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.296766761341132, - 0.09922015516570691, - 0.5022760824570548 - ], - "xyz": [ - 8.223548291455625, - 10.924369932696925, - 5.413861844836529 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2988168575250509, - 0.10378833652636989, - 0.6989370656181066 - ], - "xyz": [ - 10.974717207546895, - 13.641112041507084, - 5.504345744136096 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29867744262881185, - 0.10360908641512069, - 0.8998239334555057 - ], - "xyz": [ - 13.718755629727626, - 16.385695083577094, - 5.499989013513417 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30281250845480334, - 0.30124816997632864, - 0.0970901645130262 - ], - "xyz": [ - 5.446010008238251, - 5.4673973623350305, - 8.258608864588318 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3036994738325015, - 0.29797799909919964, - 0.29896357420335007 - ], - "xyz": [ - 8.161277740709265, - 8.239500713397517, - 8.22602610797709 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29959677793044076, - 0.30299389093299267, - 0.500545583899647 - ], - "xyz": [ - 10.985847062806378, - 10.939402345315829, - 8.238511158380465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3028973511852627, - 0.2967373589807237, - 0.6999055840043056 - ], - "xyz": [ - 13.625922920761582, - 13.710141225383442, - 8.198097823141534 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2988631331429816, - 0.3007657295458241, - 0.903127679692056 - ], - "xyz": [ - 16.45941399028663, - 16.43340203473432, - 8.198017877486066 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2983803671534153, - 0.502317716308898, - 0.10199840735615867 - ], - "xyz": [ - 8.262101265846393, - 5.473906536915483, - 10.947000071441723 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30305403639966133, - 0.5002491217887118, - 0.2968626404481509 - ], - "xyz": [ - 10.897968533185184, - 8.201952820861456, - 10.982616184182962 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3033283714655558, - 0.4971872830319603, - 0.4994801317181098 - ], - "xyz": [ - 13.626257494328302, - 10.975853349996502, - 10.944505935472229 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29911844101061064, - 0.5032510101287229, - 0.6972174084031204 - ], - "xyz": [ - 16.412588133852022, - 13.621724392731634, - 10.969850709475761 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30264608663662057, - 0.5012330867459396, - 0.8967928479920553 - ], - "xyz": [ - 19.113558935069612, - 16.39851321523502, - 10.990491360235152 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29997032387910627, - 0.7026595765428181, - 0.09659611489684516 - ], - "xyz": [ - 10.927279947338615, - 5.421784968985827, - 13.707775525186472 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30204389864064835, - 0.7004476119808635, - 0.3011809732911184 - ], - "xyz": [ - 13.694085724693185, - 8.247181868574167, - 13.705883484745396 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30241529079951535, - 0.6988354548210478, - 0.5017503099039923 - ], - "xyz": [ - 16.414192469883098, - 10.994407343010229, - 13.688919968990126 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2982791605074961, - 0.7024822063337858, - 0.7018382394673354 - ], - "xyz": [ - 19.19961635731268, - 13.673425071323898, - 13.682229270407973 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30140476688046663, - 0.7025928371742645, - 0.8968669315904267 - ], - "xyz": [ - 21.867526055792478, - 16.382554972588327, - 13.726474523067553 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2992995296234906, - 0.9037490399066654, - 0.09829286682600835 - ], - "xyz": [ - 13.699736581305903, - 5.435811677626188, - 16.447863493873776 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2962460234854722, - 0.9009531519021857, - 0.30181063582250156 - ], - "xyz": [ - 16.443970008290133, - 8.17652299585994, - 16.367891630048486 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2982356625891448, - 0.8977072848042378, - 0.5031818794033753 - ], - "xyz": [ - 19.15270449299693, - 10.956836378964177, - 16.350716707031793 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29936823207975677, - 0.9035863619681155, - 0.6976188837805759 - ], - "xyz": [ - 21.89138990293187, - 13.630628390361613, - 16.44657867799558 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30246404773881086, - 0.8993454954967797, - 0.8967369892746386 - ], - "xyz": [ - 24.55571643694757, - 16.395260721861217, - 16.43092374939921 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4974233284101937, - 0.09823134856327816, - 0.10201229684641704 - ], - "xyz": [ - 2.7376950761851786, - 8.195375970095835, - 8.143683525739451 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5021185120419296, - 0.10221819659415292, - 0.29735851576202627 - ], - "xyz": [ - 5.462940887525457, - 10.930306018270679, - 8.262382699864965 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49838041013606854, - 0.1025013699081316, - 0.4973240458430608 - ], - "xyz": [ - 8.200705115575467, - 13.613092095344578, - 8.215147538043896 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4979120850034683, - 0.09892213850038206, - 0.7036718436430784 - ], - "xyz": [ - 10.972920456948605, - 16.42783918734843, - 8.15981007358441 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5009074422838303, - 0.10311811604989808, - 0.8985399662507007 - ], - "xyz": [ - 13.69448900275897, - 19.13299306895057, - 8.258128708938234 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4994239925550201, - 0.30242760028544624, - 0.09669507680765953 - ], - "xyz": [ - 5.456733399135065, - 8.15003261489407, - 10.962770644028144 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49891915211273397, - 0.30377609832081137, - 0.29896889967001694 - ], - "xyz": [ - 8.240621118430965, - 10.908581824124449, - 10.974304978782353 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5019759487354366, - 0.2991347203955906, - 0.49679987442352436 - ], - "xyz": [ - 10.881874512139872, - 13.655083274581145, - 10.952640868438959 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49955450358642983, - 0.3034936128011825, - 0.6995272290947632 - ], - "xyz": [ - 13.713120406649827, - 16.393629614505386, - 10.979129298590484 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49711595846411705, - 0.3027774894141079, - 0.9013225070166268 - ], - "xyz": [ - 16.462238413201646, - 19.119198981128942, - 10.935999238570473 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.499171986893597, - 0.5015483988476268, - 0.09681871765564472 - ], - "xyz": [ - 8.180767510751757, - 8.148277634270412, - 13.681668984184578 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49689002854223135, - 0.4991330841100658, - 0.3013071096790285 - ], - "xyz": [ - 10.943474250249613, - 10.912807598276183, - 13.617448712021927 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49840395148822003, - 0.5033398369033141, - 0.5005489213748824 - ], - "xyz": [ - 13.72498640320301, - 13.65750386626722, - 13.695660761007142 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4993383515316465, - 0.4986280617464617, - 0.6982898918778891 - ], - "xyz": [ - 16.36404681672047, - 16.373757770811356, - 13.644017168383904 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.501086082856336, - 0.5026154528042287, - 0.8966678710259841 - ], - "xyz": [ - 19.13074973240838, - 19.10984046176738, - 13.72242672927482 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4991051763423289, - 0.7006059759933395, - 0.10314859438092742 - ], - "xyz": [ - 10.988787810334308, - 8.23390514764963, - 16.402234926725836 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5033301027204105, - 0.6989770917465782, - 0.30034009208558515 - ], - "xyz": [ - 13.662484660260246, - 10.987634242752506, - 16.437727547457662 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4964234256620521, - 0.7004087528958841, - 0.5023849116175229 - ], - "xyz": [ - 16.444378478367685, - 13.655527801785638, - 16.362874115451962 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49717654503286646, - 0.7018331615301799, - 0.6985668061820677 - ], - "xyz": [ - 19.146016286567658, - 16.347987864007358, - 16.392644886382786 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003993088448705, - 0.6969457423391193, - 0.8995600751716892 - ], - "xyz": [ - 21.82714016596062, - 19.13999270558528, - 16.369886017678294 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5012505833710423, - 0.8969602118182486, - 0.10274592845123943 - ], - "xyz": [ - 13.667802402659191, - 8.257731590262107, - 19.11608631388485 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4964729376057878, - 0.8999531743012664, - 0.3013227165632598 - ], - "xyz": [ - 16.423627750239447, - 10.907318580581467, - 19.0916864452931 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003715826191291, - 0.8990747080866707, - 0.5032861883260537 - ], - "xyz": [ - 19.17282575079341, - 13.721828385963766, - 19.132977786197365 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4967145275708546, - 0.9027569802265994, - 0.6996622522952805 - ], - "xyz": [ - 21.907987311577287, - 16.356647986509422, - 19.133322549735386 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4995557595724272, - 0.8978642725153338, - 0.9036535528128679 - ], - "xyz": [ - 24.630027434678613, - 19.184425141255524, - 19.10527514309809 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7023262160269064, - 0.10066481001126845, - 0.09639103690981074 - ], - "xyz": [ - 2.6941120690525486, - 10.919918513045268, - 10.978348769609239 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7021592361545197, - 0.10213786081525487, - 0.2972211962805809 - ], - "xyz": [ - 5.45996514398399, - 13.663349383774856, - 10.996205136293302 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6985190482722559, - 0.09968445985014701, - 0.49812757463004464 - ], - "xyz": [ - 8.173178529246973, - 16.360337231928128, - 10.912894686418028 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6974258061930431, - 0.10218701981974991, - 0.7021652909325329 - ], - "xyz": [ - 10.996960009189273, - 19.134957553503387, - 10.93216262693822 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6982250955187537, - 0.10287885306404217, - 0.9013470099137626 - ], - "xyz": [ - 13.72959523797721, - 21.869061902494384, - 10.95254898631324 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6991930588487655, - 0.30063437188166864, - 0.09707038987871877 - ], - "xyz": [ - 5.4373479159309, - 10.886370543581393, - 13.669460664008962 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7011033429557312, - 0.30244329158015537, - 0.299927177726511 - ], - "xyz": [ - 8.235500629676267, - 13.68590909327389, - 13.720308948980422 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6988181194654379, - 0.3000081718063399, - 0.50351721352945 - ], - "xyz": [ - 10.985654433741557, - 16.438112252346166, - 13.655773265535315 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7016141927079066, - 0.2992722452316158, - 0.6967521791930755 - ], - "xyz": [ - 13.617466646337983, - 19.118213330683282, - 13.683939219950318 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7013309785740816, - 0.2980092777528627, - 0.9029093683236877 - ], - "xyz": [ - 16.418743563802302, - 21.932885259523857, - 13.66280010325584 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7021927377780388, - 0.5021955476832003, - 0.0978423326337663 - ], - "xyz": [ - 8.203609892875109, - 10.937935476357525, - 16.466179848934676 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6975046884030945, - 0.5012501280017027, - 0.3029350659123047 - ], - "xyz": [ - 10.994675217857402, - 13.67783224184436, - 16.389160074019433 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6979666406255904, - 0.5004760674351301, - 0.49816273843102576 - ], - "xyz": [ - 13.653209998817026, - 16.353265567173825, - 16.384892984918718 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6984610226356323, - 0.4976833705951471, - 0.7004974818762386 - ], - "xyz": [ - 16.38131294243534, - 19.126308861155483, - 16.35347083826043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.702594395492115, - 0.4978072508063296, - 0.9017536610885172 - ], - "xyz": [ - 19.134544866462203, - 21.934357846920218, - 16.411675235896 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6967888583213733, - 0.7027820821261709, - 0.09946745004327823 - ], - "xyz": [ - 10.968211198904916, - 10.886272921826007, - 19.13468197502954 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7026503726276004, - 0.698602996038023, - 0.2971940781284351 - ], - "xyz": [ - 13.614358354530465, - 13.669693358735381, - 19.15768383079004 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6982672365199015, - 0.7028087447663197, - 0.49748851881509815 - ], - "xyz": [ - 16.4102481341777, - 16.348157450904154, - 19.155258622468583 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7013934197570283, - 0.7003627953948881, - 0.7019187057172188 - ], - "xyz": [ - 19.171740272534525, - 19.18583078330132, - 19.16455865743827 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6986194422038507, - 0.7037803314111096, - 0.8991029432056117 - ], - "xyz": [ - 21.91433161157038, - 21.843772863288795, - 19.173357272904486 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7025820556339358, - 0.8972078973425471, - 0.10165014579154419 - ], - "xyz": [ - 13.65620737128153, - 10.995317896092905, - 21.872040274902936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6993435303286569, - 0.9012055062829741, - 0.3026601704096518 - ], - "xyz": [ - 16.459034835919777, - 13.699214235828023, - 21.882418329727628 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7003664690521463, - 0.9034206240307792, - 0.49775028720099423 - ], - "xyz": [ - 19.15655648759678, - 16.380436630476808, - 21.926688454953 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7022541395024415, - 0.9008547075737545, - 0.6963700549446887 - ], - "xyz": [ - 21.836969452694902, - 19.121738234126163, - 21.917415597633276 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6963522068388032, - 0.9013799391725851, - 0.9002744195138911 - ], - "xyz": [ - 24.631894094176936, - 21.82879184270129, - 21.843906308481415 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9031823136741359, - 0.09906834778502514, - 0.10056757793147932 - ], - "xyz": [ - 2.7293864419294196, - 13.723087843051482, - 13.702590638350587 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8982152231263094, - 0.09837074625363626, - 0.2997586807205275 - ], - "xyz": [ - 5.4431538622939115, - 16.37848357809126, - 13.625143987888128 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9028351916245911, - 0.09667492569533047, - 0.5003954254615828 - ], - "xyz": [ - 8.163038368354108, - 19.184716415291092, - 13.66512241217685 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9000323067667537, - 0.09644182072156021, - 0.7013258194794029 - ], - "xyz": [ - 10.90693557865233, - 21.893480057574727, - 13.623614905677279 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9016702082637972, - 0.09806153821610153, - 0.8976165381882321 - ], - "xyz": [ - 13.612731438546295, - 24.59952452587778, - 13.668152486158807 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8962852992807765, - 0.3004850464033482, - 0.10168592284941007 - ], - "xyz": [ - 5.498409100849245, - 13.644082914143926, - 16.362028747531127 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9026118705258225, - 0.30172867306711715, - 0.2979509234670081 - ], - "xyz": [ - 8.198711501487184, - 16.41387841816706, - 16.46552713070482 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8965595149955978, - 0.30070962482229674, - 0.5026284445447466 - ], - "xyz": [ - 10.983093483533729, - 19.12944592900287, - 16.368848171145086 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8970557017408879, - 0.2989867512725547, - 0.7010478976036372 - ], - "xyz": [ - 13.672293713198496, - 21.84898475159046, - 16.352077129958243 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8979176251979634, - 0.2981528928541068, - 0.9005879311963639 - ], - "xyz": [ - 16.388968773069706, - 24.58884423602309, - 16.35246083011465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8983674585281166, - 0.4981996275578159, - 0.10364787257554045 - ], - "xyz": [ - 8.228350689273222, - 13.6993732440896, - 19.093613818891374 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9022080664031467, - 0.5005253995222676, - 0.30091056744129263 - ], - "xyz": [ - 10.95708828185174, - 16.44882140056708, - 19.177919454108395 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8971117034395732, - 0.5000953741026665, - 0.4995245433656241 - ], - "xyz": [ - 13.666623580041323, - 19.09455937179623, - 19.10236366688354 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9028241276492878, - 0.5013157850145983, - 0.6972288701784326 - ], - "xyz": [ - 16.386286787761183, - 21.875636576760982, - 19.19714814075637 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9037797798846816, - 0.4985537821434992, - 0.8985515487827209 - ], - "xyz": [ - 19.100972605463713, - 24.641149505901566, - 19.17245204000812 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8978492667684759, - 0.7036628073669863, - 0.0994372487376466 - ], - "xyz": [ - 10.979839409052442, - 13.634721728426914, - 21.895584805406692 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.897491473631332, - 0.6981893873592818, - 0.30173459269751124 - ], - "xyz": [ - 13.670780669020063, - 16.395602918156005, - 21.815861508908693 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9019356610219424, - 0.702054943237429, - 0.4992945966382687 - ], - "xyz": [ - 16.42463466626336, - 19.157367861284026, - 21.929470823125357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8984335082254067, - 0.7034662898717887, - 0.6978282098389599 - ], - "xyz": [ - 19.158246167035404, - 21.823802882266765, - 21.900885697621195 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9013243383381874, - 0.6965733062224764, - 0.9023841560889514 - ], - "xyz": [ - 21.86065861237862, - 24.65997786827884, - 21.84616897485737 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9029321962254518, - 0.9002182703998561, - 0.09674375843470076 - ], - "xyz": [ - 13.63028540506087, - 13.667389710441766, - 24.652348612617214 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9030206703561681, - 0.9005408368826429, - 0.2995422341547652 - ], - "xyz": [ - 16.407319732270654, - 16.441223569150665, - 24.657968285897716 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8969441994603085, - 0.9021227317773401, - 0.502044586716647 - ], - "xyz": [ - 19.19752282833246, - 19.12672286662982, - 24.596519251833506 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8993179803222678, - 0.9010976007572744, - 0.7027505436250505 - ], - "xyz": [ - 21.927523137329153, - 21.903192487073422, - 24.614957749714904 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8993758593582625, - 0.8966799895175684, - 0.9021585279048587 - ], - "xyz": [ - 24.593396419266284, - 24.630253866471683, - 24.55535227577756 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15179823682152985, - 0.15232119571523645, - 0.14897788835629272 - ], - "xyz": [ - 4.119306843590814, - 4.112157043728658, - 4.157866140144812 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15122152123568733, - 0.15261985499622552, - 0.34675155548065406 - ], - "xyz": [ - 6.827316037186011, - 6.80819826971201, - 4.15406460439499 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15062962297327698, - 0.15181524284820375, - 0.5512855042906829 - ], - "xyz": [ - 9.612666856748373, - 9.596457275229952, - 4.134971765435436 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14834175431579874, - 0.15335744491372652, - 0.7477731095603154 - ], - "xyz": [ - 12.320094737269294, - 12.251521118238733, - 4.124777146010207 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15277243753243092, - 0.1466265703800446, - 0.950220868395104 - ], - "xyz": [ - 14.995900750394851, - 15.07992593984619, - 4.09332934435794 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14899821644384761, - 0.3527222870007679, - 0.15130368349877973 - ], - "xyz": [ - 6.890952343995124, - 4.10567352167361, - 6.859432413404162 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14903665623399825, - 0.3535016048520807, - 0.3475373323357618 - ], - "xyz": [ - 9.584478162223487, - 6.789070188407816, - 6.870612648681875 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15056195363829708, - 0.3519285851408173, - 0.551216751111922 - ], - "xyz": [ - 12.347640471086926, - 9.594592131178139, - 6.869960197891071 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14877085100738796, - 0.35352840349524656, - 0.7476979860869524 - ], - "xyz": [ - 15.055768977617698, - 12.256360576363143, - 6.867344993694208 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15064089363175018, - 0.3515560725987343, - 0.9462544168438808 - ], - "xyz": [ - 17.743431405771332, - 14.99655524366694, - 6.865946526849261 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1495307725481334, - 0.5522011896895007, - 0.1516533895460986 - ], - "xyz": [ - 9.62297311348485, - 4.117735651003163, - 9.59395307595973 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15257642864438473, - 0.5496232313047409, - 0.3511429944708957 - ], - "xyz": [ - 12.315113700883863, - 6.886761283335952, - 9.600347354885653 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1483772674125666, - 0.5483059765871959, - 0.5536901632478156 - ], - "xyz": [ - 15.066292864519106, - 9.598539539851226, - 9.524927908980832 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1467726876205848, - 0.5516932000282097, - 0.7523163289499395 - ], - "xyz": [ - 17.828183558474038, - 12.292183198529225, - 9.54929989207454 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15149438512975033, - 0.5473380083588381, - 0.9484322136985256 - ], - "xyz": [ - 20.449901237328305, - 15.037998472392397, - 9.554310693945151 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15158139718110925, - 0.7516155181316649, - 0.14627564670825866 - ], - "xyz": [ - 12.275806385281763, - 4.072247889787538, - 12.348345650711492 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500242413258054, - 0.7534099443098646, - 0.34735162021963817 - ], - "xyz": [ - 15.049413973165747, - 6.800033251394225, - 12.351589567857465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15316712232016133, - 0.7509231710216892, - 0.5480308658417836 - ], - "xyz": [ - 17.759065780270763, - 9.586652678512241, - 12.360559754316977 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1531273891099308, - 0.7479242361330731, - 0.7509936277424982 - ], - "xyz": [ - 20.492935229691312, - 12.360979800623374, - 12.319015631029805 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15056339030106952, - 0.7532925587270876, - 0.9474944481815766 - ], - "xyz": [ - 23.252853816794012, - 15.01244911732381, - 12.357355841042137 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14967313242762006, - 0.9536327890500368, - 0.14884259805756347 - ], - "xyz": [ - 15.07284504696543, - 4.081253334361942, - 15.084199963376657 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15117259795091856, - 0.9467723729193995, - 0.3493911192498763 - ], - "xyz": [ - 17.720913955509747, - 6.84361704010017, - 15.01090601164423 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15163296494857206, - 0.9520834391830583, - 0.5465067763817348 - ], - "xyz": [ - 20.488455680963046, - 9.544840878314515, - 15.089812008334905 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15343934473012824, - 0.9473290124576766, - 0.7496409324951342 - ], - "xyz": [ - 23.200667632804738, - 12.346750995773887, - 15.049506841167373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1501961372691662, - 0.951077811091663, - 0.9522996987117226 - ], - "xyz": [ - 26.02263470608012, - 15.073124620280234, - 15.05641919267855 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3512963014855286, - 0.1472209094220848, - 0.1486489509491486 - ], - "xyz": [ - 4.0450794744206355, - 6.835161501141467, - 6.8156375744309265 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35013452784664223, - 0.1487920860594192, - 0.34760356489951166 - ], - "xyz": [ - 6.78663198869333, - 9.53934961116872, - 6.821234858533169 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34680653387715177, - 0.15095266407915314, - 0.5528001811438452 - ], - "xyz": [ - 9.621582224376692, - 12.299261078558365, - 6.805274157802968 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3527738283783855, - 0.14907609206222874, - 0.7511964640150838 - ], - "xyz": [ - 12.308364337628921, - 15.09328312295088, - 6.861201779278398 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3496245575372575, - 0.14822301556222467, - 0.9536881679507776 - ], - "xyz": [ - 15.065131356976734, - 17.81865698658183, - 6.806482406852962 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3531233623091307, - 0.3473487043359598, - 0.15085105680034228 - ], - "xyz": [ - 6.811297458298517, - 6.890247542669274, - 9.57672801019968 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34774249594426615, - 0.34803914997350827, - 0.35295214832530847 - ], - "xyz": [ - 9.583826851907729, - 9.579771051417655, - 9.512601422291546 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34698440777765494, - 0.35289993524465396, - 0.5491225197166693 - ], - "xyz": [ - 12.332288640189317, - 12.25141261345545, - 9.568692758619262 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3489483690056694, - 0.3517113040507141, - 0.7469308532877812 - ], - "xyz": [ - 15.020437819543584, - 14.982663468936043, - 9.579292931285725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34953130166230006, - 0.34666120640140363, - 0.951336297339087 - ], - "xyz": [ - 17.745988231589312, - 17.785227657379142, - 9.518218655595504 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34737202137250683, - 0.5515226590388189, - 0.14838193569511285 - ], - "xyz": [ - 9.568969636375263, - 6.777858865316223, - 12.28952626954117 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35142579780453653, - 0.552301192157654, - 0.34655756513301367 - ], - "xyz": [ - 12.289035135101695, - 9.542702901076856, - 12.355592735904876 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3493154147730179, - 0.5468651582820901, - 0.5528234457960741 - ], - "xyz": [ - 15.034744651007927, - 12.333880116705721, - 12.252419482306285 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3502255839713079, - 0.5486856192934552, - 0.7534502966974247 - ], - "xyz": [ - 17.80256785896243, - 15.08925797884439, - 12.289752167019252 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34702247826438826, - 0.5532104938484724, - 0.9497107862652511 - ], - "xyz": [ - 20.547669215884405, - 17.72870378066161, - 12.30782315279205 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3473711926314932, - 0.7524859470535203, - 0.1518262732663064 - ], - "xyz": [ - 12.363593900013013, - 6.824937898210854, - 15.03704883948836 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3463686430500979, - 0.7522059340036104, - 0.35040376105016086 - ], - "xyz": [ - 15.074681281030049, - 9.526146889825998, - 15.019513874054429 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3503829671125023, - 0.753010864595139, - 0.5497674437147458 - ], - "xyz": [ - 17.81135053111725, - 12.306694389756185, - 15.085401856217162 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35112314621789636, - 0.7510807879837557, - 0.7462146124078696 - ], - "xyz": [ - 20.470753200982227, - 15.002604315134917, - 15.069133791696828 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35215315455584756, - 0.7463441315607282, - 0.951005513435992 - ], - "xyz": [ - 23.205858823459057, - 17.81655074022419, - 15.018457166274322 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3499232742094389, - 0.9523981414415212, - 0.1511639706048389 - ], - "xyz": [ - 15.087702554717666, - 6.850774615396738, - 17.805103976925107 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3488397995311511, - 0.9515600481176779, - 0.3525749599400876 - ], - "xyz": [ - 17.82989908586432, - 9.58961633683407, - 17.77883264508221 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3511450382863396, - 0.950352336187034, - 0.5521412431706836 - ], - "xyz": [ - 20.541821768134426, - 12.349567448549758, - 17.793837834272555 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35307746142216057, - 0.9472362465474415, - 0.7488181080049265 - ], - "xyz": [ - 23.188149845656156, - 15.064917884004636, - 17.777654958892963 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34625557630398085, - 0.9507266793833723, - 0.9512282015025911 - ], - "xyz": [ - 26.00318477959433, - 17.738964663091444, - 17.732107942951465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5464918780783853, - 0.15254358794222891, - 0.1503879478345423 - ], - "xyz": [ - 4.141625429463575, - 9.52761554151288, - 9.557087065049952 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5468617743682643, - 0.1500206049066824, - 0.35005032602866465 - ], - "xyz": [ - 6.836879754980496, - 12.26242079244874, - 9.5276504506188 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5531084945011872, - 0.14718495774390253, - 0.5507558967399847 - ], - "xyz": [ - 9.542121733149898, - 15.091835261458877, - 9.57428602627346 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5485275591793796, - 0.14719174403559096, - 0.7522872295127607 - ], - "xyz": [ - 12.297514620137825, - 17.784505644336974, - 9.511749084080497 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5519923959034266, - 0.14655480898856424, - 0.9518139233668758 - ], - "xyz": [ - 15.01669960239175, - 20.559769311926104, - 9.550411646786417 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5520336241395383, - 0.3507269088003499, - 0.14629751265980295 - ], - "xyz": [ - 6.795228425807346, - 9.54745760271597, - 12.34237950945822 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5537416366286138, - 0.34924324990978134, - 0.34816665721602996 - ], - "xyz": [ - 9.534862716440808, - 12.330727849951076, - 12.34544683147336 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5527253501833571, - 0.35060355432645357, - 0.5466140512918752 - ], - "xyz": [ - 12.26659760484478, - 15.02997041587711, - 12.350150183255318 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5510628014983985, - 0.34926173044573294, - 0.7468769516405933 - ], - "xyz": [ - 14.986210756521475, - 17.74519867576073, - 12.309074942324415 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.548779670795897, - 0.34943555722324426, - 0.9480764305917174 - ], - "xyz": [ - 17.739350345248347, - 20.46474718407321, - 12.280236918736655 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5484412094452038, - 0.5482487867007834, - 0.15369032442868194 - ], - "xyz": [ - 9.596785178322046, - 9.599415947447667, - 14.993748223108629 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5510103875932504, - 0.5462090142254111, - 0.3514167072973221 - ], - "xyz": [ - 12.272177292028934, - 12.337820804466824, - 15.000986162172412 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5487275455415851, - 0.5537588286809376, - 0.5492154807167621 - ], - "xyz": [ - 15.079666222709657, - 15.010879425259395, - 15.07299526082297 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502092511635279, - 0.5473186776349165, - 0.7491181509894498 - ], - "xyz": [ - 17.72465096232318, - 17.764170363303123, - 15.005204287505146 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5520030392502275, - 0.5523426450913156, - 0.948225325935396 - ], - "xyz": [ - 20.515495197642412, - 20.51085216771211, - 15.098415414094395 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5493503428921885, - 0.7507371471674585, - 0.15298036199391338 - ], - "xyz": [ - 12.355463116102626, - 9.602138977675905, - 17.774562148347282 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5482938018894848, - 0.749109889922219, - 0.3488297641235077 - ], - "xyz": [ - 15.010833320975447, - 12.26531191228775, - 17.737869741785087 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5485024375549603, - 0.7472060245772628, - 0.5521779680533059 - ], - "xyz": [ - 17.76494405812646, - 15.048304383003204, - 17.714692866748567 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497942074100405, - 0.7493521683211948, - 0.7534627090752605 - ], - "xyz": [ - 20.546214497086403, - 17.817893975942066, - 17.761695402649814 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5479110319728145, - 0.7477171172423916, - 0.9524387429112511 - ], - "xyz": [ - 23.244224891965775, - 20.512512059255464, - 17.71359484300344 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.547472148948714, - 0.9521264857803988, - 0.14816755765287917 - ], - "xyz": [ - 15.043022108891957, - 9.510660853509792, - 20.502242606262175 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5489459445877535, - 0.9537649994163357, - 0.3490310846094437 - ], - "xyz": [ - 17.81159355750533, - 12.276980307318823, - 20.544793538453984 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5488514132044807, - 0.9516789333846694, - 0.5524717055346948 - ], - "xyz": [ - 20.56447678819054, - 15.057091441240633, - 20.51498080310447 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5496759208043467, - 0.9465482902347034, - 0.7521246384073266 - ], - "xyz": [ - 23.223950519266676, - 17.79798292144134, - 20.456108092967906 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5496200736206138, - 0.9467357989067791, - 0.9527761415089397 - ], - "xyz": [ - 25.96978533721443, - 20.54049062193253, - 20.45790814513746 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7480183352949834, - 0.15371738384469258, - 0.1491930338768973 - ], - "xyz": [ - 4.1413367072143865, - 12.2665123412715, - 12.328368439648203 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7490281713176787, - 0.15365679975565794, - 0.3478394240439924 - ], - "xyz": [ - 6.8563661024685345, - 14.9961763276176, - 12.341346441219866 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7468505596783178, - 0.1518036937009034, - 0.5490632286521911 - ], - "xyz": [ - 9.582126406365484, - 17.717500049572816, - 12.286239194435103 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7487043268641576, - 0.15348089334910212, - 0.7476670808454849 - ], - "xyz": [ - 12.320332896553039, - 20.458120539352844, - 12.334513937416046 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7466025383667771, - 0.15019446743943157, - 0.9504724344094058 - ], - "xyz": [ - 15.04811976203497, - 23.20210355430087, - 12.26084723992144 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7474235036789716, - 0.3497520086872325, - 0.15348239066691907 - ], - "xyz": [ - 6.880130125778075, - 12.317023224436035, - 15.000386113478516 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.747619136306386, - 0.35270776222641204, - 0.34807504645972154 - ], - "xyz": [ - 9.580976419451254, - 14.980133641825322, - 15.043471297898677 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7477013647977285, - 0.3479562946260749, - 0.5517403003232925 - ], - "xyz": [ - 12.30048990076066, - 17.765732546034876, - 14.979634301263543 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7530128283402997, - 0.3481340097166753, - 0.7476883288276222 - ], - "xyz": [ - 14.981885764556695, - 20.517316094591536, - 15.054681363484109 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7468889064714301, - 0.34904745581291774, - 0.9524883793837307 - ], - "xyz": [ - 17.79436366235824, - 23.233580364300302, - 14.983444676606391 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7516610426360427, - 0.5523547471340117, - 0.149194713467471 - ], - "xyz": [ - 9.591457946440562, - 12.31633774341114, - 17.828269154894024 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7489365899689313, - 0.5524846360946293, - 0.3469499944228425 - ], - "xyz": [ - 12.29690837020138, - 14.982764122219141, - 17.792796746920306 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7483819062912455, - 0.5488029368446308, - 0.5490362947492806 - ], - "xyz": [ - 15.009460363290268, - 17.738068109349882, - 17.734877682081933 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7482494041193627, - 0.5536948569290278, - 0.7495993084340878 - ], - "xyz": [ - 17.81840323589475, - 20.478317985262514, - 17.799947587086603 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.748253171987662, - 0.5488855562175898, - 0.9490990181166298 - ], - "xyz": [ - 20.48017546307407, - 23.205893619711656, - 17.734247207051123 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7529074960746027, - 0.7472049555289211, - 0.1487215662697715 - ], - "xyz": [ - 12.2489461392578, - 12.326910247141061, - 20.509267418082086 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7515273286867583, - 0.7516995868738885, - 0.3504879576550989 - ], - "xyz": [ - 15.068909715042297, - 15.066554632114327, - 20.55184780870036 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7463454705661453, - 0.7521944307032906, - 0.5508364883045055 - ], - "xyz": [ - 17.814804179109164, - 17.734838248926938, - 20.487767792973496 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7491286594405419, - 0.7489970060922941, - 0.7537423337299479 - ], - "xyz": [ - 20.545181760968525, - 20.546981701848164, - 20.482104436545136 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7526562603886828, - 0.7475245205235794, - 0.9516502495672132 - ], - "xyz": [ - 23.230811605222698, - 23.300971828945215, - 20.510201604091883 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7513209984667562, - 0.9510599808696245, - 0.15141302588277575 - ], - "xyz": [ - 15.0728125031776, - 12.342017088782416, - 23.274646320910712 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7511663976868679, - 0.9511706087177746, - 0.3514581016727781 - ], - "xyz": [ - 17.809305255291765, - 15.074883682835193, - 23.274045130903115 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7531411902944533, - 0.950593278229658, - 0.5471160231355674 - ], - "xyz": [ - 20.476411980591113, - 17.776882575716822, - 23.293150981457313 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7490103229641405, - 0.9492407908644471, - 0.7537182568607649 - ], - "xyz": [ - 23.282549567870504, - 20.545034652221734, - 23.218183543063958 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7530176612259042, - 0.9469233585277118, - 0.9494438397225868 - ], - "xyz": [ - 25.926790988382393, - 23.275747197897594, - 23.24128763268788 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9500401910698931, - 0.15324975050999298, - 0.14963670051009623 - ], - "xyz": [ - 4.141009038785476, - 15.034584519841129, - 15.083981489090718 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9513070603102417, - 0.14836534451803046, - 0.35288643873407916 - ], - "xyz": [ - 6.853024155301857, - 17.830698764104124, - 15.034523177779267 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9490600563424911, - 0.14684209675857657, - 0.5521109419003084 - ], - "xyz": [ - 9.555960132997315, - 20.52373967719587, - 14.982976974810239 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9476993726962639, - 0.15069228615118768, - 0.7532733999504118 - ], - "xyz": [ - 12.358856146557567, - 23.25539357252627, - 15.017013049263763 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9474365433951761, - 0.15346362818056195, - 0.9491714107308807 - ], - "xyz": [ - 15.075027777690238, - 25.930082559379702, - 15.051308983752605 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9497708058750544, - 0.34651020375925834, - 0.15209725737777458 - ], - "xyz": [ - 6.816871459322509, - 15.064541824541289, - 17.722520633138586 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9534946302922526, - 0.34820188008288894, - 0.35024146135795736 - ], - "xyz": [ - 9.54899164437779, - 17.824445172545172, - 17.796560384477065 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9537697666100635, - 0.34919800801010875, - 0.5485438579350097 - ], - "xyz": [ - 12.273765197665789, - 20.53936145832782, - 17.81394088040756 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9465817616371792, - 0.3504823500618465, - 0.7502364858693431 - ], - "xyz": [ - 15.048829795460755, - 23.19859365262462, - 17.73322706360897 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501821578933102, - 0.34817384553481706, - 0.9535183226496351 - ], - "xyz": [ - 17.796501018827556, - 26.027050303896647, - 17.750889574788737 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9513490843978996, - 0.548778400692607, - 0.1527593102648171 - ], - "xyz": [ - 9.591297307421929, - 15.09517123231762, - 20.509472953210086 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501687043729543, - 0.5535184062622165, - 0.34799109969146375 - ], - "xyz": [ - 12.325275693687642, - 17.74820717240399, - 20.55813951292414 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9471078680489319, - 0.5500451358332928, - 0.5532728974517132 - ], - "xyz": [ - 15.08436555382661, - 20.512935757387027, - 20.468806381537075 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9493283550266105, - 0.5467021247164308, - 0.751820321309978 - ], - "xyz": [ - 17.753165148032775, - 23.257798496112095, - 20.453459433560504 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9534994639902152, - 0.5485187407211006, - 0.9478113295575002 - ], - "xyz": [ - 20.45755538143638, - 25.994378933441524, - 20.53532253153626 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9521119658313587, - 0.7496880596999911, - 0.15165752137497412 - ], - "xyz": [ - 12.323034542252328, - 15.090537750577283, - 23.266703625060018 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9465104939933185, - 0.7525829934942604, - 0.3504405261369371 - ], - "xyz": [ - 15.080339016164196, - 17.73168089603723, - 23.229700324102428 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9529671013454483, - 0.7511346185405696, - 0.5485642057051453 - ], - "xyz": [ - 17.769248379299047, - 20.528665754360443, - 23.298171975972053 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9486730615821337, - 0.7536599260293332, - 0.7480020994229181 - ], - "xyz": [ - 20.530452912818596, - 23.196637399732086, - 23.273990186686202 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9534239786057933, - 0.7484350197482175, - 0.950366452986466 - ], - "xyz": [ - 23.2257079509635, - 26.02828009845168, - 23.26750989087633 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9531277531721646, - 0.9509745709075864, - 0.14771160984841702 - ], - "xyz": [ - 15.021039699783541, - 15.050477620132046, - 26.032544236400017 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9491817219786722, - 0.9523057164183215, - 0.35172281384681087 - ], - "xyz": [ - 17.82844334064944, - 17.785732650989555, - 25.996793990024784 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9527784596502775, - 0.946771426081161, - 0.5495127071021647 - ], - "xyz": [ - 20.456927337738453, - 20.539054419429373, - 25.970304118740795 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9531410707548578, - 0.9498292971186459, - 0.7469411727541052 - ], - "xyz": [ - 23.197940445415675, - 23.24321841845071, - 26.017068334900323 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9468342109715834, - 0.9524420124969712, - 0.9491346672791082 - ], - "xyz": [ - 25.998014082096194, - 25.921345229045368, - 25.966562657541854 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1040152474681861, - 0.09991324334989712, - 0.09694755609944797 - ], - "xyz": [ - 2.6914454151275446, - 2.7475272770720505, - 2.7880736193364863 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1008950239997988, - 0.0962722843457196, - 0.29947913030608975 - ], - "xyz": [ - 5.410642105864899, - 5.473843370322332, - 2.695635949584425 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09961410101153474, - 0.10296932719627913, - 0.5013456840680157 - ], - "xyz": [ - 8.26208605730341, - 8.216214008846299, - 2.7696841654401534 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0986109528062456, - 0.09682965798838027, - 0.7008940403574503 - ], - "xyz": [ - 10.906334813518493, - 10.93068835563528, - 2.6720288514741815 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10391659432929705, - 0.09932588523714607, - 0.899985563283689 - ], - "xyz": [ - 13.66240624811612, - 13.725169596496373, - 2.778694596986088 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09978826951275085, - 0.29935472017905085, - 0.09686577012787913 - ], - "xyz": [ - 5.417055223788091, - 2.6886186322395575, - 5.4570111093281675 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0987709012953903, - 0.2964765496916341, - 0.3030819175300064 - ], - "xyz": [ - 8.197055443330168, - 5.494059405473434, - 5.40375200535342 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10244764019562659, - 0.29944788969180364, - 0.5020624116140727 - ], - "xyz": [ - 10.958104567599705, - 8.264752616532883, - 5.494643343425566 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09889592857157355, - 0.3027218218465612, - 0.7020440850801476 - ], - "xyz": [ - 13.736978621638714, - 10.950307697443874, - 5.490845592521663 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09767592949062245, - 0.30246208048715845, - 0.8972160416523889 - ], - "xyz": [ - 16.401783343829905, - 13.601983948912444, - 5.470614847574424 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09592668759198528, - 0.4997107401099829, - 0.10228863401766797 - ], - "xyz": [ - 8.230427083185898, - 2.7099641982892892, - 8.143447696804321 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09833884894078719, - 0.5043155687528522, - 0.29948152094939623 - ], - "xyz": [ - 10.989369126932994, - 5.438928489472007, - 8.239382720912252 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09951982539030099, - 0.4966829785839231, - 0.5038699000388658 - ], - "xyz": [ - 13.679378857012615, - 8.24943571591699, - 8.151177419430875 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09881319401974765, - 0.4967691274418021, - 0.7006906786785394 - ], - "xyz": [ - 16.371454926512207, - 10.930673036833895, - 8.142694294204444 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09792027329975236, - 0.499584811405602, - 0.9042974301910088 - ], - "xyz": [ - 19.193625308305375, - 13.702140042939057, - 8.168981967176357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09758500488931714, - 0.6978161861286286, - 0.10071213569231714 - ], - "xyz": [ - 10.917335480838043, - 2.711082812546799, - 10.87458191138297 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10162856699882661, - 0.7024971786290166, - 0.300036602221311 - ], - "xyz": [ - 13.706461395705125, - 5.491493893847261, - 10.993862451589658 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10353794808401802, - 0.6996593644730051, - 0.500459267178974 - ], - "xyz": [ - 16.40780591059216, - 8.25774120757688, - 10.98116908176336 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10151319769218088, - 0.7034230603591285, - 0.6974219172058114 - ], - "xyz": [ - 19.152100381171895, - 10.922897082564667, - 11.00494363155105 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10423329799605155, - 0.6997616467193296, - 0.897643922660757 - ], - "xyz": [ - 21.839441411562053, - 13.697485022920167, - 10.992074165058641 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09952345087777585, - 0.896007943059443, - 0.10205158308154923 - ], - "xyz": [ - 13.645290190684937, - 2.7558975807857795, - 13.610726022258746 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10088078717762744, - 0.9018281443728686, - 0.295610113500875 - ], - "xyz": [ - 16.371160322763405, - 5.420752225714363, - 13.708856024550702 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09996642796349518, - 0.9041494660024343, - 0.4984544611348793 - ], - "xyz": [ - 19.176148423114466, - 8.181502679992937, - 13.728091761441272 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09634062834289148, - 0.9024487130595329, - 0.7023509763453196 - ], - "xyz": [ - 21.94053248959905, - 10.919567854808378, - 13.655268093572491 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10064949798484764, - 0.8986065381314515, - 0.903805222843193 - ], - "xyz": [ - 24.642249161928362, - 13.732724141311222, - 13.66164865969554 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3032564498520745, - 0.09667971203336588, - 0.09851801756742677 - ], - "xyz": [ - 2.6687082235107087, - 5.492988199155285, - 5.4678552167886005 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2994648605455274, - 0.09788152869974547, - 0.2983335219786266 - ], - "xyz": [ - 5.416980854165581, - 8.172991882161378, - 5.432448311411306 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29818007109098044, - 0.10089477990841252, - 0.49717062308360555 - ], - "xyz": [ - 8.176642537934331, - 10.873891527629986, - 5.45607952939052 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30415676859251023, - 0.09835138569223752, - 0.6975064597300267 - ], - "xyz": [ - 10.880825208201019, - 13.694559358244625, - 5.503019033913299 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29744573050273737, - 0.10361049353698644, - 0.8977259140315166 - ], - "xyz": [ - 13.69009112372321, - 16.3401715931763, - 5.483168504950776 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30410586259083977, - 0.29707410836838105, - 0.09963305681201577 - ], - "xyz": [ - 5.423708955056653, - 5.519845833070348, - 8.219224350559694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2962859908924034, - 0.3031441456825512, - 0.30137413395013224 - ], - "xyz": [ - 8.264865105847713, - 8.171101648024674, - 8.195300929828194 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29825868274924144, - 0.29675841715052237, - 0.5021309510400217 - ], - "xyz": [ - 10.922271641814843, - 10.942783003032723, - 8.134966686751588 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2962709565745671, - 0.3029496804619562, - 0.70167508567965 - ], - "xyz": [ - 13.735048970230132, - 13.643738659412048, - 8.192436689848678 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30051710711921215, - 0.30382531329879925, - 0.8987998412223706 - ], - "xyz": [ - 16.442074640085618, - 16.396845440675417, - 8.262460790319377 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3036886571401093, - 0.5009771693988381, - 0.09704717111620115 - ], - "xyz": [ - 8.176081139140322, - 5.478788111471189, - 11.00124634059171 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29770954208976624, - 0.49839161788016767, - 0.2996276702823021 - ], - "xyz": [ - 10.910376064285416, - 8.16668684685269, - 10.88415176090014 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30090443520611543, - 0.4980062097985869, - 0.49731759976751566 - ], - "xyz": [ - 13.60788796610203, - 10.913147982193188, - 10.922562534588188 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30271877203298136, - 0.4960596346188047, - 0.7017400143360308 - ], - "xyz": [ - 16.376101196573696, - 13.732779724655588, - 10.92075459563002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3003488265361497, - 0.4976356928145732, - 0.8979686696301947 - ], - "xyz": [ - 19.080451634559626, - 16.38318111043695, - 10.909900711349598 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30403785922515475, - 0.6969267711079766, - 0.09953017743346709 - ], - "xyz": [ - 10.88901603820788, - 5.517509554950078, - 13.685008252281111 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30061934590706374, - 0.697930163725723, - 0.303926404208651 - ], - "xyz": [ - 13.697202662616533, - 8.26524067734703, - 13.651989156787726 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29727017709509895, - 0.7001145600341554, - 0.49853908001994407 - ], - "xyz": [ - 16.387776809164436, - 10.880160917610587, - 13.636064596778482 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29958452769258187, - 0.7038221598451195, - 0.6966188112136935 - ], - "xyz": [ - 19.1465768769413, - 13.619912732925592, - 13.718395618811694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2998209006346492, - 0.6958830103087774, - 0.9020993638157893 - ], - "xyz": [ - 21.84732738220373, - 16.432437509918792, - 13.613084643714558 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29702240648497946, - 0.89805557376043, - 0.10331383317104803 - ], - "xyz": [ - 13.690542285073917, - 5.473325008054069, - 16.33889103187879 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2966895816078206, - 0.8983296659837103, - 0.30231462356505945 - ], - "xyz": [ - 16.41499261073866, - 8.189477672366685, - 16.338088049606842 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30172469018481757, - 0.8984149909159633, - 0.4967116158752733 - ], - "xyz": [ - 19.073919845260562, - 10.91607745791847, - 16.408093694867276 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29570797097483703, - 0.9005829589913034, - 0.7013185050185047 - ], - "xyz": [ - 21.900908473678573, - 13.631166515015288, - 16.355474262129675 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30036502074500804, - 0.9036495374248407, - 0.8964591126362612 - ], - "xyz": [ - 24.61076144407837, - 16.362764123244702, - 16.4610703166777 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5027227565519662, - 0.09600026646394938, - 0.10163548503296466 - ], - "xyz": [ - 2.702040420030539, - 8.262677094465689, - 8.185633400529454 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5030270805884065, - 0.09844255771497702, - 0.29666269653677313 - ], - "xyz": [ - 5.401807917184162, - 10.933214688695571, - 8.223184630348964 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500368840092353, - 0.10373805574634422, - 0.4993015816787393 - ], - "xyz": [ - 8.244649375741004, - 13.667314065778454, - 8.259240740665417 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49710235466021546, - 0.09781759696407154, - 0.7022644033988672 - ], - "xyz": [ - 10.938577094202032, - 16.397526430167325, - 8.133638493015958 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5032853178404774, - 0.09959550358500481, - 0.9009162940003472 - ], - "xyz": [ - 13.678817204463366, - 19.19799168079762, - 8.242478071981335 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5002869744407705, - 0.2971945387159723, - 0.0985124038213624 - ], - "xyz": [ - 5.4100340911207825, - 8.186677315711794, - 10.90302370120662 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5005046825000177, - 0.30150772715953394, - 0.2957027642540449 - ], - "xyz": [ - 8.164954340717994, - 10.885604894681126, - 10.96496930263165 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5020552024196804, - 0.3007051682393409, - 0.5015933368745109 - ], - "xyz": [ - 10.968880748185661, - 13.72170217249311, - 10.97519529078342 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5004200787129676, - 0.2972609886447434, - 0.7039743586180004 - ], - "xyz": [ - 13.688709445413725, - 16.46626395619027, - 10.905751970322498 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4961379379025546, - 0.299607375962757, - 0.9011041723622941 - ], - "xyz": [ - 16.4159121606214, - 19.102842627961163, - 10.879286697010043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5038957866757816, - 0.4973422473191169, - 0.10064736440099388 - ], - "xyz": [ - 8.175606333307243, - 8.26520514375448, - 13.688746177932133 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49714275679276526, - 0.5001208106651286, - 0.2986950023417165 - ], - "xyz": [ - 10.921266008583244, - 10.880550592089989, - 13.63440798684218 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000975699189151, - 0.49984218710122774, - 0.5036480194643358 - ], - "xyz": [ - 13.7195374759272, - 13.723029023841715, - 13.670996368823127 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5025858948349662, - 0.4957543142850661, - 0.7010793535975339 - ], - "xyz": [ - 16.362894477230686, - 16.456294616824422, - 13.64912763785144 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49970647664367784, - 0.49843359371357887, - 0.8976174765450136 - ], - "xyz": [ - 19.086558943382826, - 19.103961569684213, - 13.646391376711748 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4999117769218838, - 0.7037439986634212, - 0.0998314726333216 - ], - "xyz": [ - 10.986339199984231, - 8.199581754133847, - 16.456165105762683 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4985515289166625, - 0.6978410608301202, - 0.2992592189575729 - ], - "xyz": [ - 13.632175547206977, - 10.907524939001927, - 16.356864136351856 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49700215498320716, - 0.6990134379744578, - 0.5040313800461881 - ], - "xyz": [ - 16.447812203911024, - 13.685950304885585, - 16.35170990411046 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4974623823130258, - 0.7012337466326312, - 0.6977021103821083 - ], - "xyz": [ - 19.125999228651253, - 16.340073814519187, - 16.38835770964181 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49662797004197656, - 0.7008070519865403, - 0.9036173482931693 - ], - "xyz": [ - 21.935401604232137, - 19.143901948120813, - 16.371116082869914 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.503357810768379, - 0.8983890155090339, - 0.09680078101097635 - ], - "xyz": [ - 13.606055763858205, - 8.205260238260825, - 19.16443029443606 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4999644106588901, - 0.9041243777388333, - 0.2986051276638908 - ], - "xyz": [ - 16.443501306555067, - 10.917898985432162, - 19.19644917899176 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49759060543290035, - 0.9030074960152868, - 0.5020658524220998 - ], - "xyz": [ - 19.20990990663323, - 13.667123153631147, - 19.14872513534135 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49923474096555803, - 0.8967447970272487, - 0.7001460172610772 - ], - "xyz": [ - 21.832403772603417, - 16.397717837938075, - 19.085580967120812 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4979946330841707, - 0.8974768242917979, - 0.903933530076325 - ], - "xyz": [ - 24.62855811105719, - 19.166909499660928, - 19.078634580381912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6982251593124322, - 0.10081393169535666, - 0.09716832575477949 - ], - "xyz": [ - 2.7067777870519203, - 10.874476557011604, - 10.924318625222107 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6973338629776701, - 0.10310948894714488, - 0.30193924077777173 - ], - "xyz": [ - 5.537753324027709, - 13.661882005385722, - 10.943517427712722 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6958031537952485, - 0.1026776239760251, - 0.500387183536575 - ], - "xyz": [ - 8.244993496646915, - 16.35409897773997, - 10.916685467148852 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.696208722335985, - 0.10071157467181183, - 0.6997243349283545 - ], - "xyz": [ - 10.943415677589744, - 19.08494549096774, - 10.895350855037135 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.699409760089643, - 0.09872289340636886, - 0.8975801873769238 - ], - "xyz": [ - 13.621276385914635, - 21.833759103572355, - 10.911925974719844 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6986840611606248, - 0.3012501609727022, - 0.0966477855328236 - ], - "xyz": [ - 5.439989102993177, - 10.87363384826042, - 13.670920696846862 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6980777483842929, - 0.29697341340522615, - 0.30322068762539023 - ], - "xyz": [ - 8.2057457143524, - 13.689571983405905, - 13.604160374777182 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7005514563681003, - 0.2995128936901077, - 0.503550503003234 - ], - "xyz": [ - 10.979338208179962, - 16.462265250172194, - 13.672699782412808 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7008063414319963, - 0.29793233915736095, - 0.6974295864695241 - ], - "xyz": [ - 13.608409082024158, - 19.116429923802563, - 13.654575468055185 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7010494486942255, - 0.2955956141021956, - 0.9014690802668506 - ], - "xyz": [ - 16.36605302976861, - 21.909344874620615, - 13.625951902441363 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6975238974325466, - 0.5016518343734253, - 0.10332891838499503 - ], - "xyz": [ - 8.271187955177625, - 10.949115544350581, - 16.39491475361952 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998041489221711, - 0.49593646735662905, - 0.3015852743350718 - ], - "xyz": [ - 10.903573698495428, - 13.690815944676837, - 16.347950472452823 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7027628807791872, - 0.4960640904939083, - 0.5016823516866051 - ], - "xyz": [ - 13.641009763132386, - 16.466958418130467, - 16.39014656239093 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7030796792981892, - 0.5014975391540225, - 0.6962950401044471 - ], - "xyz": [ - 16.376004540957528, - 19.131999276223347, - 16.468762906779315 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6984349316686228, - 0.5042249714361208, - 0.8975798085351279 - ], - "xyz": [ - 19.165222626906516, - 21.82042624541244, - 16.442549716465493 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6962215968026306, - 0.6993786981880139, - 0.10123197798628655 - ], - "xyz": [ - 10.945805054733324, - 10.902641732870613, - 19.08039602505899 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.701019578965871, - 0.6978084445008547, - 0.29744868132882485 - ], - "xyz": [ - 13.606976278060728, - 13.650878330462227, - 19.124524947792846 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7009425478220827, - 0.6962698273642075, - 0.5033337351597131 - ], - "xyz": [ - 16.400763978185786, - 16.464648571196175, - 19.102436095319423 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7030088704249544, - 0.6989280641138672, - 0.6963729235610364 - ], - "xyz": [ - 19.0763039493135, - 19.132095998653547, - 19.16702942036655 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6974795524824858, - 0.6985095717863462, - 0.8998148880600775 - ], - "xyz": [ - 21.85200431661753, - 21.837922078098625, - 19.0857120289611 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6977787493357736, - 0.8994033594220304, - 0.09849738067284299 - ], - "xyz": [ - 13.64311929644389, - 10.886543919774402, - 21.836386298157116 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998695706393941, - 0.9034491232827682, - 0.30043758925665504 - ], - "xyz": [ - 16.459322434230735, - 13.676019434810001, - 21.920284585938894 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.702427208536618, - 0.8974061985922711, - 0.49747738130843366 - ], - "xyz": [ - 19.07059722535805, - 16.40487956953537, - 21.872634372252886 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7022147298706957, - 0.9022002248779301, - 0.699625918421066 - ], - "xyz": [ - 21.89987870247808, - 19.165713012128272, - 21.935272466631353 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7012173767072718, - 0.8970688622735333, - 0.903565436220716 - ], - "xyz": [ - 24.617948014839644, - 21.94030175744512, - 21.85148176782255 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9033412810988126, - 0.10088266053662556, - 0.09952365145543149 - ], - "xyz": [ - 2.7399190244192453, - 13.710988842193764, - 13.729568969730215 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9015938240747485, - 0.10331402073871133, - 0.29811534550931984 - ], - "xyz": [ - 5.4882700380571565, - 16.402207818902856, - 13.738919170877555 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9031833452855906, - 0.09766978282951692, - 0.5018413752996103 - ], - "xyz": [ - 8.196408641932964, - 19.20924507539116, - 13.683483814026689 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9013771198105565, - 0.1017080340975919, - 0.701342010030678 - ], - "xyz": [ - 10.979155654313761, - 21.912087453745983, - 13.7139996689045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8986154459180208, - 0.09772180295822883, - 0.9043213119315962 - ], - "xyz": [ - 13.699753099013005, - 24.649426824703546, - 13.621743525931286 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8962077110172882, - 0.29932744196670524, - 0.10307307546931876 - ], - "xyz": [ - 5.501547442292181, - 13.661987042303322, - 16.34514141526962 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9038807062520899, - 0.2975936403088527, - 0.2978004119278613 - ], - "xyz": [ - 8.14012031125095, - 16.42916794515502, - 16.426341000798825 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8955898452560196, - 0.3018886874908803, - 0.5011629914745496 - ], - "xyz": [ - 10.979178005513143, - 19.09615336826973, - 16.37171095357972 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8962460158594916, - 0.3026930449941042, - 0.6990630012241059 - ], - "xyz": [ - 13.695828347807048, - 21.81077772594387, - 16.391679030959406 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9008517948640539, - 0.2964921018998, - 0.9035253528198315 - ], - "xyz": [ - 16.40642263778495, - 24.669119575247493, - 16.36987023465399 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9041255741086877, - 0.5000437094848238, - 0.09741492048087211 - ], - "xyz": [ - 8.168346846337599, - 13.692881364739433, - 19.19754969481944 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8983981670268127, - 0.49673474325291983, - 0.3031893752789237 - ], - "xyz": [ - 10.936418562226027, - 16.42788859264641, - 19.07400602542065 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9039764655188915, - 0.4998966669335292, - 0.49686112814037353 - ], - "xyz": [ - 13.627493157847283, - 19.151999429742613, - 19.193500769725652 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9008023167059982, - 0.5026981744595482, - 0.6957835798285238 - ], - "xyz": [ - 16.385426817910748, - 21.828234991958606, - 19.18840608512694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8985145199960671, - 0.49658898436479176, - 0.9028870516692921 - ], - "xyz": [ - 19.133384458971506, - 24.62843803552589, - 19.073603992990876 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9016670800618612, - 0.6956020887395854, - 0.10093814986802109 - ], - "xyz": [ - 10.890154765000245, - 13.707438234659962, - 21.83757656740299 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8984443307540262, - 0.704433094405125, - 0.29859585860760607 - ], - "xyz": [ - 13.713231300378517, - 16.36571800171815, - 21.914251638839385 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9037421099358218, - 0.6967842952586913, - 0.4988062287740579 - ], - "xyz": [ - 16.34589843828142, - 19.175388428140508, - 21.882108917066446 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9042328916122687, - 0.6976990249438763, - 0.6982801841376408 - ], - "xyz": [ - 19.085576470304865, - 21.909270319299125, - 21.901324815410632 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9036503889578704, - 0.7007052113132844, - 0.8966167286881437 - ], - "xyz": [ - 21.838298045750324, - 24.612927984375126, - 21.93446098289918 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8983954856920937, - 0.903278471668299, - 0.10155996746526927 - ], - "xyz": [ - 13.737970268915099, - 13.671210963585896, - 24.63216204371896 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8997727390166803, - 0.9040695040057791, - 0.29913260634391947 - ], - "xyz": [ - 16.449962676321213, - 16.391218078807952, - 24.66180645499932 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8960096280099051, - 0.9003541062695786, - 0.503151350181301 - ], - "xyz": [ - 19.18847396961426, - 19.129077044854093, - 24.559561629596928 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8964735099279326, - 0.8986598673689581, - 0.7021682500846164 - ], - "xyz": [ - 21.886233872764127, - 21.856342387374763, - 24.542740410395172 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8970092779871969, - 0.8988143166996598, - 0.9001983392754713 - ], - "xyz": [ - 24.595777210213914, - 24.57109904584409, - 24.552176938311657 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.149335205071795, - 0.14748642211699964, - 0.15427279945342323 - ], - "xyz": [ - 4.125597760650939, - 4.150873988427969, - 4.058091859032306 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14944411923168657, - 0.15142958854966837, - 0.34613676307313695 - ], - "xyz": [ - 6.8026375974437014, - 6.7754926183127315, - 4.113491175519283 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1471288167498143, - 0.15278517278620532, - 0.5523024334018733 - ], - "xyz": [ - 9.639830836034298, - 9.562498154448845, - 4.100370080418343 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15416951237862186, - 0.14925997233498622, - 0.7493810344895347 - ], - "xyz": [ - 12.286058089923621, - 12.353180437683, - 4.148433297697201 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1518275405330826, - 0.1531867812281788, - 0.9477643354874693 - ], - "xyz": [ - 15.05200549653533, - 15.0334222024153, - 4.170100904542048 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1521335016669191, - 0.3457337569613273, - 0.1518369740234246 - ], - "xyz": [ - 6.80269747129195, - 4.1558296289527545, - 6.806751543858831 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15160250546078674, - 0.348972097947162, - 0.3463641971391981 - ], - "xyz": [ - 9.506512665887598, - 6.808111123940524, - 6.843765874364861 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1514416091171594, - 0.3489931718024973, - 0.5531758494244735 - ], - "xyz": [ - 12.334292467791322, - 9.633403062038667, - 6.8418542464729795 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14788642390049514, - 0.3484049125180937, - 0.7543368718338339 - ], - "xyz": [ - 15.076487182138369, - 12.335034499086513, - 6.78520581907439 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15207936375052578, - 0.3525035601810488, - 0.9493087642442241 - ], - "xyz": [ - 17.798143773323932, - 15.057980236081178, - 6.898566911066179 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15279639143974855, - 0.5461872540061921, - 0.14921564380986763 - ], - "xyz": [ - 9.50742324641956, - 4.1290541837664065, - 9.556378583480718 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14593749108417287, - 0.5526764943406327, - 0.34980236368129164 - ], - "xyz": [ - 12.338528500681305, - 6.7776660611795725, - 9.551324658210564 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1508858818665546, - 0.5537822684108694, - 0.5480039014841396 - ], - "xyz": [ - 15.063422193293981, - 9.555095317809688, - 9.63409611032589 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1541996446812861, - 0.5492399191314493, - 0.7472592937751554 - ], - "xyz": [ - 17.725503869000775, - 12.324584343967546, - 9.617299097326232 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14604059471046332, - 0.5501383137713279, - 0.950642038807324 - ], - "xyz": [ - 20.518398839991864, - 14.993647562581154, - 9.518032724559522 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14964694583083932, - 0.7460659012159222, - 0.15130007478623314 - ], - "xyz": [ - 12.268626098025786, - 4.114493495412903, - 12.246024816510854 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15419713713285982, - 0.7473572275277786, - 0.3496735835256205 - ], - "xyz": [ - 14.99840778317608, - 6.888829796113024, - 12.325888993854608 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14559044635962373, - 0.7510950165685935, - 0.5514593944321249 - ], - "xyz": [ - 17.80828944740784, - 9.529939954333443, - 12.259322245771257 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15389159298742539, - 0.7467377949708446, - 0.7493461388925855 - ], - "xyz": [ - 20.45419024867272, - 12.34890368747177, - 12.313242878875633 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1489999607158345, - 0.7544050783824171, - 0.9482178840959787 - ], - "xyz": [ - 23.27795467087138, - 15.000964875055043, - 12.351191081644256 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15041387981423224, - 0.9465207571408741, - 0.14938326785321773 - ], - "xyz": [ - 14.983002566994724, - 4.098772639422795, - 14.99709290821556 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14843034034078176, - 0.9508426128443969, - 0.3537381703910264 - ], - "xyz": [ - 17.835993643853723, - 6.865557488393349, - 15.029061946816187 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14812929916580045, - 0.9535983310406698, - 0.54710213106754 - ], - "xyz": [ - 20.51730659186026, - 9.505078972492788, - 15.062621849209423 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1519128374989189, - 0.9511177711030044, - 0.7513755396181944 - ], - "xyz": [ - 23.276182095384296, - 12.34959610003729, - 15.080435935295945 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15215544308542556, - 0.9457424564198731, - 0.9518360933795241 - ], - "xyz": [ - 25.943352368718394, - 15.093573568072227, - 15.01026246041453 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34701477115143725, - 0.1525867874238457, - 0.14790442522300426 - ], - "xyz": [ - 4.108261770889456, - 6.766446167376016, - 6.830462580560725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3530383004973044, - 0.1519899474706347, - 0.3479228035005739 - ], - "xyz": [ - 6.834717146983189, - 9.583414040860271, - 6.904655301133029 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35282583653280614, - 0.1522541834833419, - 0.5471102658535685 - ], - "xyz": [ - 9.561584865733357, - 12.303764403328083, - 6.9053631192571725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34800178917804425, - 0.14904726927018416, - 0.7485634233379705 - ], - "xyz": [ - 12.27197181941402, - 14.9920422037807, - 6.795565258273657 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34940046394756674, - 0.15286654196485996, - 0.9516113510195829 - ], - "xyz": [ - 15.100222946862564, - 17.787199352104174, - 6.8669040967736334 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35011042738139936, - 0.3466830169622794, - 0.1538459370362453 - ], - "xyz": [ - 6.843141763856109, - 6.890000702172442, - 9.526434548246792 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35014878173074027, - 0.35383390226332423, - 0.3466739703150737 - ], - "xyz": [ - 9.577217542474791, - 9.526835237875, - 9.62472453868373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3536667260698971, - 0.34643064898370807, - 0.5498401297066684 - ], - "xyz": [ - 12.253652757514661, - 12.352583100943162, - 9.571605294205378 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35220908252811167, - 0.3476873451994648, - 0.7472250539712738 - ], - "xyz": [ - 14.969445237230486, - 15.031265616075027, - 9.568857978534433 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3473764098557341, - 0.3481759124876247, - 0.953972148318694 - ], - "xyz": [ - 17.802733900693042, - 17.791803244620308, - 9.509466151660378 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3542241133098808, - 0.5497362911161294, - 0.14754045778453215 - ], - "xyz": [ - 9.533042201155041, - 6.860034898380016, - 12.358783936439615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.348597824158684, - 0.5518160044840643, - 0.34656314647904696 - ], - "xyz": [ - 12.282478043720483, - 9.504115661584342, - 12.310295790714498 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3518599263278732, - 0.5528169700248368, - 0.5490549801680366 - ], - "xyz": [ - 15.064594966085927, - 12.317146436928908, - 12.368579685092906 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3524015374442538, - 0.5503709282734759, - 0.7514831188062888 - ], - "xyz": [ - 17.79871419794607, - 15.092112321019291, - 12.34254265224897 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3500997965356049, - 0.5458611122930425, - 0.9513423708038545 - ], - "xyz": [ - 20.469496524273815, - 17.793083052274966, - 12.249416272541676 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3508279187223036, - 0.7536528000685239, - 0.14879593031365895 - ], - "xyz": [ - 12.338116601013734, - 6.830767331726853, - 15.10026158077881 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34751703548519125, - 0.7474678094782484, - 0.3532361443560606 - ], - "xyz": [ - 15.04862633011098, - 9.580571339217222, - 14.970435703068052 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34882332908921343, - 0.7511191311838633, - 0.5465954080659104 - ], - "xyz": [ - 17.74211959200584, - 12.242003799012165, - 15.038215327210654 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3486056191585546, - 0.7519312183906354, - 0.7529250598330068 - ], - "xyz": [ - 20.574124161743555, - 15.059929167650408, - 15.046341546341765 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35296331165121436, - 0.7487895986609536, - 0.9464372857080728 - ], - "xyz": [ - 23.176836822254142, - 17.765171074988647, - 15.062967474264104 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3462867644111698, - 0.9489710324982675, - 0.15212263305533075 - ], - "xyz": [ - 15.053954398588994, - 6.81416356847045, - 17.70853145294238 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35387448977566716, - 0.948850842014008, - 0.35039356004939937 - ], - "xyz": [ - 17.763035601018533, - 9.62862600895934, - 17.810626245668715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3492643075275814, - 0.953416075304769, - 0.550941427630581 - ], - "xyz": [ - 20.567304995781573, - 12.307450774050066, - 17.810011711614983 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.352591125276383, - 0.94611774544035, - 0.7493048049991253 - ], - "xyz": [ - 23.179511933549424, - 15.064922817459298, - 17.75571391284244 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3509159476758962, - 0.9505670039848227, - 0.9457977016924651 - ], - "xyz": [ - 25.926756910372855, - 17.728435605707347, - 17.793640648174048 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5516269629751043, - 0.15182169287676764, - 0.15094984707421782 - ], - "xyz": [ - 4.139437995332682, - 9.605503683168521, - 9.617423402048738 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5542284847351622, - 0.14838643995163778, - 0.34976772047148746 - ], - "xyz": [ - 6.810674013556092, - 12.359273398268376, - 9.606024779631484 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.548039082571484, - 0.1541360804160298, - 0.5477089681469851 - ], - "xyz": [ - 9.595499171844798, - 14.98087011477378, - 9.60001243683595 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5478136751633819, - 0.14864455602345433, - 0.7491896731514609 - ], - "xyz": [ - 12.275027971118188, - 17.732396317557832, - 9.52185157430481 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5535918588856328, - 0.14675814808609158, - 0.948654034433474 - ], - "xyz": [ - 14.976278185214644, - 20.538435449198026, - 9.575059232316159 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5493332794083244, - 0.35079484539711836, - 0.1534806595454205 - ], - "xyz": [ - 6.894363933983501, - 9.608745666866588, - 12.306389699277547 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.552942667561028, - 0.35063400743795137, - 0.3458924976632707 - ], - "xyz": [ - 9.522785002972988, - 12.28871258861687, - 12.353537656784544 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5485487010863159, - 0.3540275167155346, - 0.550223347747939 - ], - "xyz": [ - 12.362755053789007, - 15.022213672693143, - 12.339859586067695 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5486462616697811, - 0.34647155525675316, - 0.7525254282445639 - ], - "xyz": [ - 15.025288938972976, - 17.78938513360474, - 12.23788967181253 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5478645564532548, - 0.35437447865028965, - 0.9488037061035045 - ], - "xyz": [ - 17.816817569880616, - 20.46217908538875, - 12.33524968490934 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5511401738224393, - 0.5461719304779707, - 0.14952074919659752 - ], - "xyz": [ - 9.511385091828355, - 9.579310020550126, - 15.00225357381643 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5497366357184468, - 0.5462600396961339, - 0.35056210624527034 - ], - "xyz": [ - 12.261190951324608, - 12.308722346354385, - 14.984269266866571 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5480535269804458, - 0.5542869718931496, - 0.5480208135453549 - ], - "xyz": [ - 15.070553627113853, - 14.985331090287453, - 15.071000879309997 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5540472033152757, - 0.5503473515981245, - 0.7479730848975688 - ], - "xyz": [ - 17.750403310090547, - 17.800987016794128, - 15.099083563756121 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5519606784705715, - 0.5522167415249831, - 0.950000666578103 - ], - "xyz": [ - 20.53804600445193, - 20.534545156463366, - 15.096114934243621 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5528826580452257, - 0.7507101257124306, - 0.15054311313474297 - ], - "xyz": [ - 12.321772055935563, - 9.617110526933718, - 17.822485892833598 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5467286796561094, - 0.7482685299615707, - 0.3525251630665118 - ], - "xyz": [ - 15.049853228215197, - 12.294436672011985, - 17.70496875039519 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5521165350724274, - 0.7526615974129617, - 0.5488828446011507 - ], - "xyz": [ - 17.79448133321738, - 15.052665339008817, - 17.83869176727639 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5498651323705398, - 0.7520808085106108, - 0.752187196851126 - ], - "xyz": [ - 20.566081401064697, - 17.801425075699353, - 17.79997055345773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5458917726790493, - 0.7501181465045148, - 0.9528204942642471 - ], - "xyz": [ - 23.28227056763517, - 20.490124345440694, - 17.718814333292233 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5506412826743494, - 0.9538066109512277, - 0.1469330817582194 - ], - "xyz": [ - 15.049114945578872, - 9.537111147136482, - 20.568540801028036 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5499339560745926, - 0.9525175173318778, - 0.3458701718151532 - ], - "xyz": [ - 17.751322776234158, - 12.247272791765583, - 20.541246103148048 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5507726836356777, - 0.9503532640407849, - 0.552962568414134 - ], - "xyz": [ - 20.55306346447381, - 15.090069693679656, - 20.52312375396201 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5462309735746971, - 0.9497786925268554, - 0.7534091491648112 - ], - "xyz": [ - 23.28567759779696, - 17.76844582287246, - 20.453174873200524 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5471982083490687, - 0.9526775203138256, - 0.9476969995470945 - ], - "xyz": [ - 25.98157836812492, - 20.43793820121892, - 20.50603098464793 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7473216123755092, - 0.15420841563374346, - 0.14895250090998444 - ], - "xyz": [ - 4.144761482020869, - 12.253698347498876, - 12.32555626753746 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.746475157110207, - 0.15329706187943123, - 0.3489110741463838 - ], - "xyz": [ - 6.866099238280458, - 14.975923384218481, - 12.301523819026913 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7542379442660194, - 0.14791933531728238, - 0.5480273953905889 - ], - "xyz": [ - 9.514858431826488, - 17.80433731602401, - 12.334131938152577 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7486615659052223, - 0.15434776564694982, - 0.7477910257785093 - ], - "xyz": [ - 12.33387917138642, - 20.459230472033475, - 12.345781039301617 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7537157903167417, - 0.15089989749777863, - 0.9470046203737431 - ], - "xyz": [ - 15.010352945526227, - 23.251943325286383, - 12.367742852976315 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.754276879070534, - 0.34946506590055126, - 0.14756525195769385 - ], - "xyz": [ - 6.795309040300712, - 12.329823283834344, - 15.090161198094581 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7526911323587371, - 0.3462679667432756, - 0.3520208850483003 - ], - "xyz": [ - 9.546879489701102, - 15.103423853825879, - 15.024770990284877 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.747569745286043, - 0.3540692500181353, - 0.5480835692536695 - ], - "xyz": [ - 12.334070957576644, - 17.71393889879033, - 15.06141004877957 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.746040161071163, - 0.35319933364413625, - 0.7504486875091332 - ], - "xyz": [ - 15.088877088563692, - 20.45972616979706, - 15.028604508638521 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7497148334864705, - 0.3474236837414703, - 0.9542057948704733 - ], - "xyz": [ - 17.795643938276342, - 23.295696125183028, - 14.999880322607305 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7518841101379476, - 0.5462583272074281, - 0.14906607427730054 - ], - "xyz": [ - 9.506350058706941, - 12.317628750292076, - 17.74796973774725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7476115572291387, - 0.5498572253756031, - 0.34832570761929643 - ], - "xyz": [ - 12.279795386978325, - 14.98345701630013, - 17.73875965139116 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7543617811752072, - 0.5492243042050611, - 0.548487820044028 - ], - "xyz": [ - 15.00772257455118, - 17.812325234941163, - 17.822394313823658 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7509932985031089, - 0.5456949688081382, - 0.7524339694014287 - ], - "xyz": [ - 17.74778517999232, - 20.554586989882612, - 17.72808858679125 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7465842749583208, - 0.5502318067777837, - 0.9494211262023237 - ], - "xyz": [ - 20.50298496217609, - 23.18748056369612, - 17.729836042601306 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7516687101320599, - 0.7468512776012132, - 0.1482479842122569 - ], - "xyz": [ - 12.237635989646636, - 12.303499060070516, - 20.487495538691515 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7498922450431189, - 0.7497124393259543, - 0.3465891836629424 - ], - "xyz": [ - 14.988438455212055, - 14.990896726612101, - 20.502325315850783 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7510536926889484, - 0.7468008944910322, - 0.5535795638541461 - ], - "xyz": [ - 17.77856755801277, - 17.836711049471006, - 20.478398302099 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7540408528979412, - 0.7489626036442631, - 0.747032060289048 - ], - "xyz": [ - 20.45296976625672, - 20.52239867596814, - 20.548792717222838 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7532985503383797, - 0.7461663635508877, - 0.9497704265785184 - ], - "xyz": [ - 23.186542526027015, - 23.284052499991983, - 20.50041439900956 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7456337943866381, - 0.9508886848033639, - 0.1521353226857173 - ], - "xyz": [ - 15.080345686069368, - 12.27413777017217, - 23.19454996143945 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7498959828876932, - 0.9507388312948187, - 0.34611493084866696 - ], - "xyz": [ - 17.73035120234855, - 14.984463930639041, - 23.250773065236746 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.74990572902342, - 0.9500668706560779, - 0.5536331529382545 - ], - "xyz": [ - 20.558316056577464, - 17.82174895718126, - 23.241719387750152 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7542696120841811, - 0.9478221241265682, - 0.749680148443233 - ], - "xyz": [ - 23.207945520165257, - 20.56173041497391, - 23.270691840960843 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7465808686111421, - 0.9528275609008445, - 0.9520782095750017 - ], - "xyz": [ - 26.04352881090708, - 23.223761158326884, - 23.23400615477057 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499154295698773, - 0.14605268331733445, - 0.15089833608531827 - ], - "xyz": [ - 4.0598608860895755, - 15.050127657560015, - 14.983878765133637 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9489718774913591, - 0.1544083037337551, - 0.3482336838808001 - ], - "xyz": [ - 6.872030779108427, - 17.73516093807911, - 15.08521522927714 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9483216570871669, - 0.14670664742449824, - 0.5527962722767504 - ], - "xyz": [ - 9.563478007629925, - 20.523014129036188, - 14.971029874188671 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9520443853484948, - 0.15288379156164522, - 0.7484234310832705 - ], - "xyz": [ - 12.32251011270121, - 23.248489902048135, - 15.106379147643588 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.950548667765421, - 0.14975578111856583, - 0.9462555904865979 - ], - "xyz": [ - 14.984470190538907, - 25.932766394055115, - 15.043164370341067 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9514761258711242, - 0.3487650877439671, - 0.14652666571745074 - ], - "xyz": [ - 6.77153970080888, - 15.01169652609651, - 17.776663829127077 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9496183562278747, - 0.345975280130307, - 0.35248828587609726 - ], - "xyz": [ - 9.549268150997676, - 17.802167631649926, - 17.713122989434513 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9477193392444074, - 0.347596005522858, - 0.5538019526815505 - ], - "xyz": [ - 12.323750632938195, - 20.528528829379148, - 17.709318236895992 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9541083866787324, - 0.34829757675717543, - 0.7474660045917173 - ], - "xyz": [ - 14.981082446757418, - 23.263618794059155, - 17.80625989902231 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9522567701934614, - 0.35265793845448734, - 0.9465477130567502 - ], - "xyz": [ - 17.762505810444367, - 25.960113110189905, - 17.840559011987196 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.953005569044688, - 0.5518797237019308, - 0.1466314049707774 - ], - "xyz": [ - 9.549918419210105, - 15.034038774084118, - 20.574520843079075 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9518046309140341, - 0.5528536699140093, - 0.34907879186081825 - ], - "xyz": [ - 12.331058269542321, - 17.785443997161682, - 20.571417450426857 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9508642527386807, - 0.5456201898868674, - 0.5519873104550689 - ], - "xyz": [ - 15.00629217532489, - 20.546716058703566, - 20.45966593237682 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9504682891784403, - 0.5496586267937962, - 0.7535331186265984 - ], - "xyz": [ - 17.817002968873457, - 23.296800527257084, - 20.50946517232754 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.952512773915383, - 0.5478139935444329, - 0.9470917514778996 - ], - "xyz": [ - 20.438082262911223, - 25.971051142362384, - 20.51219750589246 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9515844975752904, - 0.7496062214524566, - 0.1527839903424393 - ], - "xyz": [ - 12.337316545421693, - 15.098727180483374, - 23.25837329621793 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9455744120809122, - 0.7512518032524224, - 0.3516994013270027 - ], - "xyz": [ - 15.079350337793073, - 17.7360940676266, - 23.19870258731859 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9520982004096346, - 0.7456472322744595, - 0.5507247652159096 - ], - "xyz": [ - 17.723764602728778, - 20.546325077898626, - 23.21126996147905 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9518407356706001, - 0.7497547454430687, - 0.7524804733864655 - ], - "xyz": [ - 20.538289509498, - 23.30117279241057, - 23.263907130599478 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9462925238128485, - 0.7516738992585088, - 0.9529660928205673 - ], - "xyz": [ - 23.305531136506552, - 25.966321940061064, - 23.21429130227544 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9527660785023653, - 0.9466778288724852, - 0.14835815306954908 - ], - "xyz": [ - 14.971134838634741, - 15.054372291689528, - 25.968855201725624 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9529276651396389, - 0.9478848213559323, - 0.35212746351266716 - ], - "xyz": [ - 17.773533956512214, - 17.84247880901117, - 25.987566169119876 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9463036774112366, - 0.9494318016988781, - 0.5508800839966917 - ], - "xyz": [ - 20.511994045090404, - 20.46922689289214, - 25.918154238007244 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9523564594731629, - 0.9516355365776811, - 0.7502421612109014 - ], - "xyz": [ - 23.267765546179895, - 23.277621874240804, - 26.031035851447847 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9515283256053815, - 0.9485585459609799, - 0.9466552562428756 - ], - "xyz": [ - 25.91102196524671, - 25.951624257984633, - 25.977645692418406 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09644473739409348, - 0.09846995486019842, - 0.10432147146413172 - ], - "xyz": [ - 2.772527878249503, - 2.74483946959206, - 2.6648385878560727 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10059746903330645, - 0.09710920647383185, - 0.29776316060348246 - ], - "xyz": [ - 5.398623925654967, - 5.446314823480843, - 2.703010080332003 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09913999967319698, - 0.10369811955824458, - 0.5013913089181229 - ], - "xyz": [ - 8.27267375003177, - 8.210355955424978, - 2.773166255270807 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10310441527954024, - 0.10273146301151491, - 0.6973191997188785 - ], - "xyz": [ - 10.938148651730646, - 10.94324758800768, - 2.8141510775372134 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10455056139327308, - 0.0993808202429239, - 0.8996806108639926 - ], - "xyz": [ - 13.658988055036163, - 13.72966782549033, - 2.7881131420813903 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10391985285041724, - 0.29892552054555643, - 0.0959627708507474 - ], - "xyz": [ - 5.398841640077814, - 2.7327592523700566, - 5.50762943290254 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10354296633885918, - 0.29568763691892186, - 0.29920266192659106 - ], - "xyz": [ - 8.13323308556206, - 5.506265735432147, - 5.458208946231795 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09961643970440898, - 0.29712589661251365, - 0.49842526221619804 - ], - "xyz": [ - 10.876632244297555, - 8.176318501152192, - 5.424189808504429 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10405917766087344, - 0.3000568252233408, - 0.6957869348062637 - ], - "xyz": [ - 13.614996635247946, - 10.935352077350455, - 5.5250012505524575 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10043239553588897, - 0.30345156548299096, - 0.8953564787240507 - ], - "xyz": [ - 16.389887794950713, - 13.614246246884527, - 5.521828815937142 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0991447750962554, - 0.5002123092755735, - 0.09624369269761605 - ], - "xyz": [ - 8.15463909689709, - 2.6713159617536073, - 8.194302173256457 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10229395943220652, - 0.5034072858273857, - 0.2964025351961064 - ], - "xyz": [ - 10.934855907265398, - 5.45090670918926, - 8.281038398964997 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09841142805675154, - 0.49609761631418686, - 0.5019052291320547 - ], - "xyz": [ - 13.644515262428833, - 8.207421280087065, - 8.128020643011482 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10134190211580761, - 0.49866610723502064, - 0.6960806735922492 - ], - "xyz": [ - 16.33436293304988, - 10.902217919016925, - 8.20320150240284 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0993212014779413, - 0.5024900760298924, - 0.8954931196106359 - ], - "xyz": [ - 19.112974613822086, - 13.600922331345231, - 8.22785546005715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09797463854871054, - 0.6979616909947676, - 0.09905475692828651 - ], - "xyz": [ - 10.896665413043367, - 2.6937504296703176, - 10.881898228979114 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10020852367575983, - 0.7016978436435404, - 0.2952064896310819 - ], - "xyz": [ - 13.629496601750645, - 5.406042887228745, - 10.963519510843353 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10128938076603415, - 0.704040232285198, - 0.4963224930026162 - ], - "xyz": [ - 16.411143114844442, - 8.170441968027708, - 11.010321510306095 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09990631458446608, - 0.7027531881751001, - 0.6952706756868561 - ], - "xyz": [ - 19.113530622425166, - 10.871516679131267, - 10.973816243018291 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0994328360046847, - 0.7048995199072209, - 0.8983475669294706 - ], - "xyz": [ - 21.919305586755613, - 13.641474068443241, - 10.996687190203508 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09918683325906186, - 0.8982194452499993, - 0.10497410025728715 - ], - "xyz": [ - 13.715481579337428, - 2.79125153406749, - 13.63635910664575 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10435453263804473, - 0.896175503579843, - 0.3002401032860772 - ], - "xyz": [ - 16.357178822261623, - 5.531545035320128, - 13.67906655976444 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09847904338285048, - 0.8998838324541287, - 0.49690879225998597 - ], - "xyz": [ - 19.096697342418928, - 8.140035319098443, - 13.649437533125528 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10295860050470358, - 0.9026589776149547, - 0.6983395621361586 - ], - "xyz": [ - 21.888563855740063, - 10.95520424595659, - 13.748622516887906 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09872108562421736, - 0.9010519141994124, - 0.8961466637036339 - ], - "xyz": [ - 24.570975461346425, - 13.601652792615502, - 13.668716494448697 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3030405014072538, - 0.09803546444131951, - 0.1026679952247862 - ], - "xyz": [ - 2.743981573932257, - 5.546773538423857, - 5.483438411407842 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3021748545039693, - 0.09496709653893239, - 0.3012108954746341 - ], - "xyz": [ - 5.416474194770918, - 8.24938136427247, - 5.429653269107364 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3018017168815269, - 0.10001261587257085, - 0.5029234502348316 - ], - "xyz": [ - 8.243233367328507, - 11.002057634284773, - 5.493533230834128 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30155714292820773, - 0.09565119423153967, - 0.6992738046307502 - ], - "xyz": [ - 10.868071497945431, - 13.68318056545551, - 5.430560888147377 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30315098061421997, - 0.10261510086658322, - 0.8964657248118302 - ], - "xyz": [ - 13.659253214126645, - 16.40094366557798, - 5.547560828110874 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2998888372222269, - 0.3040485763002139, - 0.10027679451488465 - ], - "xyz": [ - 5.527863691217281, - 5.470992487296076, - 8.256923608944376 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30168742571821244, - 0.30220957549759153, - 0.29497606827312345 - ], - "xyz": [ - 8.164614628217336, - 8.157475890420624, - 8.256371099162251 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2961116550046143, - 0.29827772091049676, - 0.5032605418914737 - ], - "xyz": [ - 10.958486852141235, - 10.928872788967873, - 8.126384557423732 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3011639122547573, - 0.29814564965676116, - 0.6965237119790972 - ], - "xyz": [ - 13.598940471800361, - 13.640205614752896, - 8.193652454733135 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2965983079949518, - 0.2976315072336307, - 0.9033382530511699 - ], - "xyz": [ - 16.41944238805694, - 16.405316674041586, - 8.124203072438439 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2987044050686276, - 0.49583011052031656, - 0.10238836785658144 - ], - "xyz": [ - 8.178735357042841, - 5.483668194734331, - 10.862732880919237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30066527118121583, - 0.49795065531410354, - 0.3044761656275108 - ], - "xyz": [ - 10.97063505908598, - 8.273384798590284, - 10.918533196177236 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3029164290031017, - 0.4951933358707756, - 0.5015945092822205 - ], - "xyz": [ - 13.627903997119633, - 10.999128736268032, - 10.91161304559797 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2960221898020522, - 0.49956659033942696, - 0.7042670710109046 - ], - "xyz": [ - 16.458597127922687, - 13.675774721767798, - 10.877146596113876 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30167590861292964, - 0.4954371151738909, - 0.9032384238107565 - ], - "xyz": [ - 19.12244020740108, - 16.4733718683168, - 10.897985780869128 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29655225910169214, - 0.6976600514941615, - 0.10264032825697542 - ], - "xyz": [ - 10.941562737889187, - 5.457689199701978, - 13.592691752250603 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2984474251786088, - 0.6995933227572793, - 0.2971231845035212 - ], - "xyz": [ - 13.626928678298356, - 8.142534172864337, - 13.645033458444832 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.297549637201162, - 0.7046366067173861, - 0.5003812017626088 - ], - "xyz": [ - 16.474786574332963, - 10.90916680276166, - 13.701709933330484 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30019341678885036, - 0.6952404241838348, - 0.7030326179288662 - ], - "xyz": [ - 19.116937342617266, - 13.71592576597437, - 13.609392295687176 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30167470693274384, - 0.6950914009331757, - 0.9026444368286294 - ], - "xyz": [ - 21.8439567814286, - 16.465234556059617, - 13.627606808843435 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.301350907074246, - 0.9008135969857385, - 0.0950830339705125 - ], - "xyz": [ - 13.615719477040289, - 5.41997348385455, - 16.435776709897375 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30366085507815355, - 0.8982830027553599, - 0.2961996209133319 - ], - "xyz": [ - 16.330751423926092, - 8.20118445286991, - 16.432760074405383 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3025776244921814, - 0.8988208633283372, - 0.5028523118334906 - ], - "xyz": [ - 19.16342334964098, - 11.011693112056047, - 16.42530387375432 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29682125612715576, - 0.8982397938458354, - 0.704571871242596 - ], - "xyz": [ - 21.91335257898932, - 13.690866586636318, - 16.338659564241738 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30275746334063686, - 0.896241495696751, - 0.9029508767442028 - ], - "xyz": [ - 24.59823426138568, - 16.48422739813871, - 16.392497948146538 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.498069264722685, - 0.1049952827289121, - 0.09781077193303196 - ], - "xyz": [ - 2.7727278742482597, - 8.146764602750363, - 8.244989941139693 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5004844267774621, - 0.09831478619214952, - 0.304501927327689 - ], - "xyz": [ - 5.507237600234798, - 11.005628535781886, - 8.186675055862194 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5003451494530735, - 0.09973936986454575, - 0.49583167297400194 - ], - "xyz": [ - 8.142540094900912, - 13.619550204394937, - 8.204247532897012 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5000900244641602, - 0.09883937536594688, - 0.7045547058557003 - ], - "xyz": [ - 10.98385926752774, - 16.469685916881673, - 8.188454947185253 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49675789412567256, - 0.09792817122149258, - 0.9010265048043024 - ], - "xyz": [ - 13.657528518782982, - 19.11025670097881, - 8.130440841934679 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49830331464222083, - 0.2960699872594803, - 0.10260612366642002 - ], - "xyz": [ - 5.450628026878942, - 8.215525676856842, - 10.860528796405715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5025511818928149, - 0.3032285958952696, - 0.29765975447312837 - ], - "xyz": [ - 8.21523736633367, - 10.94033988402663, - 11.01647608155869 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49855445264366827, - 0.2973260458773296, - 0.49918618955345956 - ], - "xyz": [ - 10.88977191060737, - 13.640930466803534, - 10.881134917289348 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49740587858477386, - 0.30167772976712803, - 0.6969742783528431 - ], - "xyz": [ - 13.653390497654783, - 16.32935051722285, - 10.924927258337698 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5005757996646281, - 0.30241858483422707, - 0.8950694985095112 - ], - "xyz": [ - 16.371841527620585, - 19.08101130048316, - 10.978394685879136 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.503424896908204, - 0.49553810752881794, - 0.10153422625212222 - ], - "xyz": [ - 8.163065474432932, - 8.27089223920581, - 13.657642383322164 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5025395741899248, - 0.5015526632035778, - 0.2950378833372963 - ], - "xyz": [ - 10.890842566008452, - 10.904335435369811, - 13.727768333041237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5024298032676631, - 0.5033784678878688, - 0.4972594121372092 - ], - "xyz": [ - 13.68054098088446, - 13.667571008956639, - 13.751229637749622 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49894416427624816, - 0.5032257530195118, - 0.7021060403848282 - ], - "xyz": [ - 16.47907931970132, - 16.420542209089394, - 13.701486718682515 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5014241931387547, - 0.49958271705335594, - 0.8955260218536641 - ], - "xyz": [ - 19.073675558763775, - 19.09885188833765, - 13.6855862949027 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49503216130291927, - 0.7010520080631908, - 0.10258500571922217 - ], - "xyz": [ - 10.987180597770667, - 8.170514336436653, - 16.35264746842297 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5027762338058878, - 0.7029934182352755, - 0.2964343573400565 - ], - "xyz": [ - 13.663996650666336, - 10.926663344240943, - 16.485065644169417 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4949466467041455, - 0.701450616650858, - 0.5015679503068321 - ], - "xyz": [ - 16.447453304103487, - 13.624168197706624, - 16.356928033082202 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5013164295725594, - 0.6950354110086264, - 0.7026002329036368 - ], - "xyz": [ - 19.10822294915256, - 16.459731904375307, - 16.356307021094665 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49585111455524367, - 0.6988753080308111, - 0.9016734611465242 - ], - "xyz": [ - 21.882414673414075, - 19.106704444570944, - 16.334084598840473 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5014733747734491, - 0.8967190451232008, - 0.1040398959782585 - ], - "xyz": [ - 13.682196106129751, - 8.27846844532861, - 19.115835090191414 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49663001736028073, - 0.9046892542221363, - 0.29923227882303655 - ], - "xyz": [ - 16.459798493917653, - 10.880886058204998, - 19.15858484360592 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5035733919244252, - 0.9016411221260193, - 0.499002323935455 - ], - "xyz": [ - 19.149345078732185, - 13.707034723607427, - 19.211839897485145 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5041169566835677, - 0.8995644544692262, - 0.70043130515481 - ], - "xyz": [ - 21.87485402634309, - 16.468367017167168, - 19.190879590626988 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5041324338173299, - 0.9013548700099094, - 0.8968878659548163 - ], - "xyz": [ - 24.58525100241725, - 19.15449735483082, - 19.215569430211325 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7039402126461817, - 0.096052448380469, - 0.10125487398452643 - ], - "xyz": [ - 2.6975501960561914, - 11.008482289299446, - 10.937355662877382 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6992300741880422, - 0.09616807637009306, - 0.30434720893909367 - ], - "xyz": [ - 5.475772887995845, - 13.720727971003237, - 10.874540342763725 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7017394353621481, - 0.1039075114254113, - 0.4972010915972635 - ], - "xyz": [ - 8.218248620977464, - 16.39169907529422, - 11.01466004002909 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.696388478040628, - 0.1002603605496018, - 0.7044606724386672 - ], - "xyz": [ - 11.002001113229674, - 19.152157432505835, - 10.891639524414675 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7041875239254007, - 0.10041096726483935, - 0.8994273378050107 - ], - "xyz": [ - 13.669609336020077, - 21.924333738903073, - 11.000325743824547 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6970483545031627, - 0.3047296418243349, - 0.09999901462088585 - ], - "xyz": [ - 5.533377339760897, - 10.897088162137548, - 13.696128445750206 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7007967429891148, - 0.2970085197559285, - 0.3044325824554528 - ], - "xyz": [ - 8.222794490035607, - 13.743314396199546, - 13.641813947302936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998674159802175, - 0.3011274699909243, - 0.4954741686483068 - ], - "xyz": [ - 10.890994215180612, - 16.342494983555948, - 13.685421901917975 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.699118815884373, - 0.30306787755891956, - 0.6956157324697108 - ], - "xyz": [ - 13.653822553261627, - 19.068559692878328, - 13.701716079151874 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.695669837553042, - 0.30098886182246565, - 0.8995576912077494 - ], - "xyz": [ - 16.413656374649552, - 21.80966363226236, - 13.626138339296052 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7016708787005235, - 0.4952088101239516, - 0.10021405291135199 - ], - "xyz": [ - 8.140514207303324, - 10.963226445709871, - 16.363523667264236 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998356099672596, - 0.5018984715853696, - 0.29531820143660115 - ], - "xyz": [ - 10.89940285455524, - 13.60556378182753, - 16.429892050852864 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7046890665715263, - 0.499419709123423, - 0.4966275851919136 - ], - "xyz": [ - 13.617779319366303, - 16.424185025912433, - 16.46235844172172 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.701505340407912, - 0.5008308438440353, - 0.7026104169808542 - ], - "xyz": [ - 16.45323229857094, - 19.19681789418288, - 16.438123890579458 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6954258354085435, - 0.4997807911209279, - 0.9033401492280967 - ], - "xyz": [ - 19.183216934682598, - 21.858040764074907, - 16.340649860718155 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.703787080211341, - 0.7011698130105282, - 0.0957546836154389 - ], - "xyz": [ - 10.895408271460827, - 10.931191077522245, - 19.208317751888615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7003140525030579, - 0.7004349627289611, - 0.2955223741583002 - ], - "xyz": [ - 13.616549437601995, - 13.614896374757288, - 19.15078840142942 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7033822089370498, - 0.6972624991748186, - 0.49693006341840235 - ], - "xyz": [ - 16.32678576111325, - 16.410453331434717, - 19.149362333258004 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7037522220999337, - 0.7005083252976341, - 0.695543162907685 - ], - "xyz": [ - 19.086564657475243, - 19.13091463065486, - 19.198797437121012 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7028058310301067, - 0.7026940974877217, - 0.8958386470785132 - ], - "xyz": [ - 21.85485194781554, - 21.856379548694992, - 19.215742032708615 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6983766294381313, - 0.9039871212019224, - 0.09627712430580875 - ], - "xyz": [ - 13.675432717017507, - 10.864363083511472, - 21.907228773275694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7041053075681102, - 0.8958379072621094, - 0.29985330211997757 - ], - "xyz": [ - 16.347274990254203, - 13.72594139910579, - 21.874135643380093 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7047075209451329, - 0.8966753480123982, - 0.4991224684460772 - ], - "xyz": [ - 19.083096503013312, - 16.458546925558533, - 21.89381833547095 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.70454175271742, - 0.899068722874773, - 0.696430260861304 - ], - "xyz": [ - 21.81337491582257, - 19.153837194685867, - 21.924273772410853 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7025150522371767, - 0.8954202382041169, - 0.9025828826190708 - ], - "xyz": [ - 24.58197502733287, - 21.94461004772634, - 21.846683662561084 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9039180762531489, - 0.10025697689231494, - 0.10016042791688173 - ], - "xyz": [ - 2.740070683418471, - 13.727580574881907, - 13.728900575095214 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9014282326689637, - 0.1020101467864918, - 0.3016160558784729 - ], - "xyz": [ - 5.5183047901189175, - 16.44780496504861, - 13.718828905006683 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.899310744146741, - 0.0956869669253663, - 0.5013499023925406 - ], - "xyz": [ - 8.162580610677946, - 19.149580240568678, - 13.603429606189856 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9009120995267751, - 0.09541634218506981, - 0.7001538937192684 - ], - "xyz": [ - 10.876893062641647, - 21.88948606778112, - 13.621623115964834 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.901281287530627, - 0.09672992625877487, - 0.8978379095791088 - ], - "xyz": [ - 13.597552429365093, - 24.597233821428826, - 13.644629672910218 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8949376486671647, - 0.30167073359698243, - 0.1015097919265959 - ], - "xyz": [ - 5.512211572463768, - 13.623250047258589, - 16.35981441280661 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9014078359686778, - 0.30365938757896566, - 0.29573030139101447 - ], - "xyz": [ - 8.194747937453553, - 16.367057129116986, - 16.47546216824314 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9039046938297634, - 0.29614467669496547, - 0.501411998661165 - ], - "xyz": [ - 10.904051305267451, - 19.21323686273132, - 16.406858984927396 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9041018663903172, - 0.2995841232549814, - 0.7004426091044851 - ], - "xyz": [ - 13.6721854800068, - 21.937043250959345, - 16.456578186952385 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9047038852416892, - 0.29665573749176766, - 0.8993680254785252 - ], - "xyz": [ - 16.351821603052507, - 24.66494643042284, - 16.42477251727973 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9038188758770851, - 0.4962355382839057, - 0.0983170413710885 - ], - "xyz": [ - 8.128615849578742, - 13.701021876151923, - 19.141291940614515 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8953459034345789, - 0.500628074319395, - 0.3005847303289384 - ], - "xyz": [ - 10.954037246847177, - 16.350548357300728, - 19.085504948536332 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8964553943579847, - 0.5045577206798801, - 0.4999346022106195 - ], - "xyz": [ - 13.73323822994079, - 19.09119268288657, - 19.154399126436978 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9029376645776516, - 0.49591515413921106, - 0.6985406567417874 - ], - "xyz": [ - 16.330384844319052, - 21.89512334298153, - 19.124863943989574 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9031726594716432, - 0.49758393446939647, - 0.8966175281144529 - ], - "xyz": [ - 19.061271440183123, - 24.606407482443338, - 19.150892016174982 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9012573676893109, - 0.6963513944328428, - 0.1040667847667801 - ], - "xyz": [ - 10.943173270744987, - 13.744610854032231, - 21.8422194261569 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.903578799414932, - 0.6968345822193358, - 0.3021730544046186 - ], - "xyz": [ - 13.65825258654811, - 16.484822310087207, - 21.880563679295015 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9030287729130652, - 0.6952098340355638, - 0.5003472718633974 - ], - "xyz": [ - 16.345441551571533, - 19.186704676495733, - 21.8508305512524 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8999618970966468, - 0.7046012633471828, - 0.6988706348117728 - ], - "xyz": [ - 19.18801516668757, - 21.858950586396166, - 21.937298708219156 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9021431219178637, - 0.6954198889452705, - 0.8995303528457003 - ], - "xyz": [ - 21.805872614722627, - 24.632155445741986, - 21.841593923178813 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9043897192164534, - 0.9006311879916145, - 0.09649790529882632 - ], - "xyz": [ - 13.632569480230114, - 13.68395544260049, - 24.677920939585402 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9023393451992379, - 0.8986906731007641, - 0.29584341495021926 - ], - "xyz": [ - 16.331455035697193, - 16.38133902386655, - 24.62335822479433 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8980116317665635, - 0.8965828225803322, - 0.5012887678488347 - ], - "xyz": [ - 19.11144876746129, - 19.13098318946979, - 24.535372352828972 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9042998290512247, - 0.8984815838400978, - 0.7007975857499481 - ], - "xyz": [ - 21.86505693638458, - 21.944602937626968, - 24.64730297639584 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.900940579855298, - 0.9017831397690039, - 0.8950004287086876 - ], - "xyz": [ - 24.56530152718467, - 24.553782199705267, - 24.64651420443392 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15491927011177872, - 0.14744069514901126, - 0.1494139508836213 - ], - "xyz": [ - 4.058543286721866, - 4.160789017469329, - 4.133811020251773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14704050879423017, - 0.15425332065580083, - 0.35116321920458354 - ], - "xyz": [ - 6.909963957993999, - 6.81135169252874, - 4.119235003351522 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14688584374172384, - 0.1525611319477956, - 0.5532622455499169 - ], - "xyz": [ - 9.649890168940775, - 9.572298650139238, - 4.093985151171485 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14671870632790854, - 0.1536866030208362, - 0.752010874631658 - ], - "xyz": [ - 12.382532888918924, - 12.287269059554621, - 4.107087316460355 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14810944549260396, - 0.15501773892075346, - 0.9478896215429033 - ], - "xyz": [ - 15.07875090893423, - 14.984301964677387, - 4.1443003024062275 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1540791283255185, - 0.34822624738865976, - 0.14641866776866644 - ], - "xyz": [ - 6.762696243946235, - 4.1083517785964, - 6.867428681796616 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1532501641214858, - 0.35144437357182684, - 0.34995168394739956 - ], - "xyz": [ - 9.589360647112509, - 6.879685090465147, - 6.900092874326185 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1545333572111992, - 0.3467878224975673, - 0.5482219751398449 - ], - "xyz": [ - 12.236412851535125, - 9.607944407943652, - 6.853972931165908 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1492256964425189, - 0.3480475895308857, - 0.7477501482955033 - ], - "xyz": [ - 14.981549427969581, - 12.263292293606186, - 6.798630856636912 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1528368405013214, - 0.3468762903731258, - 0.9472804711508045 - ], - "xyz": [ - 17.6934782953381, - 15.040605863791766, - 6.831987976951884 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1468902127967371, - 0.5516447938273785, - 0.15395664508924856 - ], - "xyz": [ - 9.646855864609119, - 4.113124088582777, - 9.550244874263715 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1489359711891374, - 0.5549756595702751, - 0.3486356737320023 - ], - "xyz": [ - 12.354011498868742, - 6.802709966465736, - 9.62375311164915 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15216990900107027, - 0.5517903561680179, - 0.5449798212463072 - ], - "xyz": [ - 14.994844446976716, - 9.531305624990699, - 9.62441803254404 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1464934848941327, - 0.5509938186324848, - 0.7482731162341882 - ], - "xyz": [ - 17.763343665448875, - 12.233087912638199, - 9.535920866101279 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14830596104615598, - 0.5462655894507417, - 0.9515545114948096 - ], - "xyz": [ - 20.477926812509406, - 15.037094405695022, - 9.496057215514494 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15240745615231643, - 0.7532178924490145, - 0.1482518775827925 - ], - "xyz": [ - 12.324732431316258, - 4.110560292146337, - 12.381546753514646 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14854309537730284, - 0.7549097285918535, - 0.3492861316443233 - ], - "xyz": [ - 15.096367045894164, - 6.806231582578809, - 12.351844387797989 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14775033338868104, - 0.746544327169544, - 0.5521593558810683 - ], - "xyz": [ - 17.75564298800502, - 9.569039287951943, - 12.22663562611315 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1524749391068057, - 0.7533186703384244, - 0.7475017176780624 - ], - "xyz": [ - 20.518946197291562, - 12.304318855764494, - 12.383847185485484 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14707195827652114, - 0.7482503094069679, - 0.9499239068947379 - ], - "xyz": [ - 23.217132213917985, - 14.99793000936572, - 12.240684885760478 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15056461790106979, - 0.9502548861626171, - 0.1536841420814577 - ], - "xyz": [ - 15.092855685127907, - 4.159634281704318, - 15.050206112047995 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1506203515426538, - 0.9540172720164983, - 0.34581539010997214 - ], - "xyz": [ - 17.77107818671392, - 6.787180101441203, - 15.102406754528486 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14803146883457044, - 0.9486741490469204, - 0.5482427807331691 - ], - "xyz": [ - 20.46557881890602, - 9.519336210725212, - 14.993961800664522 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14588361257949645, - 0.9509672602587341, - 0.7491870174490962 - ], - "xyz": [ - 23.244203257051467, - 12.237244541037512, - 14.995947700287175 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14720433742097633, - 0.9487033139674418, - 0.9491853431935967 - ], - "xyz": [ - 25.947592100747425, - 14.98964236321993, - 14.983052146405202 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3476865790081253, - 0.1505325359618424, - 0.15456591560196345 - ], - "xyz": [ - 4.171251112059072, - 6.866705700860102, - 6.811562060428702 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34797560909675734, - 0.1530470437943841, - 0.3463001042886583 - ], - "xyz": [ - 6.8269843261047, - 9.492012583776992, - 6.849891526250165 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3507506172963508, - 0.15447007106660496, - 0.547572325807183 - ], - "xyz": [ - 9.59819728242699, - 12.281709579981754, - 6.907286311574425 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35091645422778733, - 0.1501794132444433, - 0.7454044156128969 - ], - "xyz": [ - 12.24426090304836, - 14.988701594705264, - 6.850892502824192 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35014036108485813, - 0.15307952631480673, - 0.9452633590957558 - ], - "xyz": [ - 15.016346227613834, - 17.71052648963972, - 6.879931720948485 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3505334970111604, - 0.34869370378821174, - 0.14638953497594595 - ], - "xyz": [ - 6.7686889254005855, - 6.793842247181959, - 9.55970842843287 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35001522781247996, - 0.3547724823204053, - 0.34763432528154037 - ], - "xyz": [ - 9.603179440308432, - 9.538139112981888, - 9.635730711148982 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3483948860093612, - 0.3460496076179835, - 0.5533370721400557 - ], - "xyz": [ - 12.296252796049554, - 12.32831702006636, - 9.494320116864202 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3547175677472088, - 0.34679654987370245, - 0.7497794472757116 - ], - "xyz": [ - 14.992189649347301, - 15.100484379930661, - 9.590974743571925 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35212639242248583, - 0.34958609026742055, - 0.9453967380169666 - ], - "xyz": [ - 17.704772131395046, - 17.739502685204712, - 9.593686755089514 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35459078088988, - 0.5483276789742966, - 0.15028846297941603 - ], - "xyz": [ - 9.551354141885605, - 6.902618143917119, - 12.344538657940246 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.346383565403599, - 0.547910725950434, - 0.3523438007960457 - ], - "xyz": [ - 12.308117843863055, - 9.552874779755626, - 12.226630578419893 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35032277604394146, - 0.5546584791601759, - 0.5476264784237037 - ], - "xyz": [ - 15.070241528794435, - 12.27660057621584, - 12.372740824524755 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35077468289310587, - 0.5452270795965373, - 0.7531961228173836 - ], - "xyz": [ - 17.75180830722669, - 15.093290140928783, - 12.249974816441151 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34569002787155667, - 0.5519629288998559, - 0.9533014591409693 - ], - "xyz": [ - 20.579703765704313, - 17.75957779196759, - 12.272549647446532 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3453136643857187, - 0.7533530857476516, - 0.15093661445433934 - ], - "xyz": [ - 12.363286009015582, - 6.784644487251081, - 15.020774047808413 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3492448507096742, - 0.7541470199025788, - 0.3459889972910805 - ], - "xyz": [ - 15.040861602588615, - 9.505112027773677, - 15.085375044474011 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3455064109581605, - 0.7506804233655179, - 0.5501297799317696 - ], - "xyz": [ - 17.784442953643918, - 12.244976787332762, - 14.98686908524315 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3534267595424511, - 0.7522495280975714, - 0.7479762005473997 - ], - "xyz": [ - 20.510816121402886, - 15.058183017815622, - 15.11660718288261 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35078527194829795, - 0.754450747083366, - 0.9476119280020927 - ], - "xyz": [ - 23.270294522486875, - 17.75145280622575, - 15.110587909717482 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3478646530540205, - 0.9464808498154895, - 0.15363616707379227 - ], - "xyz": [ - 15.040601833847218, - 6.856428942639832, - 17.696058733041422 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34905675894362104, - 0.954477469595961, - 0.346354499661139 - ], - "xyz": [ - 17.784740533928602, - 9.507537553617729, - 17.821685336432026 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3484786426618573, - 0.9538617253808224, - 0.5515012743306041 - ], - "xyz": [ - 20.58105196671467, - 12.304363428735872, - 17.805363090613266 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35211103942377175, - 0.9534614412098655, - 0.7461471859860228 - ], - "xyz": [ - 23.236743221469286, - 15.015188771322135, - 17.849551952176572 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3529772754582085, - 0.9460614354830515, - 0.9526487074749166 - ], - "xyz": [ - 25.958823306695606, - 17.850283425984756, - 17.760223429020936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5509761624127185, - 0.14644424936419945, - 0.15423225043804895 - ], - "xyz": [ - 4.110794983526375, - 9.64148248298138, - 9.5350063341399 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5490879235049282, - 0.1498699723362463, - 0.3545736876750482 - ], - "xyz": [ - 6.896662919815616, - 12.354698888962623, - 9.556026539519285 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5537457862322328, - 0.14933239629426745, - 0.5512018281781444 - ], - "xyz": [ - 9.57757782082641, - 15.106644893648083, - 9.612358357429455 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.546706006121912, - 0.14746757925654144, - 0.7529477590493583 - ], - "xyz": [ - 12.310316430557364, - 17.768632339743874, - 9.490616308048846 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5487945226400918, - 0.1529977071973576, - 0.9524351028620338 - ], - "xyz": [ - 15.113278401226188, - 20.52454121853247, - 9.594777043736237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5459020692834884, - 0.3487308527765092, - 0.15352998984509367 - ], - "xyz": [ - 6.866819833370882, - 9.562509214635329, - 12.231260276478315 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5470326867509746, - 0.35423677427854855, - 0.3475379049965291 - ], - "xyz": [ - 9.59453709560659, - 12.230408107665355, - 12.321993842692654 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5464149234687657, - 0.3534286204970965, - 0.5522712898394899 - ], - "xyz": [ - 12.382566148137949, - 15.021040144832075, - 12.302498961263353 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5473140759390572, - 0.34817546122835646, - 0.7496548252427613 - ], - "xyz": [ - 15.009338067181556, - 17.731925362555607, - 12.242971764036188 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5548705290224794, - 0.34936734901125954, - 0.947126943465646 - ], - "xyz": [ - 17.725436597771605, - 20.5350390843126, - 12.36257750565923 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5549433390338777, - 0.5473683281055994, - 0.1491645502326295 - ], - "xyz": [ - 9.522872136722164, - 9.626436322631617, - 15.070606697030845 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5524982837412674, - 0.5521951615250253, - 0.34518699252924173 - ], - "xyz": [ - 12.26884728144221, - 12.27299151382067, - 15.103169938860605 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5550600001120747, - 0.5482579461589256, - 0.5481210775986165 - ], - "xyz": [ - 14.989496664588838, - 15.08249312186658, - 15.084364364186786 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5542022709271397, - 0.5486632912646238, - 0.750878917119868 - ], - "xyz": [ - 17.76710715543526, - 17.84283508836484, - 15.078179450484594 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5528814878798601, - 0.550174955854214, - 0.9452133286777268 - ], - "xyz": [ - 20.444679456229476, - 20.481682674908345, - 15.080789148572388 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.55233315015042, - 0.7501463754876894, - 0.15234495841866552 - ], - "xyz": [ - 12.33869906872758, - 9.634232258296993, - 17.807265628209613 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5503489468829246, - 0.7452208427495635, - 0.3513595346415339 - ], - "xyz": [ - 14.99224953522315, - 12.32799605187572, - 17.71279696129324 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5460457977744276, - 0.7528320473723273, - 0.5527919593699341 - ], - "xyz": [ - 17.850256407858982, - 15.023112024881426, - 17.758024100834305 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5530881689812814, - 0.7527024563974735, - 0.7476676093440395 - ], - "xyz": [ - 20.51278947220613, - 17.783698865223688, - 17.852534387865767 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5515574504368679, - 0.7494804417535088, - 0.95341839368396 - ], - "xyz": [ - 23.281726356310692, - 20.575758845168014, - 17.787555875206234 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502708725649291, - 0.9497629402867631, - 0.14585336289900072 - ], - "xyz": [ - 14.979068886221189, - 9.517285244900465, - 20.508192283222023 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.550516251371003, - 0.9511756180538348, - 0.34520693421265924 - ], - "xyz": [ - 17.723908905728095, - 12.246166163126423, - 20.530860934239882 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5543510150786102, - 0.9495458036259612, - 0.5461139029486108 - ], - "xyz": [ - 20.448390289540363, - 15.045358275582918, - 20.56100660390153 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5539953721826001, - 0.9457478080402955, - 0.7504133469592532 - ], - "xyz": [ - 23.189610002145926, - 17.83364121453797, - 20.504218806234984 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5482272474688575, - 0.9467383529774607, - 0.9544902569906307 - ], - "xyz": [ - 25.99325533433395, - 20.54488323181932, - 20.43890059549398 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7462593885698495, - 0.1489393000119725, - 0.15434949354277402 - ], - "xyz": [ - 4.146509793497654, - 12.31296252664501, - 12.238995334526726 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7472293826737668, - 0.15218744979481932, - 0.3470046252438349 - ], - "xyz": [ - 6.824864195354973, - 14.960170394128024, - 12.296665038480665 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7488418865324337, - 0.14636406869428814, - 0.5503738026878139 - ], - "xyz": [ - 9.52567476471925, - 17.762643044195162, - 12.239094682787798 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7512741774343175, - 0.15069733848466738, - 0.7528992288616837 - ], - "xyz": [ - 12.353809621377188, - 20.564788059665794, - 12.331592210771495 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7511247908870411, - 0.1462250652797681, - 0.9485671221384759 - ], - "xyz": [ - 14.967801723788495, - 23.23788189034052, - 12.268405710538504 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7509041181480641, - 0.3457080500783007, - 0.1538459528274725 - ], - "xyz": [ - 6.829812408007207, - 12.36958011536476, - 14.992684173800578 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7547250258472298, - 0.34695923639645737, - 0.3499481250406675 - ], - "xyz": [ - 9.52799200224331, - 15.10289247777217, - 15.062028930228484 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7472499928777042, - 0.34709308177148496, - 0.5517733852292274 - ], - "xyz": [ - 12.289140540869678, - 17.76001380126991, - 14.961661534850277 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7508120337639793, - 0.3527048496153797, - 0.751410126376457 - ], - "xyz": [ - 15.095261211064711, - 20.538110973451218, - 15.087084196523586 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7514421735619676, - 0.35140969666541305, - 0.9449611851042716 - ], - "xyz": [ - 17.72374934879641, - 23.19292136708026, - 15.077992256412106 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7461824960198427, - 0.5486350588487294, - 0.15407011100844142 - ], - "xyz": [ - 9.607258595356665, - 12.308091597821432, - 17.702512543003238 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7475114653320046, - 0.5544111673558008, - 0.3508744439000209 - ], - "xyz": [ - 12.376901925679567, - 15.016934441556591, - 17.79965188803379 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7500574506518085, - 0.5546151654234297, - 0.5486686220223466 - ], - "xyz": [ - 15.08389735087691, - 17.755949094907965, - 17.83724916590976 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7514437663904556, - 0.5540929176619521, - 0.7470372096756254 - ], - "xyz": [ - 17.788816897536435, - 20.486962178199764, - 17.84906254776139 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7454147643268211, - 0.5532415993316259, - 0.9516216760792516 - ], - "xyz": [ - 20.574219826027942, - 23.20157674667255, - 17.754996045792826 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7470502807380243, - 0.7548539691597844, - 0.14933470918599173 - ], - "xyz": [ - 12.361904856381347, - 12.255214232942958, - 20.533764561837856 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.754826282007553, - 0.7476456575623308, - 0.3476804429185455 - ], - "xyz": [ - 14.975101287076454, - 15.07327349197913, - 20.541525912850325 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7548813301816453, - 0.749532182327037, - 0.5482695355457258 - ], - "xyz": [ - 17.743311482447194, - 17.816444069068783, - 20.56807074858645 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7507141332076598, - 0.7540821231337983, - 0.7492697655373484 - ], - "xyz": [ - 20.553556418571954, - 20.507509866539976, - 20.57330355337427 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7483339959860638, - 0.7460610508720407, - 0.9524554518321919 - ], - "xyz": [ - 23.221811892001778, - 23.252887188470584, - 20.43110008953557 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7458983739415145, - 0.9539968003007563, - 0.1508998350344725 - ], - "xyz": [ - 15.105947916908885, - 12.260863689442077, - 23.240660841108962 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7525888811154459, - 0.946537653800269, - 0.34768283761461666 - ], - "xyz": [ - 17.69434959893586, - 15.042716889568041, - 23.230152142591365 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7517487244740321, - 0.9529227229140087, - 0.5452427132839442 - ], - "xyz": [ - 20.482648173919895, - 17.732233478568254, - 23.30596118782876 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7543967308377398, - 0.9465811753922417, - 0.7506818879826143 - ], - "xyz": [ - 23.20467509510962, - 20.57716396236049, - 23.255463757953184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7549338163118843, - 0.9472674675755707, - 0.948838573269573 - ], - "xyz": [ - 25.92322049134745, - 23.293669431327558, - 23.272189557078182 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9535916912236124, - 0.15150173701429057, - 0.14920150301486637 - ], - "xyz": [ - 4.111160571095428, - 15.077190048853518, - 15.108638434051526 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9506920584654586, - 0.15449210554013432, - 0.34713981681724937 - ], - "xyz": [ - 6.858221348724125, - 17.74372378912763, - 15.109878957134944 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9472079341791951, - 0.15255488812939683, - 0.5469651557738715 - ], - "xyz": [ - 9.563712126637581, - 20.428065534682133, - 15.035759349295052 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9533284587047326, - 0.14689593991806651, - 0.7472896775107254 - ], - "xyz": [ - 12.225144808075305, - 23.25054504707322, - 15.042069937579155 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9486913846665306, - 0.14986652653624902, - 0.9546877428054149 - ], - "xyz": [ - 15.101267150670745, - 26.022656822553493, - 15.019286021540385 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9519922985303655, - 0.352304506768528, - 0.14504729538405994 - ], - "xyz": [ - 6.799704315705793, - 14.998527860871118, - 17.832111148621514 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9542550395856829, - 0.34816063191471724, - 0.34657483245467563 - ], - "xyz": [ - 9.498298216474753, - 17.78471186115881, - 17.8063926259326 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9512817859421879, - 0.3540917836313406, - 0.5464717289272297 - ], - "xyz": [ - 12.312342242268512, - 20.477016459662, - 17.846832475966757 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9453489701037154, - 0.3529188524130342, - 0.7497286587690125 - ], - "xyz": [ - 15.07519829632893, - 23.17479622797474, - 17.749683981240945 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9454579585341868, - 0.35314168469751495, - 0.9518746290753496 - ], - "xyz": [ - 17.841948138966124, - 25.939989617931808, - 17.75422057432804 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.954735532450909, - 0.5483953524212912, - 0.1499073288156887 - ], - "xyz": [ - 9.547068563389365, - 15.102478363521895, - 20.550534894413442 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9516726673099007, - 0.5515716233504063, - 0.3518208885774429 - ], - "xyz": [ - 12.351019812425406, - 17.821129267251703, - 20.552085357935397 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9549281888778806, - 0.5494447986619698, - 0.5480168380444668 - ], - "xyz": [ - 15.004297953955792, - 20.547993877977486, - 20.567516698507074 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9547084961837756, - 0.5475716096083896, - 0.747523340507211 - ], - "xyz": [ - 17.706305040889468, - 23.272607269508562, - 20.53890319597144 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9477672326313284, - 0.5549118871329216, - 0.9477832955681048 - ], - "xyz": [ - 20.544578052755543, - 25.91562562244757, - 20.544358443175266 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9451285334023293, - 0.7516264614560524, - 0.15276221721543196 - ], - "xyz": [ - 12.364639224834372, - 15.01016472211092, - 23.197728873804717 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9510533178258903, - 0.750875069782068, - 0.34513036596103763 - ], - "xyz": [ - 14.984389036501305, - 17.721190011671794, - 23.268458568266233 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9482330398884145, - 0.7530682382789864, - 0.5525786483918967 - ], - "xyz": [ - 17.85056921812471, - 20.518827256064522, - 23.25988484087463 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9487128170319555, - 0.7543841694944804, - 0.7463819600611639 - ], - "xyz": [ - 20.518204385381445, - 23.17503067535725, - 23.284435442331855 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9545102728741497, - 0.7463247093195698, - 0.9494400813947674 - ], - "xyz": [ - 23.184190980984088, - 26.030466532500864, - 23.253509726255736 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.951488796236577, - 0.9538256973663984, - 0.14862046523684463 - ], - "xyz": [ - 15.072445494802269, - 15.040495803197553, - 26.049116799931028 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9462800349181616, - 0.9543323770411315, - 0.35054359887047526 - ], - "xyz": [ - 17.840029464987822, - 17.72993929290416, - 25.9848307860733 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9504182457405153, - 0.9525831293189804, - 0.54511642323875 - ], - "xyz": [ - 20.47627869664983, - 20.446680798044095, - 26.01749225956591 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9513881329711505, - 0.950925003921755, - 0.7450499077785045 - ], - "xyz": [ - 23.18706371728184, - 23.193395534281947, - 26.00808279123516 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9549286396405192, - 0.9481839046855179, - 0.9493939475007939 - ], - "xyz": [ - 25.94334283107786, - 26.035555633330343, - 26.019012145767597 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09941666990082705, - 0.10283161534545858, - 0.10290380003253435 - ], - "xyz": [ - 2.812777566673151, - 2.766089047244329, - 2.7651021511958724 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09530125846567994, - 0.09858616200956581, - 0.3035926817485474 - ], - "xyz": [ - 5.498516759669047, - 5.453606149699677, - 2.6507939130018743 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09602698016551704, - 0.10517899039982831, - 0.4994101705044484 - ], - "xyz": [ - 8.265834181834308, - 8.140709545272646, - 2.7508518124946995 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09481146323331197, - 0.10193408338532035, - 0.7035477775351063 - ], - "xyz": [ - 11.012403015769108, - 10.915023835122476, - 2.6898696991715494 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09805809636863688, - 0.10070209433027293, - 0.9049960826122362 - ], - "xyz": [ - 13.749724449486134, - 13.71357618527428, - 2.7174135504011687 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09656686259625494, - 0.30275453212179254, - 0.10378387987273424 - ], - "xyz": [ - 5.558119991875011, - 2.739159287902375, - 5.459450230734095 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10171861972038052, - 0.29443819527667925, - 0.30090621183113764 - ], - "xyz": [ - 8.139441571984792, - 5.504614224502676, - 5.416184666413101 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10136371924285821, - 0.30067977565996784, - 0.49456664309237636 - ], - "xyz": [ - 10.872465892826673, - 8.147452646382106, - 5.496666294482354 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09986285294487096, - 0.3037084779951696, - 0.694809519107568 - ], - "xyz": [ - 13.651558323149148, - 10.864617629673976, - 5.517554593772664 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10125984023460524, - 0.30472663843834935, - 0.8961444715519318 - ], - "xyz": [ - 16.418093658987324, - 13.63633221796941, - 5.550574058850474 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10355489875983423, - 0.5026831339522672, - 0.09545948482908612 - ], - "xyz": [ - 8.177698218307281, - 2.720888829838673, - 8.288377260393961 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10329460540604309, - 0.4954007013047586, - 0.2983637585143975 - ], - "xyz": [ - 10.852204817044734, - 5.491400853014757, - 8.185254468194872 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09622539163002534, - 0.5003481160295208, - 0.4983150791038418 - ], - "xyz": [ - 13.653543444488207, - 8.1284502985887, - 8.156245613489935 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10169087540983666, - 0.49430534639195295, - 0.702126583768092 - ], - "xyz": [ - 16.357401991400703, - 10.989647614737988, - 8.148353065154142 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09911007492750941, - 0.49955506877481615, - 0.9052200925182428 - ], - "xyz": [ - 19.20583314566967, - 13.731021269888181, - 8.184842084972328 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10291858628514476, - 0.7013559180496284, - 0.10131542820467788 - ], - "xyz": [ - 10.973978165146548, - 2.792250683982247, - 10.995896253854237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10408506173229962, - 0.6964087123951009, - 0.29714280889690403 - ], - "xyz": [ - 13.583657559830458, - 5.4855152262257585, - 10.944206790990476 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10301334683384634, - 0.7029039319845667, - 0.49908025519314037 - ], - "xyz": [ - 16.433311449939918, - 8.231715350064597, - 11.018355970895154 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10119481095937789, - 0.698172717732436, - 0.704696179325339 - ], - "xyz": [ - 19.179771044172426, - 11.017996558794398, - 10.928808966119314 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10231025877176236, - 0.7016512340376453, - 0.9017222101666957 - ], - "xyz": [ - 21.92103312194179, - 13.726951189482188, - 10.991616816621514 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10035693541270665, - 0.8958907722588247, - 0.09877120232886585 - ], - "xyz": [ - 13.598839477407479, - 2.7224440561379857, - 13.620519334697795 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1004892807620472, - 0.898938060034893, - 0.29571449871099015 - ], - "xyz": [ - 16.333074745713137, - 5.416826756275061, - 13.66399070645442 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09433783245826646, - 0.902484087231206, - 0.5017524857814474 - ], - "xyz": [ - 19.198469663645852, - 8.149639534716083, - 13.628369858048922 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10393953555231002, - 0.8959987982198897, - 0.7024601230722541 - ], - "xyz": [ - 21.853842649300354, - 11.024950980776488, - 13.670976910433435 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09585648465338342, - 0.9026181497527791, - 0.8977504112980859 - ], - "xyz": [ - 24.614314900346436, - 13.584414632207215, - 13.65096547616686 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29519999194029867, - 0.10435007266687349, - 0.09942812194305893 - ], - "xyz": [ - 2.786018796631966, - 5.395284539952765, - 5.462576564297628 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3024593531400044, - 0.09695062488571161, - 0.29656585643158534 - ], - "xyz": [ - 5.380086499603446, - 8.18976484072505, - 5.460661325771544 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29779904308030575, - 0.10318840614385731, - 0.49577554598653245 - ], - "xyz": [ - 8.188927340015304, - 10.849608938295779, - 5.482228228051897 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30354250427429547, - 0.10256054050476611, - 0.6952743995327123 - ], - "xyz": [ - 10.907855689903197, - 13.655644921806724, - 5.552167729671269 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2952556602574817, - 0.1023557115844146, - 0.9036866471144014 - ], - "xyz": [ - 13.754430040505644, - 16.391723416773058, - 5.436071105775474 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29756831699024094, - 0.3032842748618716, - 0.09594938643078658 - ], - "xyz": [ - 5.4582507551341894, - 5.380103207985672, - 8.21474848233555 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2990476633681203, - 0.3000881534751259, - 0.2958469942806846 - ], - "xyz": [ - 8.147518071790845, - 8.133292678336083, - 8.191277043433828 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2992691819088123, - 0.304075881565048, - 0.5015362629263068 - ], - "xyz": [ - 11.014184229299794, - 10.948467896805678, - 8.248825105703192 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30060326069590404, - 0.29960060185200477, - 0.7045235489444315 - ], - "xyz": [ - 13.728204647341732, - 13.74191281857693, - 8.205879172059749 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30084985839024053, - 0.30502775377159785, - 0.8972353019094835 - ], - "xyz": [ - 16.43712408992172, - 16.38000465628897, - 8.283449655506464 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2997463607335901, - 0.5036399453544939, - 0.0948220738431031 - ], - "xyz": [ - 8.18206500330609, - 5.3944686152143255, - 10.983752967301188 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30467962366251017, - 0.4997955835353794, - 0.3001477636026266 - ], - "xyz": [ - 10.936681452268331, - 8.26909116975924, - 10.998640227272249 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3009769700688915, - 0.49509739889420584, - 0.5042692303967231 - ], - "xyz": [ - 13.663160669672306, - 11.009181108449798, - 10.883785479077051 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30270652661296565, - 0.49720855908496636, - 0.69628657357255 - ], - "xyz": [ - 16.317250624569684, - 13.658053846978335, - 10.9362950669467 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29724125996625766, - 0.501528503116625, - 0.9046543415912289 - ], - "xyz": [ - 19.22507873993373, - 16.432100323285674, - 10.920636422311816 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3042438281225714, - 0.7010412147140656, - 0.09962400816577706 - ], - "xyz": [ - 10.94655080747309, - 5.521608361523767, - 13.744076154354788 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3020338879661911, - 0.7025854614831419, - 0.3009951589179747 - ], - "xyz": [ - 13.720773597612393, - 8.244504583771874, - 13.734974914188378 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3017062288513696, - 0.7043510281961175, - 0.49822566651573025 - ], - "xyz": [ - 16.44141210629533, - 10.936524885717823, - 13.754633728046974 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3039679610843055, - 0.7000913394447713, - 0.7010802000827457 - ], - "xyz": [ - 19.156565077543096, - 13.740837550806914, - 13.727318026159441 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30172164183471856, - 0.7023728982767, - 0.8943225074567709 - ], - "xyz": [ - 21.82973218201498, - 16.35210032116637, - 13.727799815386094 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29629159658874116, - 0.8972084733478196, - 0.10382656475993081 - ], - "xyz": [ - 13.685970854702303, - 5.47034348069, - 16.317318126160067 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30386850767394424, - 0.9026379891762676, - 0.29709515340471176 - ], - "xyz": [ - 16.402535573401483, - 8.21626700080839, - 16.49513965376666 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29890433906061353, - 0.9011469558931275, - 0.49545677239006053 - ], - "xyz": [ - 19.094114784416654, - 10.860362130753554, - 16.406885295374455 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30419123103032025, - 0.8971757795268863, - 0.7022197135433588 - ], - "xyz": [ - 21.866647290067636, - 13.759469280241316, - 16.424873522276226 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3000676507439922, - 0.8946279106863052, - 0.9022039435153387 - ], - "xyz": [ - 24.565961680911116, - 16.437240827826603, - 16.333662670673966 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4978278403075557, - 0.09588279888734175, - 0.10217341719968573 - ], - "xyz": [ - 2.707788936222944, - 8.203109192412652, - 8.117104991157582 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49568019684223036, - 0.09922404940339054, - 0.30019328508607934 - ], - "xyz": [ - 5.460761902019823, - 10.881038987697103, - 8.133423771905804 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5021811890638073, - 0.1041441318634894, - 0.4976734315670842 - ], - "xyz": [ - 8.227941400061384, - 13.669832399433833, - 8.289570649160233 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4990006529689398, - 0.09846305559823815, - 0.705555165492416 - ], - "xyz": [ - 10.992392395471626, - 16.468470329956332, - 8.168416280062914 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5054660149720842, - 0.09665498933018511, - 0.8990359632236705 - ], - "xyz": [ - 13.612907478944853, - 19.20209823553628, - 8.232089989039851 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49524617909947294, - 0.30186605080205947, - 0.09888617220398895 - ], - "xyz": [ - 5.479012257538552, - 8.122870563197695, - 10.897974927012367 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5046560123590926, - 0.2981880473533023, - 0.295901368239084 - ], - "xyz": [ - 8.122283553884298, - 10.945076407209761, - 10.976339472457115 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5009611643047946, - 0.29689645449331664, - 0.4971671140982073 - ], - "xyz": [ - 10.856294178340967, - 13.646230159235728, - 10.908165749836392 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5020749713301815, - 0.2943110890577674, - 0.7020666458820426 - ], - "xyz": [ - 13.622297044104792, - 16.46280744503443, - 10.888046868133166 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.499787762828356, - 0.29469981872167905, - 0.9028009978092929 - ], - "xyz": [ - 16.37201561346447, - 19.175941069461018, - 10.8620912071874 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5019088585432536, - 0.49891545252197467, - 0.09521894138525838 - ], - "xyz": [ - 8.122898489308787, - 8.163823797618628, - 13.683089832507807 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4994888280170008, - 0.4966315911689141, - 0.2984611909530693 - ], - "xyz": [ - 10.870365400470973, - 10.909429028355383, - 13.618779069434373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.504753971071413, - 0.5010461300763108, - 0.4982872027841267 - ], - "xyz": [ - 13.662705446867985, - 13.713398381541642, - 13.751117938873472 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4963150197892058, - 0.49960554305089205, - 0.6987779109822397 - ], - "xyz": [ - 16.38408287451925, - 16.33909543277966, - 13.616046669448505 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4969367446942836, - 0.4966087537641612, - 0.9041272445605777 - ], - "xyz": [ - 19.15061043661613, - 19.155094669574396, - 13.583575216734134 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4987935362791746, - 0.6956369919446118, - 0.10086986580317371 - ], - "xyz": [ - 10.889698387893327, - 8.19849009385749, - 16.330039184380528 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5037950560469439, - 0.7005738482554327, - 0.3009025319917131 - ], - "xyz": [ - 13.69200480499053, - 11.00168057809867, - 16.465914873219315 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5049065763484468, - 0.7002909270713218, - 0.49571776887307495 - ], - "xyz": [ - 16.35161560938652, - 13.680355935486505, - 16.47724333120446 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4951127517570601, - 0.699002514146247, - 0.7036970642417523 - ], - "xyz": [ - 19.177456149796615, - 16.389912018568882, - 16.32572897468215 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4944359320182185, - 0.7009158519477284, - 0.901718400425545 - ], - "xyz": [ - 21.910927024281964, - 19.087970725391294, - 16.342634427061313 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4960465659301154, - 0.9050834075632035, - 0.09865230533461976 - ], - "xyz": [ - 13.722893994310716, - 8.13061592213463, - 19.155996794205425 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4944162219409664, - 0.9025720633310775, - 0.3022147497484441 - ], - "xyz": [ - 16.471628446796863, - 10.891395251362715, - 19.099372378348033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4957253258473429, - 0.9046836471387227, - 0.5010286675393765 - ], - "xyz": [ - 19.218645738062328, - 13.627441181864416, - 19.14613940505035 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4966501106558342, - 0.9029488912906158, - 0.6967846361316256 - ], - "xyz": [ - 21.871268834881946, - 16.316425039823727, - 19.135065626791512 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4948384164772291, - 0.9002456769563351, - 0.9039660956014424 - ], - "xyz": [ - 24.66685859629087, - 19.12420350432742, - 19.073338610286868 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6982823699665459, - 0.095447438535423, - 0.10315294633516046 - ], - "xyz": [ - 2.71522871388134, - 10.957079386119993, - 10.851731070473386 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7028415573829938, - 0.09869177334214674, - 0.2952100958977499 - ], - "xyz": [ - 5.385355453911403, - 13.645182554356737, - 10.95841942167459 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6966411007584646, - 0.10304125130457284, - 0.503531693155104 - ], - "xyz": [ - 8.292956113522699, - 16.408546407283403, - 10.933113174582475 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6998471006855949, - 0.10513443455756324, - 0.6990160027163889 - ], - "xyz": [ - 10.994200031330763, - 19.125004554353307, - 11.005562653168113 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6989281362653518, - 0.09520957048900103, - 0.9019177343168164 - ], - "xyz": [ - 13.63254502839027, - 21.886476590342696, - 10.857307781958294 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6946379064868008, - 0.3026114524467104, - 0.09996471552928951 - ], - "xyz": [ - 5.503948904857634, - 10.863664019732022, - 13.634213730454356 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7012327868046931, - 0.2980388972280776, - 0.2960223008143559 - ], - "xyz": [ - 8.121897768620501, - 13.634292052011865, - 13.661862595192913 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7009849378921815, - 0.3036586946689219, - 0.49466184937083113 - ], - "xyz": [ - 10.914494780413575, - 16.3466676590382, - 13.735306908521544 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6993367594506186, - 0.2971286201814837, - 0.705535789728627 - ], - "xyz": [ - 13.708247332697248, - 19.20716461531979, - 13.623495306561768 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6964082613448006, - 0.2980130146429166, - 0.9004522078991892 - ], - "xyz": [ - 16.38520079885561, - 21.831988900619365, - 13.59554868947439 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.698032993289606, - 0.49907568693416443, - 0.09729650203670691 - ], - "xyz": [ - 8.153493220615738, - 10.873601700792191, - 16.366654396456948 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6980089338847427, - 0.5042299650626072, - 0.30196041041469623 - ], - "xyz": [ - 11.022089699258105, - 13.671400880779954, - 16.436793823406354 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7048042409168884, - 0.5003303995703697, - 0.49556690971586254 - ], - "xyz": [ - 13.615728751045696, - 16.411258304643855, - 16.476383880506503 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7026144294193586, - 0.503268234294395, - 0.6991220263333067 - ], - "xyz": [ - 16.438863213055022, - 19.1642885104884, - 16.48661071941497 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7049678278043482, - 0.49964270058160964, - 0.8996820574784574 - ], - "xyz": [ - 19.131316213740785, - 21.938484394607165, - 16.469218314197704 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.695021139107281, - 0.6994623882892584, - 0.10152524407031165 - ], - "xyz": [ - 10.950958731846216, - 10.890238772455074, - 19.065127779530556 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7041612892343028, - 0.6983145367816004, - 0.30193323703862496 - ], - "xyz": [ - 13.675207519070831, - 13.755143266188737, - 19.174397047640742 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6983229708677189, - 0.6981390106891948, - 0.5056932837813285 - ], - "xyz": [ - 16.45857844018799, - 16.461093510635937, - 19.09217684868944 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6992058050188996, - 0.6980725901177622, - 0.7055611081217467 - ], - "xyz": [ - 19.19022726826488, - 19.20572037841455, - 19.103338708197313 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.695609418543541, - 0.7044825305376052, - 0.9013611224630644 - ], - "xyz": [ - 21.954805371967613, - 21.833493781944924, - 19.141805111286594 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6953420942796521, - 0.9043824896759103, - 0.10123181230439234 - ], - "xyz": [ - 13.74857772610034, - 10.890615067513869, - 21.871146561415333 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7035206365698327, - 0.8946044915441891, - 0.30112504080757363 - ], - "xyz": [ - 16.347798934997474, - 13.735334864881969, - 21.84927908905184 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6990032600497806, - 0.9000760795980761, - 0.5050380627175602 - ], - "xyz": [ - 19.210467633193762, - 16.461436237436985, - 21.862324897384358 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7053966259943107, - 0.8964955395054439, - 0.6987899132740021 - ], - "xyz": [ - 21.810455559019083, - 19.197785611299302, - 21.90078134612285 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7047161106954993, - 0.8954443892995929, - 0.8995159011765679 - ], - "xyz": [ - 24.54037399853778, - 21.932771304552762, - 21.8771063270429 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9016140344289209, - 0.09512276053734309, - 0.10404174062063698 - ], - "xyz": [ - 2.7229412102216948, - 13.749144738438044, - 13.627206048155664 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8966906971812817, - 0.09784705347348671, - 0.3001983782412027 - ], - "xyz": [ - 5.4420054942255245, - 16.36365199914263, - 13.597141110156874 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9041164525016296, - 0.09497091468069112, - 0.4998727810022846 - ], - "xyz": [ - 8.13259593551242, - 19.195088082403483, - 13.659342648390595 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9031459161628017, - 0.09544117066258757, - 0.698292281617684 - ], - "xyz": [ - 10.851780887554462, - 21.894574781179198, - 13.652502905401093 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8991612870368653, - 0.10127099500154166, - 0.895260472240224 - ], - "xyz": [ - 13.624398844465315, - 24.533011296919693, - 13.67773008221833 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9010944230198233, - 0.2997729180517303, - 0.09499966281371841 - ], - "xyz": [ - 5.397259666527858, - 13.618419044580731, - 16.418042131008885 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9027280358512672, - 0.2962324883527737, - 0.3037722583233914 - ], - "xyz": [ - 8.203156895702127, - 16.495054851902978, - 16.391972474023287 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9012276808015283, - 0.2993733168328668, - 0.4951578150533054 - ], - "xyz": [ - 10.862686619544005, - 19.09113114993803, - 16.414400731477873 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8981480396184403, - 0.2968913143998651, - 0.7054750407676351 - ], - "xyz": [ - 13.704172381906131, - 21.92444610288395, - 16.338362941054548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9048185186596569, - 0.2958164977431484, - 0.8985841019097253 - ], - "xyz": [ - 16.32963000634615, - 24.655796015952888, - 16.4148658299562 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9039586051372229, - 0.5025077303457609, - 0.09628291934812354 - ], - "xyz": [ - 8.186557980297842, - 13.675122079289247, - 19.228954574782964 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8989603164524377, - 0.5024512920814275, - 0.3034923061856662 - ], - "xyz": [ - 11.018715805660015, - 16.43971581523608, - 19.159847257785465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9035572114422545, - 0.49571536096484964, - 0.49790832213109937 - ], - "xyz": [ - 13.584644143024855, - 19.16058451121885, - 19.130602740886893 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.90039806757956, - 0.5050944390576497, - 0.6982878586503138 - ], - "xyz": [ - 16.45242616544969, - 21.85694621994811, - 19.215640562092734 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9017823494265225, - 0.5042293388836243, - 0.8955450040622485 - ], - "xyz": [ - 19.13746285737424, - 24.572736057974844, - 19.222738720472428 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8988345286122784, - 0.6981585304477786, - 0.10563046551739458 - ], - "xyz": [ - 10.989258470816575, - 13.732864596041946, - 21.833801644718466 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8971268039770287, - 0.6965511323202657, - 0.30189608749899044 - ], - "xyz": [ - 13.6505906688693, - 16.392825148139664, - 21.788477883028072 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9053152373071542, - 0.6994834797076266, - 0.4988855487812197 - ], - "xyz": [ - 16.383885651074376, - 19.19798039125875, - 21.940519195257018 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8959414992480688, - 0.697603251810408, - 0.7028511891295952 - ], - "xyz": [ - 19.146761034732354, - 21.858405852815512, - 21.7866569984163 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8989462651335292, - 0.6992065660424628, - 0.8964576888762559 - ], - "xyz": [ - 21.815634473682834, - 24.546439686510055, - 21.849657840328547 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8960742562168317, - 0.9013049624500191, - 0.10468572162614585 - ], - "xyz": [ - 13.753723554366193, - 13.682210280273177, - 24.573445149353823 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9033553021520719, - 0.8978526832488435, - 0.30305221576546104 - ], - "xyz": [ - 16.418555616441747, - 16.493786431615284, - 24.62579135896394 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9041551505479857, - 0.9022918214236801, - 0.49664439379953274 - ], - "xyz": [ - 19.126004126013022, - 19.151479226401285, - 24.697417840341657 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8980716527938646, - 0.8971372106899356, - 0.7055533187769629 - ], - "xyz": [ - 21.91169643457613, - 21.924471958821467, - 24.543772443955085 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8976095622898402, - 0.905470678986911, - 0.8996739412696287 - ], - "xyz": [ - 24.679612322115762, - 24.572136549634415, - 24.65138850429231 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15481277846199248, - 0.14911074378440972, - 0.15045523393970525 - ], - "xyz": [ - 4.095612125568109, - 4.1735693173137784, - 4.155187689918806 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15196210551008565, - 0.14739823954389694, - 0.35435162372838835 - ], - "xyz": [ - 6.859833815683295, - 6.922230169677153, - 4.09280075271594 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14921264262493464, - 0.1502802456683158, - 0.5456433873962478 - ], - "xyz": [ - 9.514542645004761, - 9.499946568364201, - 4.094612860025427 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14440893470436267, - 0.15286503122377473, - 0.7516371619653536 - ], - "xyz": [ - 12.366191174886987, - 12.250580945370958, - 4.064276152855627 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14761060601789933, - 0.14657704110432881, - 0.9550294737128673 - ], - "xyz": [ - 15.060965981408037, - 15.075096694864689, - 4.0220805576786205 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15041601470043364, - 0.347583187716577, - 0.15520270241510928 - ], - "xyz": [ - 6.87399818842019, - 4.178364089034622, - 6.808555455588933 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1485525585150459, - 0.349051266235402, - 0.3468697885190834 - ], - "xyz": [ - 9.514507394813467, - 6.773325152628149, - 6.803149923299668 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14613841905394795, - 0.34742580710020327, - 0.5524808360994784 - ], - "xyz": [ - 12.303361642630271, - 9.551396704991717, - 6.747921258418847 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1533554055935905, - 0.3445923398459668, - 0.750423239484287 - ], - "xyz": [ - 14.97085589779895, - 12.356298955348626, - 6.807851945055448 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14935211257216385, - 0.34992395744216626, - 0.9549796905648343 - ], - "xyz": [ - 17.840407792895068, - 15.098225632764473, - 6.826012559543318 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14916498867797076, - 0.5527789261227252, - 0.15309161738909255 - ], - "xyz": [ - 9.65053501419574, - 4.132397911959797, - 9.59685085325045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14862966779553272, - 0.5505848866728225, - 0.35490969031641345 - ], - "xyz": [ - 12.379758867572974, - 6.884299467022067, - 9.559535530071546 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14950007220781455, - 0.5466649117565063, - 0.555425209646554 - ], - "xyz": [ - 15.067577763600786, - 9.63761156696219, - 9.51784235106308 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14775089459228805, - 0.5458481992754372, - 0.7526747950167175 - ], - "xyz": [ - 17.753172643823365, - 12.310457951710193, - 9.482761963522641 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1509815696499897, - 0.5519080071347439, - 0.9443985567255817 - ], - "xyz": [ - 20.457234005916874, - 14.975839919384063, - 9.609779773677054 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15530343517730275, - 0.7464396969352034, - 0.14984009377981325 - ], - "xyz": [ - 12.253775968293377, - 4.171867402066478, - 12.328469788478403 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14797250443629423, - 0.75111794775454, - 0.35478837360731924 - ], - "xyz": [ - 15.119752162521491, - 6.873656227654235, - 12.29220282607169 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1500794844996607, - 0.7446102577591064, - 0.5523557136319488 - ], - "xyz": [ - 17.731885306983656, - 9.6035675905197, - 12.232037112008255 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14721411072969193, - 0.7495793398012047, - 0.7554926990518672 - ], - "xyz": [ - 20.577074002232205, - 12.341645016107714, - 12.260798632837322 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14531738930673388, - 0.7532372800041185, - 0.9529456185253862 - ], - "xyz": [ - 23.32662547577365, - 15.015254155739335, - 12.284877698977496 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14551118733449644, - 0.9508255246565853, - 0.14902152059118537 - ], - "xyz": [ - 15.036910830159375, - 4.026798166872495, - 14.98891818573391 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15114290952018553, - 0.94436164420392, - 0.35250515269546806 - ], - "xyz": [ - 17.73052941118499, - 6.885785649961217, - 14.977541067696299 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15501057785173178, - 0.9465479342674676, - 0.5476243059404166 - ], - "xyz": [ - 20.42805391711895, - 9.606297656927168, - 15.060309697161511 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14712155791632106, - 0.9483009926872366, - 0.7489958702638437 - ], - "xyz": [ - 23.205137196831835, - 12.25155617694214, - 14.976419935792729 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15477691910968275, - 0.9511010161269633, - 0.9480680335740871 - ], - "xyz": [ - 25.96509739708381, - 15.077897681001016, - 15.11936407252708 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3490197542553235, - 0.1528495111876806, - 0.14503382387419614 - ], - "xyz": [ - 4.0726073379656675, - 6.754611590542729, - 6.861466260668972 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3547203885371239, - 0.15133381919740377, - 0.34766082766248246 - ], - "xyz": [ - 6.8221649928319295, - 9.602829559262101, - 6.918682038389069 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34947901002069043, - 0.15525395490942373, - 0.5461743387325387 - ], - "xyz": [ - 9.589801373580054, - 12.245211366551372, - 6.900618244590833 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3455573354046971, - 0.14836628450119602, - 0.75414878994283 - ], - "xyz": [ - 12.339023645085321, - 15.034984198648825, - 6.752834825101786 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.353547822100123, - 0.14700715090597827, - 0.9530115993840889 - ], - "xyz": [ - 15.039258350590744, - 17.863045229836274, - 6.843497491044275 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35399785917257665, - 0.3448440060682226, - 0.15079880286820224 - ], - "xyz": [ - 6.776339268073191, - 6.901489100022361, - 9.554440190036463 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3449689435792419, - 0.3541726870338764, - 0.35077783353161335 - ], - "xyz": [ - 9.637956626077672, - 9.512124702239731, - 9.558538528249041 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3537558370474723, - 0.34982836545570295, - 0.5515824604001366 - ], - "xyz": [ - 12.323926557152383, - 12.377622241810167, - 9.61927657146696 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34842946076492926, - 0.35560510017676766, - 0.7487925881425045 - ], - "xyz": [ - 15.09912640311719, - 15.00102235269363, - 9.62543379097391 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35439259301428616, - 0.3511458774927184, - 0.9453086408661945 - ], - "xyz": [ - 17.72489281318975, - 17.76928132339183, - 9.645994971847074 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35529685898320434, - 0.5501361709239636, - 0.1477835811491023 - ], - "xyz": [ - 9.541833224787583, - 6.878025223009672, - 12.378917406945416 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3527208705834818, - 0.5527709481231081, - 0.3498205113285478 - ], - "xyz": [ - 12.340067967160337, - 9.605019316052523, - 12.37972115682913 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3457009636023107, - 0.5480869204246395, - 0.5521320002426555 - ], - "xyz": [ - 15.041995043957535, - 12.275010671754885, - 12.219707068597335 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35271761580521976, - 0.5530273578801184, - 0.7448601728546073 - ], - "xyz": [ - 17.744484700449636, - 15.005885962555194, - 12.383182246130678 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3470511559147592, - 0.55066136696937, - 0.9471697611213257 - ], - "xyz": [ - 20.478077573652932, - 17.694355417952284, - 12.273364024617694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34465077327065496, - 0.7504111672543099, - 0.15355504447405866 - ], - "xyz": [ - 12.358863332832144, - 6.811380263158529, - 14.971489739708023 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3549153249674808, - 0.7467094556706385, - 0.3473132698987797 - ], - "xyz": [ - 14.957281779894481, - 9.600742947864436, - 15.06121570842385 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3502598393638148, - 0.746300437980707, - 0.5551596458570034 - ], - "xyz": [ - 17.793328003414086, - 12.378732226431685, - 14.991974731004378 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3499095635529296, - 0.7539864293653192, - 0.7512020177133248 - ], - "xyz": [ - 20.578665514538745, - 15.054199338987601, - 15.09226731389957 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35565994922632127, - 0.7478641151839825, - 0.9487516859289491 - ], - "xyz": [ - 23.1958258419718, - 17.833681081748527, - 15.087182374286078 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34747856571275504, - 0.949241545381125, - 0.1477015033321097 - ], - "xyz": [ - 14.997207912258576, - 6.770012771568962, - 17.72852394925553 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34621022339106594, - 0.9543265124716142, - 0.34748338861958505 - ], - "xyz": [ - 17.798110641936677, - 9.484054198559457, - 17.780704156102104 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34944565439851955, - 0.9504391614099204, - 0.5546850947337902 - ], - "xyz": [ - 20.577787907630704, - 12.361112858602095, - 17.771791222466142 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3487904066026516, - 0.9478567973203847, - 0.7556549217683814 - ], - "xyz": [ - 23.290105591272173, - 15.099777729329656, - 17.727527175539045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3490095745218357, - 0.9453428561642636, - 0.954359510203105 - ], - "xyz": [ - 25.972388806548715, - 17.819427519924137, - 17.696153448902823 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5453090931841896, - 0.14913858862864413, - 0.1543845125819885 - ], - "xyz": [ - 4.149713205593551, - 9.566085033186148, - 9.494363705162336 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5551747288602592, - 0.14661499693159216, - 0.35042739522242333 - ], - "xyz": [ - 6.795474117899111, - 12.3812292320761, - 9.594742808875548 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5513479954194621, - 0.14604884324910186, - 0.5479461819532985 - ], - "xyz": [ - 9.48817506546268, - 15.029352120088454, - 9.534684046845646 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5552721603864386, - 0.1488178210299138, - 0.7496545916769584 - ], - "xyz": [ - 12.283753101494067, - 17.840723667395388, - 9.626191489727713 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5518126782839798, - 0.15033661770450105, - 0.9445879849383344 - ], - "xyz": [ - 14.96961208090437, - 20.458520515456097, - 9.599658787881232 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5482337339268475, - 0.34668904135300804, - 0.15539895398177875 - ], - "xyz": [ - 6.864456696378044, - 9.619939455202912, - 12.235223097526633 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5553298764244239, - 0.346533453484481, - 0.34983443888962595 - ], - "xyz": [ - 9.520616478318162, - 12.375243589396932, - 12.330113111115162 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5515687569056837, - 0.3526245819340266, - 0.5443541839962072 - ], - "xyz": [ - 12.263332231620288, - 14.98326118188129, - 12.361968573815528 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5469910634439319, - 0.3464387938093383, - 0.7533719052128512 - ], - "xyz": [ - 15.03641391110555, - 17.778328442141177, - 12.214812190992403 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5515069367163836, - 0.34472975449989784, - 0.9536432962991543 - ], - "xyz": [ - 17.751122643375496, - 20.57814305874649, - 12.25318671970458 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5449694622621677, - 0.5515504395891959, - 0.15392735819797285 - ], - "xyz": [ - 9.645165465342568, - 9.555191527903357, - 14.991422724529508 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5485329060925127, - 0.5481262366189028, - 0.3476647864133047 - ], - "xyz": [ - 12.247093624512194, - 12.252653536354885, - 14.993326400504783 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5553022499485899, - 0.5499979280438536, - 0.5465835707946335 - ], - "xyz": [ - 14.992264867450002, - 15.064784601753614, - 15.111465079480647 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5513643151264308, - 0.551166744259101, - 0.7530303158632058 - ], - "xyz": [ - 17.830747450521354, - 17.83344860385673, - 15.073606188328299 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5443688647812134, - 0.551967442246396, - 0.9511098628038042 - ], - "xyz": [ - 20.549802360731427, - 20.445915977371392, - 14.98891264914621 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.552940702105473, - 0.7502318972192713, - 0.14456661323260322 - ], - "xyz": [ - 12.233524171166147, - 9.536194463985415, - 17.816741206900023 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5490382078906738, - 0.7450740791239644, - 0.3523066617889631 - ], - "xyz": [ - 15.003191961228179, - 12.323024816183452, - 17.69287024785247 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5549655578906946, - 0.7469175315023538, - 0.5471345313467543 - ], - "xyz": [ - 17.692046873901692, - 15.067714042038336, - 17.799111259225665 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5500892286703286, - 0.7552567791884072, - 0.7464895094694534 - ], - "xyz": [ - 20.53160494419831, - 17.726591123674233, - 17.84645565716322 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.548978882334709, - 0.7450630215017907, - 0.9526888206765078 - ], - "xyz": [ - 23.211357590930103, - 20.530530535382812, - 17.69190798170993 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.54567525151229, - 0.9511705251482474, - 0.1485533544228461 - ], - "xyz": [ - 15.035226931197665, - 9.491368539196111, - 20.464606026263066 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5526627994363166, - 0.9463829052782083, - 0.3471077899882272 - ], - "xyz": [ - 17.68437195735756, - 12.301501539906265, - 20.494683046630133 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5532541285500372, - 0.9447614101734342, - 0.5522831871728219 - ], - "xyz": [ - 20.46732426689049, - 15.114707183846098, - 20.48059880263033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5547285731248575, - 0.9470310138349167, - 0.7468167307726462 - ], - "xyz": [ - 23.157981471680568, - 17.794493116731967, - 20.531786756188378 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5456741343717845, - 0.9548508705063347, - 0.9490473947951189 - ], - "xyz": [ - 26.029754381513715, - 20.43556369689465, - 20.514907772192764 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7447983101292254, - 0.14996837057151488, - 0.15148044588410312 - ], - "xyz": [ - 4.121353957794247, - 12.253761822038143, - 12.233089000537992 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7505260557415135, - 0.15084942652745534, - 0.34476307646570103 - ], - "xyz": [ - 6.775924930671894, - 14.974595863493239, - 12.323443345994534 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7451848813005244, - 0.1544629746119308, - 0.5498855177352142 - ], - "xyz": [ - 9.629725804641543, - 17.70596938294479, - 12.299823549421022 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.749184594693698, - 0.14923638181457208, - 0.7553083445972795 - ], - "xyz": [ - 12.36677268145208, - 20.56915665725717, - 12.283049875045297 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7483999163969319, - 0.15297094927364704, - 0.9532520735679842 - ], - "xyz": [ - 15.12408204814667, - 23.264679709442138, - 12.323380228692335 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7463311995951547, - 0.3512098962364615, - 0.154792267449193 - ], - "xyz": [ - 6.917970501520804, - 12.319997839206254, - 15.005384304812605 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7542536604108941, - 0.3450127448076459, - 0.35058921020719486 - ], - "xyz": [ - 9.510144720610999, - 15.105212855373798, - 15.028972424194938 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499632752535738, - 0.35323623220414774, - 0.5521245841482828 - ], - "xyz": [ - 12.377930116223485, - 17.80191083792749, - 15.082745090050624 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7470251678480979, - 0.3496944302741245, - 0.7554487990661002 - ], - "xyz": [ - 15.10931930575827, - 20.541553630336868, - 14.994152935999361 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7523664262962403, - 0.3532869092579499, - 0.9495132584491727 - ], - "xyz": [ - 17.811649388861593, - 23.26779271149603, - 15.116293386096487 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7550958643747911, - 0.5491176013366684, - 0.14985684156866624 - ], - "xyz": [ - 9.556252768002011, - 12.372350504171877, - 17.830971744783245 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7443577138881768, - 0.5514811009828626, - 0.35151157002952876 - ], - "xyz": [ - 12.345553259400631, - 14.982527593251763, - 17.716475025930173 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7457211214449956, - 0.5480464915421306, - 0.5540617187297534 - ], - "xyz": [ - 15.067825071359348, - 17.770397029957934, - 17.68815792658965 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.751016664102042, - 0.5519954657766069, - 0.7526038258167366 - ], - "xyz": [ - 17.836246686791704, - 20.557228686481352, - 17.814547297517507 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7460955561964515, - 0.5529208645150895, - 0.9535800344353283 - ], - "xyz": [ - 20.5966091202883, - 23.237658733511378, - 17.759918681012458 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7536758651765294, - 0.7448568818317216, - 0.1496625775103882 - ], - "xyz": [ - 12.229709034622642, - 12.350280587495853, - 20.487669981202345 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7538671374008835, - 0.7501522112708282, - 0.35117457243518324 - ], - "xyz": [ - 15.05714154800752, - 15.107931349370933, - 20.562681811556878 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7453433224481458, - 0.7524968947470827, - 0.5536375169356267 - ], - "xyz": [ - 17.857234572331897, - 17.759432219503847, - 20.478201838254066 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7470104449576339, - 0.7507094225168363, - 0.7471844288303975 - ], - "xyz": [ - 20.478935114726134, - 20.428363359352684, - 20.47655643853481 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7476387723587105, - 0.7475882030196347, - 0.9491809457345056 - ], - "xyz": [ - 23.197922383319828, - 23.198613758221192, - 20.442474066517164 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7499830718915373, - 0.9523838460330301, - 0.152990879195889 - ], - "xyz": [ - 15.112484275879238, - 12.345297323956094, - 23.274454075819456 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7536084770217796, - 0.9446803990046984, - 0.3513805015195224 - ], - "xyz": [ - 17.71951134100505, - 15.107210416600541, - 23.218699821036317 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7544933701037719, - 0.9453125971084432, - 0.5493376048783749 - ], - "xyz": [ - 20.434588524527417, - 17.825742400380413, - 23.239441218651304 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7551266471381094, - 0.9459419979057948, - 0.7495477257206514 - ], - "xyz": [ - 23.180430313270517, - 20.57163718433786, - 23.256704322684147 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7459151144609414, - 0.9529574660297946, - 0.9476255194732783 - ], - "xyz": [ - 25.98442847286062, - 23.15378270983454, - 23.22668012340485 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9552947572938059, - 0.1464997531705499, - 0.1482547942245436 - ], - "xyz": [ - 4.029831116167187, - 15.087530829439599, - 15.063536224056786 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9449776710166146, - 0.14982872779298187, - 0.35108113447601796 - ], - "xyz": [ - 6.848349473166556, - 17.719482698110284, - 14.967996019373016 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9487952276440258, - 0.14962863368999443, - 0.5552882282693662 - ], - "xyz": [ - 9.637496451673226, - 20.56355827422583, - 15.017453315863683 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9471481008627192, - 0.1531645990507617, - 0.753388889834809 - ], - "xyz": [ - 12.394236120415522, - 23.249435640158275, - 15.043277176931124 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.951012501501151, - 0.14854363114322394, - 0.9546990799880698 - ], - "xyz": [ - 15.083335762899043, - 26.054545714035957, - 15.032933525410016 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9491184625038841, - 0.34540341452533146, - 0.1545312298360095 - ], - "xyz": [ - 6.835016469472268, - 15.088899936726403, - 17.698470088805568 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9482330255602309, - 0.3459010583451107, - 0.35117137500321105 - ], - "xyz": [ - 9.530248835700252, - 17.765223071711276, - 17.693168251018726 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9504651508833596, - 0.34471621698583105, - 0.5537490960337712 - ], - "xyz": [ - 12.283656035847658, - 20.565346425286563, - 17.707486528861356 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.950207892700604, - 0.3534265378623353, - 0.7517144580445208 - ], - "xyz": [ - 15.109288770659271, - 23.26837603336421, - 17.823055280459002 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.948324469321883, - 0.3528300299895137, - 0.9534134551500693 - ], - "xyz": [ - 17.85872580500105, - 26.000218590554123, - 17.789150106775537 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9555865074253905, - 0.5490620033003991, - 0.14720610231995268 - ], - "xyz": [ - 9.519252211782437, - 15.077182057768578, - 20.571283601911063 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9546436923970705, - 0.5514061068810646, - 0.34611100964637515 - ], - "xyz": [ - 12.27069246408218, - 17.78368415049162, - 20.59044176676679 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9492532992525096, - 0.551078800924423, - 0.5543923398747675 - ], - "xyz": [ - 15.113802452201186, - 20.55757252193309, - 20.512270413840987 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9479351035738746, - 0.5467853377677346, - 0.7499195186352042 - ], - "xyz": [ - 17.728315389866825, - 23.212762781010525, - 20.435548824343037 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9499882479253768, - 0.5458524658463282, - 0.9550361907788102 - ], - "xyz": [ - 20.519879553420697, - 26.045151221564677, - 20.45086498735827 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9528327893741253, - 0.7516855238803578, - 0.1510770907478933 - ], - "xyz": [ - 12.342407969926814, - 15.092457177249814, - 23.303867565518907 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9518385476986905, - 0.744303896371007, - 0.35174420582732274 - ], - "xyz": [ - 14.984972364597168, - 17.822348761312018, - 23.18935418968097 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9545654401762759, - 0.7485524048022465, - 0.5456540448320953 - ], - "xyz": [ - 17.694157622239786, - 20.51073075952715, - 23.28472061533426 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9481830223150663, - 0.7498261506161558, - 0.7553555184123546 - ], - "xyz": [ - 20.578572846257366, - 23.290472291887966, - 23.214875770664538 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.946658401712775, - 0.7517367299751192, - 0.947069871661656 - ], - "xyz": [ - 23.225778072389694, - 25.89071208248601, - 23.220152529313186 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9467863400861368, - 0.9553905409389186, - 0.1480229061063201 - ], - "xyz": [ - 15.085670033582035, - 14.968034948278955, - 26.00621992553597 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9538232750228517, - 0.9447804706878076, - 0.35019878975523866 - ], - "xyz": [ - 17.704723352510445, - 17.82835494567439, - 25.957368662681905 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9450155448052975, - 0.9515925669892267, - 0.5539543551388454 - ], - "xyz": [ - 20.583566520889015, - 20.49364665745433, - 25.93008471499461 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9473924323499684, - 0.9518889671659202, - 0.7544033426186341 - ], - "xyz": [ - 23.328121326758662, - 23.266645512131237, - 25.966633423529313 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9489864841022708, - 0.9552161175327848, - 0.9461283418772711 - ], - "xyz": [ - 25.994839207051587, - 25.90966878012362, - 26.033915213086186 - ], - "label": "Si", - "properties": {} - } - ] - }, - { - "@module": "pymatgen.core.structure", - "@class": "Structure", - "charge": null, - "lattice": { - "matrix": [ - [ - 0.0, - 13.671819999999999, - 13.671819999999999 - ], - [ - 13.671819999999999, - 0.0, - 13.671819999999999 - ], - [ - 13.671819999999999, - 13.671819999999999, - 0.0 - ] - ], - "a": 19.334873266323726, - "b": 19.334873266323726, - "c": 19.334873266323726, - "alpha": 59.99999999999999, - "beta": 59.99999999999999, - "gamma": 59.99999999999999, - "volume": 5111.036606083104 - }, - "sites": [ - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09841179355078757, - 0.10168240092614332, - 0.10485911805681639 - ], - "xyz": [ - 2.823798470061608, - 2.7790833147350718, - 2.735651809933593 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10496191700816095, - 0.09579630536960244, - 0.29728421527593174 - ], - "xyz": [ - 5.374126123772027, - 5.499436716284303, - 2.7447302798687527 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09547093739375047, - 0.09733515160216519, - 0.5036647902518031 - ], - "xyz": [ - 8.21676302503792, - 8.191275823939032, - 2.636010143656139 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09626773111606461, - 0.10478157232851203, - 0.7023174797080365 - ], - "xyz": [ - 11.034512961614324, - 10.91811325704916, - 2.7487098878196314 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10436857593040627, - 0.10109228075843887, - 0.8942437498543447 - ], - "xyz": [ - 13.608055050052466, - 13.652847967910473, - 2.8090238496956865 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10363697464431959, - 0.2940490250807679, - 0.10011291674524987 - ], - "xyz": [ - 5.388911119495786, - 2.7856318400977433, - 5.437091404761445 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09810360429085195, - 0.29506506115607845, - 0.3023631222699531 - ], - "xyz": [ - 8.167930586727685, - 5.475109001528545, - 5.375331223630651 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10345883421157295, - 0.2941598541035249, - 0.502706084013477 - ], - "xyz": [ - 10.894607670066788, - 8.287377652287603, - 5.43617113528012 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09488261137339483, - 0.3050749844465565, - 0.7009030108569699 - ], - "xyz": [ - 13.753550075750656, - 10.879837785721545, - 5.468148257683127 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09936344798494508, - 0.30398373622302277, - 0.902302714733091 - ], - "xyz": [ - 16.492131225910814, - 13.694599476771698, - 5.514490099998178 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09931376156600703, - 0.4975222822689349, - 0.09700574118425041 - ], - "xyz": [ - 8.128280121607727, - 2.6840449040910244, - 8.159834960823435 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10202190954873905, - 0.4968137649621392, - 0.30497426742720346 - ], - "xyz": [ - 10.961901656981262, - 5.56437847230323, - 8.187173551491314 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1025759341521456, - 0.4942524934614729, - 0.499488108658269 - ], - "xyz": [ - 13.586242638872728, - 8.23131122177628, - 8.15973083321642 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10180779754357198, - 0.4953836928972249, - 0.6978703532705812 - ], - "xyz": [ - 16.313954533477933, - 10.933055735863954, - 8.164694562838294 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10553520603846146, - 0.4964014907514788, - 0.9010361507969316 - ], - "xyz": [ - 19.105515896474387, - 13.761662407809261, - 8.22957016990664 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09807272629581214, - 0.7061776863593968, - 0.09673725040004195 - ], - "xyz": [ - 10.977308490686429, - 2.663406935589912, - 10.995566876747738 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10486970121606945, - 0.7001326119109316, - 0.3004361944357566 - ], - "xyz": [ - 13.679596617986777, - 5.541269250290548, - 11.005846724655994 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09495860568391794, - 0.7025722921431535, - 0.5042692363797469 - ], - "xyz": [ - 16.49972014648996, - 8.192535195682852, - 10.903698879530111 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.0964875869063614, - 0.6982562460206734, - 0.699141836548788 - ], - "xyz": [ - 19.104975053234813, - 10.87770226418258, - 10.865594629888491 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10021683759776268, - 0.700617598509492, - 0.9047171084687801 - ], - "xyz": [ - 21.947847153559678, - 13.73927602251148, - 10.948864260259885 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10475223388413683, - 0.9011085820182577, - 0.09456839798925416 - ], - "xyz": [ - 13.6127164488063, - 2.725075801259264, - 13.751948020070675 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09523572907102867, - 0.8976574395590928, - 0.3037263506217997 - ], - "xyz": [ - 16.425102930270928, - 5.454537740386004, - 13.574656680740667 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09861718761661321, - 0.89463587920204, - 0.503211154777902 - ], - "xyz": [ - 19.11111303610765, - 8.22808876811618, - 13.579577143992598 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.10120092992807747, - 0.9025221399887775, - 0.6937358999750107 - ], - "xyz": [ - 21.823752595937716, - 10.868233249805638, - 13.722721141750654 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.09441562167703284, - 0.9023545609549187, - 0.8992113584672892 - ], - "xyz": [ - 24.630684968474927, - 13.584689219676743, - 13.627662518311167 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30448888963600573, - 0.09856519344542564, - 0.09482421249654369 - ], - "xyz": [ - 2.6439851479455347, - 5.459336855997831, - 5.510482874154374 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2983806603472553, - 0.10512599655113293, - 0.29520917397105556 - ], - "xyz": [ - 5.473310391048667, - 8.115453368629767, - 5.516670381916522 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2970396134178732, - 0.09592023956431911, - 0.5022337926289427 - ], - "xyz": [ - 8.17785426042048, - 10.927522138258977, - 5.372476377198996 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3061809549365091, - 0.09796314666561223, - 0.6967967017743346 - ], - "xyz": [ - 10.865813591098233, - 13.712529986572445, - 5.525385411165914 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30251206986696044, - 0.0995269609365106, - 0.8942430738250766 - ], - "xyz": [ - 13.586645036654161, - 16.361820908631664, - 5.496605262119511 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30473842358353825, - 0.3002699322721903, - 0.09446004620168202 - ], - "xyz": [ - 5.3966772142986565, - 5.45776962317897, - 8.271565339755465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2998744440198188, - 0.29545557869930417, - 0.3056461314027136 - ], - "xyz": [ - 8.218154382206967, - 8.278568313473285, - 8.139244911211758 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29656451795598593, - 0.303280931887216, - 0.5040092092175911 - ], - "xyz": [ - 11.037125496959522, - 10.945299894646253, - 8.200979018075284 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2964080628552885, - 0.30605049641089627, - 0.6994658569887915 - ], - "xyz": [ - 13.747238590736917, - 13.615408974802687, - 8.236704979746609 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2938126250249869, - 0.3024212334873212, - 0.9008197470832275 - ], - "xyz": [ - 16.450494102984038, - 16.332798757636528, - 8.151601991485743 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3029325152792723, - 0.4960866281349235, - 0.09667571723502594 - ], - "xyz": [ - 8.10414008867578, - 5.463371825453632, - 10.924045905313069 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2940936101384785, - 0.5016590011181309, - 0.30397319761225466 - ], - "xyz": [ - 11.014458407246059, - 8.176661743542628, - 10.879386465630336 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29865469389577665, - 0.49980970885956394, - 0.5057914485537826 - ], - "xyz": [ - 13.748398015946938, - 10.998242859264732, - 10.91646159087852 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30050448477492303, - 0.5057796384048574, - 0.6970763175532366 - ], - "xyz": [ - 16.445230115786988, - 13.638745164886178, - 11.023371400971785 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3023246193453962, - 0.4937477849603152, - 0.9011600087030542 - ], - "xyz": [ - 19.070928271562725, - 16.453825207445362, - 10.88375861863491 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3018057104344447, - 0.6942296537440419, - 0.09985129101471177 - ], - "xyz": [ - 10.856531742171622, - 5.491382225552606, - 13.617616212682716 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29979177710924965, - 0.7052794173115362, - 0.299986811915857 - ], - "xyz": [ - 13.743818938075657, - 8.200064909005233, - 13.741152457305986 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.30549019411543343, - 0.7001370117384575, - 0.49912359601044026 - ], - "xyz": [ - 16.396075162233537, - 11.000534908118722, - 13.748754145537342 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.304069456325904, - 0.6952773093136766, - 0.6976413270397668 - ], - "xyz": [ - 19.043732870869732, - 13.695209522234444, - 13.662889097406529 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2943194626568181, - 0.7026579761672911, - 0.903701934155319 - ], - "xyz": [ - 21.961863549146862, - 16.37913289336411, - 13.63049608766423 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3024500256000118, - 0.9033907922498464, - 0.09400213012091392 - ], - "xyz": [ - 13.636176503927006, - 5.420222511628466, - 16.486038610296045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3011370231405194, - 0.8938664717202665, - 0.30147265923762895 - ], - "xyz": [ - 16.34246143741277, - 8.238771107731214, - 16.337872681107587 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.29399116779794837, - 0.9015065183845304, - 0.5006718961611953 - ], - "xyz": [ - 19.170330891554542, - 10.864490371097899, - 16.344629175903336 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3051359925488511, - 0.9009824974102256, - 0.6988691644215032 - ], - "xyz": [ - 21.872883947264263, - 13.726577785170427, - 16.489834893392302 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.2977417185443068, - 0.9050375335790211, - 0.8955151756350558 - ], - "xyz": [ - 24.6168325408872, - 16.31399347097929, - 16.444181434764754 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5058786138757636, - 0.09980412101994583, - 0.0959847504613748 - ], - "xyz": [ - 2.6767902088957487, - 8.228567581811774, - 8.280785328601857 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49999309745570525, - 0.09636265062802536, - 0.2977216039282509 - ], - "xyz": [ - 5.387848993127589, - 10.906211808675199, - 8.153268443766109 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5002498236848011, - 0.09719205778355353, - 0.49668121904604023 - ], - "xyz": [ - 8.119328543624375, - 13.62986176862837, - 8.16811786389668 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49806186161630667, - 0.09620221126900634, - 0.6997963844539709 - ], - "xyz": [ - 10.882749520977313, - 16.37690232578854, - 8.124671436954879 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49695264911396175, - 0.0974493413623401, - 0.9061185034985899 - ], - "xyz": [ - 13.720598932726558, - 19.182536245711333, - 8.126557021433712 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4999525211553232, - 0.3041389336324452, - 0.09421287053242669 - ], - "xyz": [ - 5.446194163217378, - 8.123322285384411, - 10.993393633396506 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.500346023894358, - 0.3054918943151362, - 0.2953234963390323 - ], - "xyz": [ - 8.214239874253472, - 10.87825046011727, - 11.017270966934927 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5058907740905522, - 0.29645109721941765, - 0.49751356158931903 - ], - "xyz": [ - 10.854941901594461, - 13.718363464634775, - 10.969473643013071 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5024493398586967, - 0.29684154488705916, - 0.7046715403282053 - ], - "xyz": [ - 13.692506628707756, - 16.50353939215689, - 10.927761103884718 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4972329399700741, - 0.3009716956105003, - 0.8962454394344099 - ], - "xyz": [ - 16.368137171249703, - 19.051385577109812, - 10.912910100823208 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5006675961013717, - 0.49389538591925747, - 0.10200906340851114 - ], - "xyz": [ - 8.147098368408372, - 8.239686807020405, - 13.597486068849276 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5021446615562607, - 0.4966728169870678, - 0.29628253078446193 - ], - "xyz": [ - 10.841142782769754, - 10.915952856787737, - 13.655652779498247 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.496723479629593, - 0.4959980351925811, - 0.5039996067444805 - ], - "xyz": [ - 13.671787760987957, - 13.681705906750784, - 13.572309860776095 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4975247405601758, - 0.5018238194403082, - 0.6956441715237252 - ], - "xyz": [ - 16.371566828221887, - 16.312790595606916, - 13.662913629585816 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49384372687649286, - 0.5029606118519014, - 0.902527389444703 - ], - "xyz": [ - 19.21557896588694, - 19.09093455554245, - 13.628129494313635 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5044973771919107, - 0.6956442986521302, - 0.09725608949309536 - ], - "xyz": [ - 10.840391384651655, - 8.227065080893398, - 16.408120966638073 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5010593391536025, - 0.6949393248310163, - 0.30506344684286196 - ], - "xyz": [ - 13.67185789382636, - 11.021165628042182, - 16.351478454238187 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4998391812434867, - 0.7032377868888018, - 0.5028350850081565 - ], - "xyz": [ - 16.489211211458272, - 13.708382086824539, - 16.448251754450382 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49841342655560733, - 0.6977490056017308, - 0.7063092025459987 - ], - "xyz": [ - 19.19603109131829, - 16.470750935003917, - 16.353717463217336 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5036557278825202, - 0.694891296954088, - 0.9032740790298682 - ], - "xyz": [ - 21.84982935068497, - 19.235291072740928, - 16.386319185101634 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5007908544397273, - 0.8952461819970426, - 0.10532979699204847 - ], - "xyz": [ - 13.679694681062635, - 8.286772444657979, - 19.08636707549696 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5060189061290841, - 0.8975321180142751, - 0.2966629746832418 - ], - "xyz": [ - 16.326820352243764, - 10.974122191727572, - 19.18909696290366 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5038921793767297, - 0.9012543155447293, - 0.5008570319137512 - ], - "xyz": [ - 19.169413962409802, - 13.736750361905422, - 19.2109099521971 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.4968745757879661, - 0.9040886482594764, - 0.6958749016945022 - ], - "xyz": [ - 21.8744136615318, - 16.307056161234357, - 19.153717025796304 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.49726086888049525, - 0.9057280272630046, - 0.8964175720127834 - ], - "xyz": [ - 24.6386102470907, - 19.05412078177354, - 19.181411650072622 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7027692878946746, - 0.09419699989457239, - 0.099573439604386 - ], - "xyz": [ - 2.649194570150649, - 10.969485348676205, - 10.895979632722781 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6990196730329666, - 0.09827743236915842, - 0.2965598866899117 - ], - "xyz": [ - 5.398144755458175, - 13.61138453621044, - 10.90050251157888 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.693992241261453, - 0.10021188430564253, - 0.5023663990202242 - ], - "xyz": [ - 8.23834182554025, - 16.356399985375838, - 10.858215848010726 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6952921284582546, - 0.09765735722715334, - 0.7028208778973151 - ], - "xyz": [ - 10.943994344539409, - 19.114749362552203, - 10.841062637383473 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6957026498082587, - 0.0970503300416583, - 0.9038129617670445 - ], - "xyz": [ - 13.683622770216058, - 21.86828952864746, - 10.838376044971692 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7059817365356182, - 0.2981285599618197, - 0.09964315642097182 - ], - "xyz": [ - 5.438263307476576, - 11.014358524021766, - 13.7280152338596 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6953990665423071, - 0.3052738913027274, - 0.3011281458866005 - ], - "xyz": [ - 8.290619500085796, - 13.624340673429785, - 13.681020558524898 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7047640390054879, - 0.3021833206175089, - 0.4975018576092066 - ], - "xyz": [ - 10.933151813383573, - 16.43716293065471, - 13.76680305024088 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6971550138201413, - 0.3026423961138729, - 0.7044832170425142 - ], - "xyz": [ - 13.769240100463755, - 19.162945597472667, - 13.669050225084053 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6984624979475533, - 0.2987836913634849, - 0.8965881607264833 - ], - "xyz": [ - 16.342908794840667, - 21.807245496272866, - 13.634170395946438 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7033876362705003, - 0.5031968736397402, - 0.09895777171138423 - ], - "xyz": [ - 8.23254992340441, - 10.969521995754887, - 16.496206234281022 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.694642588208982, - 0.4994808863878198, - 0.30484366167564053 - ], - "xyz": [ - 10.996580442704976, - 13.664796100897577, - 16.325841202462044 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6940033704001299, - 0.5000751651281139, - 0.5029932810377278 - ], - "xyz": [ - 13.713771243659076, - 16.36512275906113, - 16.32522680360575 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7036194020326735, - 0.5033025387991136, - 0.6948753379186361 - ], - "xyz": [ - 16.381272258467263, - 19.11996835556111, - 16.50081952910284 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7039271655860713, - 0.5031355206674316, - 0.8951832935015437 - ], - "xyz": [ - 19.11756312993168, - 21.862750356763232, - 16.502743775174363 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6961310923612305, - 0.7043954685776098, - 0.09664867950465544 - ], - "xyz": [ - 10.951731404634074, - 10.838742340591455, - 19.147747046374853 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6975373887094727, - 0.7024604182732147, - 0.30454978264294835 - ], - "xyz": [ - 13.767662205089614, - 13.700355431039455, - 19.140518017462043 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.699943091632154, - 0.6963696802684907, - 0.5059374460262621 - ], - "xyz": [ - 16.437726615419123, - 16.486581652369082, - 19.090136881126668 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.6969783903839745, - 0.7042219303141996, - 0.6958065124455353 - ], - "xyz": [ - 19.140936864291394, - 19.041904490202544, - 19.156958568527706 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7039935374201147, - 0.6943667242335123, - 0.8993244264228235 - ], - "xyz": [ - 21.788658547366303, - 21.920274604427156, - 19.11812979248129 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7055341584558602, - 0.89660086662773, - 0.09680657325511066 - ], - "xyz": [ - 13.581687704739016, - 10.969458062620683, - 21.904101678638327 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.702829618582311, - 0.8950505760802171, - 0.29799813192656777 - ], - "xyz": [ - 16.31114718710132, - 13.683136855962298, - 21.845930402991044 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.701849535886623, - 0.9023989700795507, - 0.4936746481108013 - ], - "xyz": [ - 19.086867214647217, - 16.344991449259663, - 21.93299680883845 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.702306709612561, - 0.8937739651830497, - 0.7028908532758015 - ], - "xyz": [ - 21.829313998302087, - 19.21160814424837, - 21.821327691284125 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7012766408248008, - 0.9004071861147801, - 0.9041723639975932 - ], - "xyz": [ - 24.671886784817342, - 21.9494098131109, - 21.8979329788291 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8948326369499483, - 0.10495938501772799, - 0.1011481245132584 - ], - "xyz": [ - 2.81786477095593, - 13.616869694187898, - 13.668976561778114 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.899095168750998, - 0.10599893815533065, - 0.29608944649522967 - ], - "xyz": [ - 5.497280019033223, - 16.34034892641568, - 13.741465712684082 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9041241633369734, - 0.09462638452166015, - 0.4987761896113737 - ], - "xyz": [ - 8.112893181083495, - 19.18020110344627, - 13.654737715224622 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8941599245388553, - 0.10408280022897506, - 0.7016465760010747 - ], - "xyz": [ - 11.015787000529517, - 21.817579230211823, - 13.647794849335316 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9006184741782708, - 0.10571114127472193, - 0.8973186925776727 - ], - "xyz": [ - 13.713243343059844, - 24.58107331519724, - 13.758357363142533 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9008862902989573, - 0.2959307423839269, - 0.10553414757003676 - ], - "xyz": [ - 5.4887557117703984, - 13.75959907086607, - 16.362667043774508 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9017710091241649, - 0.3017766939811965, - 0.3027490342775209 - ], - "xyz": [ - 8.264966942122097, - 16.467981219780036, - 16.45468755826994 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8957321335125554, - 0.29753897148508035, - 0.5015493929198623 - ], - "xyz": [ - 10.924992282238783, - 19.103381518709256, - 16.314187758728774 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.898621656615332, - 0.3049920551312985, - 0.6950190848381074 - ], - "xyz": [ - 13.67197230365652, - 21.78796936181796, - 16.45559001653182 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9034002895142831, - 0.2996224784153261, - 0.9028029034411694 - ], - "xyz": [ - 16.43934338417327, - 24.694084937512212, - 16.447510739035387 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.901360714246791, - 0.5053636191995168, - 0.09700588328788708 - ], - "xyz": [ - 8.235487411497337, - 13.64948841550656, - 19.232481876497896 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9041678931867517, - 0.5016663380285129, - 0.29422525749486683 - ], - "xyz": [ - 10.881286633508452, - 16.384215445351966, - 19.22031255901348 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8998908061616648, - 0.5060075994118222, - 0.4970655925966007 - ], - "xyz": [ - 13.713836127964594, - 19.09893643167123, - 19.22118993928771 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.904187676094516, - 0.5030843171694371, - 0.6962983548382968 - ], - "xyz": [ - 16.397744002808775, - 21.881556927427848, - 19.23996938294598 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8976841809706191, - 0.4955971499961268, - 0.9016013750139636 - ], - "xyz": [ - 19.10224673820345, - 24.599508250021135, - 19.048691566337773 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8997453686092336, - 0.6941408015919461, - 0.10260155492417779 - ], - "xyz": [ - 10.892918084664274, - 13.703906716102564, - 21.79132481947989 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9062827988621017, - 0.6985694342494437, - 0.2978956309818934 - ], - "xyz": [ - 13.623491008131097, - 16.46331074070973, - 21.94125085769909 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8945616013261557, - 0.6989696731852518, - 0.5022496679325853 - ], - "xyz": [ - 16.422854612281665, - 19.096952247277038, - 21.78647274949055 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9059538935594201, - 0.6963576922002855, - 0.6978165308672198 - ], - "xyz": [ - 19.060899026418777, - 21.92646056408462, - 21.906515584421257 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8972962947855266, - 0.701723794322365, - 0.9051125956287767 - ], - "xyz": [ - 21.968377892861813, - 24.642209916144076, - 21.86151483466705 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.8949390360166039, - 0.8986343044346464, - 0.10485188838675862 - ], - "xyz": [ - 13.71948260073954, - 13.668961556076377, - 24.52141186744821 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9059098675337341, - 0.8984201087046204, - 0.29600440159121916 - ], - "xyz": [ - 16.329956908352866, - 16.432355542907917, - 24.668474655735057 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9006630762763249, - 0.9017822148735997, - 0.4939351688884846 - ], - "xyz": [ - 19.081996841666136, - 19.066696180209146, - 24.64270758044936 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.903870995419128, - 0.8947969421093669, - 0.6983686856167308 - ], - "xyz": [ - 21.781473692458214, - 21.905532515979672, - 24.591064281660824 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9044767533480154, - 0.8966489465277943, - 0.9027230841706035 - ], - "xyz": [ - 24.600690516742965, - 24.7077108825838, - 24.624666366076088 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14851653831466793, - 0.15300285041325004, - 0.14470559695084434 - ], - "xyz": [ - 4.070216304841372, - 4.008880253365736, - 4.1223188091981235 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14431536963170555, - 0.14930465734534523, - 0.35277246152397945 - ], - "xyz": [ - 6.86430799530001, - 6.796095351750917, - 4.014320157225382 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14810340242010156, - 0.14888744081355884, - 0.5562022811942814 - ], - "xyz": [ - 9.63985976314123, - 9.629140531352792, - 4.060405350338822 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15282016095010764, - 0.15006934193461105, - 0.7531031313837401 - ], - "xyz": [ - 12.348011484163298, - 12.385620186595744, - 4.141050763329354 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14670916080762714, - 0.1491861702137912, - 0.9561500845259464 - ], - "xyz": [ - 15.111958314275839, - 15.078093087536455, - 4.045427704565247 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15158200187812595, - 0.3467547533770939, - 0.14641112133618026 - ], - "xyz": [ - 6.742475069222436, - 4.074108341823815, - 6.813170417233419 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.146137203865756, - 0.350863612316524, - 0.35558215445917346 - ], - "xyz": [ - 9.658399363119315, - 6.859416757533936, - 6.794905698697218 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15205726996045316, - 0.35453510245319303, - 0.5485706299300024 - ], - "xyz": [ - 12.347099014111217, - 9.578858534280327, - 6.926039729012335 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14456646058754583, - 0.3543517884647983, - 0.7490487796318593 - ], - "xyz": [ - 15.085493954915245, - 12.217346713536466, - 6.8211204957588185 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15520632901424025, - 0.34698621104540894, - 0.946173638000594 - ], - "xyz": [ - 17.679848687384123, - 15.05786866063275, - 6.865886013038312 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15584771316681048, - 0.5503203956002596, - 0.14721429142715084 - ], - "xyz": [ - 9.536568684795089, - 4.143409175647812, - 9.654603272803802 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15549745190539785, - 0.5482319748598062, - 0.35070404152996104 - ], - "xyz": [ - 12.290091407597947, - 6.920695701979407, - 9.621262051437052 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1468181965824402, - 0.548091654107766, - 0.5562042233891153 - ], - "xyz": [ - 15.09773446387941, - 9.611595981815512, - 9.500682394863373 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14959920177775185, - 0.5560746413824581, - 0.7467501312653452 - ], - "xyz": [ - 17.811985783181687, - 12.254726738485273, - 9.64784576239462 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15499491060706594, - 0.5465025428604764, - 0.9464947642339971 - ], - "xyz": [ - 20.411990443080363, - 15.059368566285542, - 9.590746914266614 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15299515340171027, - 0.754248060931845, - 0.14673206176549608 - ], - "xyz": [ - 12.318038061095962, - 4.097816534867315, - 12.403665922589788 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15007208370121802, - 0.753811051214332, - 0.35202268090378375 - ], - "xyz": [ - 15.118759735447096, - 6.864549244621955, - 12.357727521601113 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1438054492972204, - 0.750825686924979, - 0.5525566830944204 - ], - "xyz": [ - 17.819609154078623, - 9.52053772887468, - 12.231235860825388 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14437499400070236, - 0.7538364059977988, - 0.7525587755178279 - ], - "xyz": [ - 20.59516377054897, - 12.262717048778832, - 12.280184582727506 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15572238759752086, - 0.750394806600475, - 0.9459699139786181 - ], - "xyz": [ - 23.192393114107652, - 15.062138842534686, - 12.388271177980041 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15623803899061123, - 0.9486676722858917, - 0.14817083370681355 - ], - "xyz": [ - 14.995778623001186, - 4.161823313922106, - 15.106072001544316 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15346830261546676, - 0.9525180086760899, - 0.34994042184456 - ], - "xyz": [ - 17.806977219560828, - 6.882513467247082, - 15.120845770442129 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.14840552295813358, - 0.9524044056975004, - 0.54485965343102 - ], - "xyz": [ - 20.470324708874486, - 9.478196703860757, - 15.050075198792667 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.1447399090216303, - 0.9485481877722056, - 0.7541299243993433 - ], - "xyz": [ - 23.278708667549225, - 12.289186565961534, - 14.9472380675079 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.15055117816358782, - 0.9540231963708716, - 0.9440695416509475 - ], - "xyz": [ - 25.950382257541463, - 14.965457449574759, - 15.101542025247712 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34435890246462303, - 0.15435902544453842, - 0.1516039138403241 - ], - "xyz": [ - 4.183070232573568, - 6.780714351214302, - 6.818381741147031 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3514313916028459, - 0.1437086714622501, - 0.3522567406515034 - ], - "xyz": [ - 6.780749840645057, - 9.620697480317657, - 6.76946581701464 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3513849190121547, - 0.14625208994664043, - 0.5470136116342669 - ], - "xyz": [ - 9.478203884187879, - 12.282742999262357, - 6.803603611823033 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3491788938958887, - 0.1469599679558958, - 0.7561808044784987 - ], - "xyz": [ - 12.347578075384002, - 15.112278831428915, - 6.783121214242463 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3443099874214212, - 0.15297220330285433, - 0.9534320335172587 - ], - "xyz": [ - 15.126559573041956, - 17.74249531670986, - 6.798752600787964 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34455679696879815, - 0.3546161402235823, - 0.14935997084500702 - ], - "xyz": [ - 6.890270674829759, - 6.752741144532137, - 9.55896654616553 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3555770762293575, - 0.3497016671331091, - 0.3494068270429552 - ], - "xyz": [ - 9.558085492846198, - 9.63841302843647, - 9.642444029077838 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34921467755792035, - 0.35195276429658384, - 0.5543350048208862 - ], - "xyz": [ - 12.390603247575608, - 12.353168618540213, - 9.586235054895246 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.349396994501396, - 0.35578499912187206, - 0.7456422481796763 - ], - "xyz": [ - 15.058515068202253, - 14.971179418871936, - 9.641121284058467 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3473400929347639, - 0.34996925165103, - 0.9559715216942273 - ], - "xyz": [ - 17.854587183837154, - 17.818641799116932, - 9.533487843494948 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35477069738772915, - 0.544520528819198, - 0.1508359820674348 - ], - "xyz": [ - 9.506789052670083, - 6.912563512308699, - 12.29494777228039 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3482215485106176, - 0.5553450659271082, - 0.34544124532083925 - ], - "xyz": [ - 12.31538830584591, - 9.483632857960787, - 12.353400110601987 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34774879040112927, - 0.5541889757566167, - 0.5452228184454272 - ], - "xyz": [ - 15.030960156207387, - 12.208547101260526, - 12.331130790110794 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3455612594674993, - 0.5479672470527546, - 0.7511471359623393 - ], - "xyz": [ - 17.76125800399342, - 14.993999774805575, - 12.216160906013735 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3474933650642441, - 0.5455122077381055, - 0.9523538191021679 - ], - "xyz": [ - 20.478554703075385, - 17.77127672943003, - 12.209011450350618 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35290387365476616, - 0.7533112530609969, - 0.14961166694363429 - ], - "xyz": [ - 12.344599636177715, - 6.870302018264022, - 15.123974093735102 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.34947163623556154, - 0.7538537939766327, - 0.34428518256186125 - ], - "xyz": [ - 15.01355842221851, - 9.48491835037098, - 15.08446668328368 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3469312015179111, - 0.7548632870269998, - 0.5521703302212694 - ], - "xyz": [ - 17.86952834896723, - 12.292354303662362, - 15.063535924378083 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3451848655970367, - 0.7519609769871642, - 0.7547733563868138 - ], - "xyz": [ - 20.59980059370902, - 15.038430818483246, - 14.999980473559528 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3436761856590599, - 0.752452691751359, - 0.9519289942933679 - ], - "xyz": [ - 23.301999622900013, - 17.7132808113772, - 14.986076708757311 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35528593631006133, - 0.9475603015382498, - 0.15136573565665307 - ], - "xyz": [ - 15.024318973842014, - 6.926850461827964, - 17.812279251539294 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.35475183346033856, - 0.9449969806953956, - 0.3484142286436333 - ], - "xyz": [ - 17.68328524006552, - 9.613559831194323, - 17.769931832350647 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3456513721972913, - 0.9495064796367441, - 0.5490578999570528 - ], - "xyz": [ - 20.488102456218062, - 12.232304121225203, - 17.7071650218616 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3452943545254248, - 0.9555565296795471, - 0.7498185687286788 - ], - "xyz": [ - 23.315581377919546, - 14.972186766403917, - 17.784999135691216 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.3557953313351499, - 0.9475416076366465, - 0.9462941220128985 - ], - "xyz": [ - 25.89218120533724, - 17.801932630072912, - 17.818988028973383 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5439848137004042, - 0.15072673151182361, - 0.15146001372685122 - ], - "xyz": [ - 4.131442787289019, - 9.507996500516498, - 9.49797119806344 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5465323692109272, - 0.14638233746450172, - 0.35226073993966867 - ], - "xyz": [ - 6.817358398515884, - 12.288137605547298, - 9.47340514501926 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.544676951881593, - 0.15494938918910803, - 0.5507336844887674 - ], - "xyz": [ - 9.647971960370649, - 14.97625704654102, - 9.565165402377232 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5533140639478475, - 0.1448263857032754, - 0.7535775041500858 - ], - "xyz": [ - 12.28281626937498, - 17.867586278552686, - 9.544850562349215 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5474368631508879, - 0.14768520837329704, - 0.9485870697651352 - ], - "xyz": [ - 14.98803725769858, - 20.45336992651994, - 9.503583839905781 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5499261890872185, - 0.35597993650864035, - 0.14742966260847984 - ], - "xyz": [ - 6.882525425401425, - 9.534123680330282, - 12.385385486043972 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5527494063255551, - 0.34370368913067145, - 0.3517178900494842 - ], - "xyz": [ - 9.507678654666835, - 12.36571407192619, - 12.256145359520346 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5455273346050685, - 0.3543525810245569, - 0.5527565490468801 - ], - "xyz": [ - 12.401832746693271, - 15.015539566190382, - 12.302996228103424 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5480957965003882, - 0.3562992816433924, - 0.748319137719239 - ], - "xyz": [ - 15.102144198210409, - 17.72435162596258, - 12.364726717267702 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5530988979808423, - 0.3502647521631143, - 0.9439496012248751 - ], - "xyz": [ - 17.69426568093698, - 20.46737761241071, - 12.350625219311148 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5494735931264956, - 0.5534567245162919, - 0.15283482819177524 - ], - "xyz": [ - 9.656290976145206, - 9.60183432074756, - 15.079064775355013 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5482545636292736, - 0.5460900867242307, - 0.35592394243024766 - ], - "xyz": [ - 12.332173444074778, - 12.361765782714683, - 14.961683077596044 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5509826580450019, - 0.5454965380291338, - 0.5553697224841682 - ], - "xyz": [ - 15.05084535781097, - 15.125850603166317, - 14.990866202470288 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5562831729006281, - 0.5473331993374643, - 0.7486219559467621 - ], - "xyz": [ - 17.71806561111799, - 17.840428038678322, - 15.088444390292194 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5548265963973872, - 0.5457990305477883, - 0.9472012939020452 - ], - "xyz": [ - 20.41203169581972, - 20.535454951153582, - 15.047555458981588 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5457286514718239, - 0.7531123074932171, - 0.14705130271617978 - ], - "xyz": [ - 12.306874849333035, - 9.471562833266631, - 17.757519799597425 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5463629260401504, - 0.755446662256083, - 0.34697772334587845 - ], - "xyz": [ - 15.072147763560608, - 12.213592557088894, - 17.798106365460207 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5472360638076802, - 0.7520120181026774, - 0.5549327646924864 - ], - "xyz": [ - 17.868313820314572, - 15.068653832865147, - 17.763085911223662 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5528335160003067, - 0.7437699789749393, - 0.751031503736458 - ], - "xyz": [ - 20.436656807363335, - 17.826207854137493, - 17.726929594672466 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5502779696596227, - 0.7441627813477784, - 0.9513838823026461 - ], - "xyz": [ - 23.181208787029142, - 20.530450540894783, - 17.697360948438003 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5438286893965043, - 0.9527288366381383, - 0.15273174885423568 - ], - "xyz": [ - 15.113658141946347, - 9.52324893088523, - 20.460665115590945 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5509495766446937, - 0.9438774259117336, - 0.35165600277805603 - ], - "xyz": [ - 17.712299841029637, - 12.340261012863536, - 20.43700571009101 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5544566652753133, - 0.9452349805288534, - 0.547821325960678 - ], - "xyz": [ - 20.4127970721897, - 15.07014628614005, - 20.50351423693832 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.555185762735326, - 0.9449068795581855, - 0.7505293973910162 - ], - "xyz": [ - 23.179699599919633, - 17.851502640518525, - 20.508996588761274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.5536680325296794, - 0.948838670207487, - 0.9445303542206431 - ], - "xyz": [ - 25.885800495556996, - 20.483098667940794, - 20.542001188616045 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7446984113352636, - 0.15005936231024794, - 0.1550344481227993 - ], - "xyz": [ - 4.171187659354744, - 12.300985702595932, - 12.232967224882175 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7513344569585954, - 0.15308027722087805, - 0.343762410591386 - ], - "xyz": [ - 6.7927437960854675, - 14.971967255707186, - 12.364995451049607 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7530209710047588, - 0.1540524550592436, - 0.5452521160493357 - ], - "xyz": [ - 9.560766221373695, - 17.749755957047906, - 12.401344607930348 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7504293406972947, - 0.1459578833855876, - 0.7479044595330144 - ], - "xyz": [ - 12.2207250571614, - 20.484950016664744, - 12.255244777960831 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7528441843852564, - 0.1487789273629781, - 0.9445731674888427 - ], - "xyz": [ - 14.948113037437018, - 23.206784499699342, - 12.326828891661744 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7470341534732915, - 0.34571382375152726, - 0.15349233953224198 - ], - "xyz": [ - 6.825056807306302, - 12.31183611760291, - 14.939853649981819 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7553999857489815, - 0.35081476657081473, - 0.3454154742037511 - ], - "xyz": [ - 9.518734530426524, - 15.050150821690968, - 15.123968975060835 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7556909865113061, - 0.34780569685293056, - 0.5459951660288751 - ], - "xyz": [ - 12.219884513164727, - 17.796418774021898, - 15.086808025552836 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7439679343138385, - 0.35377994241931043, - 0.7507456702503424 - ], - "xyz": [ - 15.100875361809212, - 20.43545535315266, - 15.008211376077798 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7461441028557645, - 0.34750263397479825, - 0.9556477092492045 - ], - "xyz": [ - 17.816436925496784, - 23.266591332572954, - 14.952141329534824 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7495102976485276, - 0.553669158341321, - 0.14424240657861068 - ], - "xyz": [ - 9.54172129150362, - 12.219226096706672, - 17.81683494999113 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7522905483059811, - 0.554705734375108, - 0.3455977920909151 - ], - "xyz": [ - 12.308787759208702, - 15.010131770005092, - 17.869017917484964 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.744201474744573, - 0.5504838662761937, - 0.5509960973859017 - ], - "xyz": [ - 15.059235796794708, - 17.707708070604866, - 17.700704939074537 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7506155178977659, - 0.5454970124292642, - 0.755499521414365 - ], - "xyz": [ - 17.786990431334004, - 20.591333716768375, - 17.720217214375694 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.747896200740183, - 0.5549593924165614, - 0.951765982949334 - ], - "xyz": [ - 20.599678121434955, - 23.237475436210012, - 17.81240715563224 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7483594698917756, - 0.7461252067130505, - 0.14954951208921416 - ], - "xyz": [ - 12.245503534015176, - 12.276049978027332, - 20.43232549129939 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7513743180066107, - 0.7514960542561683, - 0.34380809445474453 - ], - "xyz": [ - 14.97480116642883, - 14.973136810337403, - 20.546973212909705 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7483556945641969, - 0.7544263359712449, - 0.5523058190876468 - ], - "xyz": [ - 17.865406812177252, - 17.782410095575546, - 20.54576542071506 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7450549608983396, - 0.7532736553129171, - 0.7537453493689974 - ], - "xyz": [ - 20.60369256859029, - 20.49132805791918, - 20.484879141689383 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7503395229878246, - 0.7440672699050278, - 0.9516686273042922 - ], - "xyz": [ - 23.183795954184323, - 23.269549069326768, - 20.431260679208357 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7489787428125797, - 0.9463754696372552, - 0.14854616580137903 - ], - "xyz": [ - 14.969571513822626, - 12.27079899608649, - 23.178577628855898 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7480253449924099, - 0.9452251086425055, - 0.354792900117371 - ], - "xyz": [ - 17.773612212523453, - 15.077532539856804, - 23.149815417014906 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7467091227713206, - 0.9464526459686884, - 0.555250086548443 - ], - "xyz": [ - 20.531009452482365, - 17.80015195716213, - 23.148602933095027 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7444096780812206, - 0.9528215850854882, - 0.7490981911955608 - ], - "xyz": [ - 23.26834083575477, - 20.418970757335682, - 23.20424032838787 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.7456566277901363, - 0.9473945721315142, - 0.9521136726320636 - ], - "xyz": [ - 25.969734810923576, - 23.211609948718237, - 23.14709125611282 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9528607865418113, - 0.15417240610090763, - 0.14522379376577696 - ], - "xyz": [ - 4.093290953261335, - 15.012814726740888, - 15.135158543836575 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9508986777687966, - 0.15395827384632552, - 0.34401985818349234 - ], - "xyz": [ - 6.808267385047904, - 17.70389313820322, - 15.105405368230658 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9495192325711499, - 0.151157200270994, - 0.544577485423535 - ], - "xyz": [ - 9.511959390572175, - 20.42702139101409, - 15.048250068059877 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9553888805248157, - 0.14974161697550895, - 0.7450650035259058 - ], - "xyz": [ - 12.23363505030365, - 23.248299421042333, - 15.109145238334888 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9480471372732044, - 0.14812004894379072, - 0.9475115183345911 - ], - "xyz": [ - 14.979277574147925, - 25.915736738911768, - 14.986600459865237 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9531580526772605, - 0.3445810780765087, - 0.1535393170973285 - ], - "xyz": [ - 6.81021238114557, - 15.13056723403162, - 17.742455802621993 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.945358255549388, - 0.34867637215711905, - 0.35049184387580284 - ], - "xyz": [ - 9.558901999323222, - 17.716629306323313, - 17.691808503770375 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9454298982439149, - 0.3476682410915054, - 0.5521550838977718 - ], - "xyz": [ - 12.302222531054898, - 20.474712310544355, - 17.679005003328786 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9441129630382189, - 0.3533554202065208, - 0.7497861774609486 - ], - "xyz": [ - 15.081953357822059, - 23.158684147059326, - 17.738754191413094 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.953576746523516, - 0.3481876693492278, - 0.9448831157961044 - ], - "xyz": [ - 17.678631021765653, - 25.95540151485863, - 17.797488776217296 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9459714983675117, - 0.5485029427222153, - 0.15590628859440173 - ], - "xyz": [ - 9.63055621689915, - 15.064674765341625, - 20.432185553179348 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9518558903184342, - 0.5472142190424097, - 0.3550399837473151 - ], - "xyz": [ - 12.335457054784614, - 17.86764514896959, - 20.49501670256177 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9508420036388977, - 0.5556380801760208, - 0.5468171622240539 - ], - "xyz": [ - 15.072569632150186, - 20.475726537028414, - 20.596324539502476 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9552987171994615, - 0.5464575293404794, - 0.7515021606060305 - ], - "xyz": [ - 17.745471248204492, - 23.33507437719868, - 20.531741086569692 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9516031273730684, - 0.5519316015293977, - 0.9527576189685734 - ], - "xyz": [ - 20.57184017858857, - 26.036077339048582, - 20.55605617730331 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.953101737548505, - 0.7539617530754711, - 0.14774035782855421 - ], - "xyz": [ - 12.32790895389987, - 15.050514976417984, - 23.338664772382685 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9501612016322825, - 0.7462586723974399, - 0.35585620592232187 - ], - "xyz": [ - 15.067916235709683, - 17.85563491295319, - 23.193147162157036 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9526934279377578, - 0.74980693463005, - 0.5441086189159127 - ], - "xyz": [ - 17.69018054328076, - 20.46400816021495, - 23.276278506961805 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9507588976624178, - 0.7519814187142847, - 0.7533860269028283 - ], - "xyz": [ - 20.581112750336956, - 23.298762662569622, - 23.279559112245327 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9512064107860795, - 0.755460557714564, - 0.946636069768628 - ], - "xyz": [ - 23.270758713557253, - 25.94696078249746, - 23.333243593286465 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9521715102041416, - 0.9442558736161951, - 0.15395505983741078 - ], - "xyz": [ - 15.014542204209677, - 15.122763362825495, - 25.92761383466255 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.946725952390455, - 0.946383499493028, - 0.35171887381365297 - ], - "xyz": [ - 17.747421989421746, - 17.752103943793845, - 25.882251666449637 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9443562995011371, - 0.9497555790132105, - 0.5544023339843887 - ], - "xyz": [ - 20.564576238078832, - 20.490758260460076, - 25.895956662910024 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.9489465364049484, - 0.9561273575040368, - 0.7464698987975502 - ], - "xyz": [ - 23.27760322064916, - 23.17942832713022, - 26.04582736422274 - ], - "label": "Si", - "properties": {} - }, - { - "species": [ - { - "element": "Si", - "occu": 1 - } - ], - "abc": [ - 0.953772673061662, - 0.952283975370427, - 0.944169167504682 - ], - "xyz": [ - 25.92796600782277, - 25.94831921469175, - 26.0592634071668 - ], - "label": "Si", - "properties": {} - } - ] - } - ], - "disps": [ - 0.01, - 0.020000000000000004, - 0.030000000000000006, - 0.04000000000000001, - 0.05000000000000001, - 0.06000000000000001, - 0.07, - 0.08, - 0.09000000000000001, - 0.1 - ], - "first_pass": true, - "static_user_incar_settings": { - "ADDGRID": true, - "LCHARG": false, - "ENCUT": 700, - "EDIFF": 1e-08, - "PREC": "Accurate", - "LAECHG": false, - "LREAL": false, - "LASPH": true - }, - "env_vars": { - "VASP_CMD": ">>vasp_cmd<<", - "DB_FILE": ">>db_file<<" - }, - "shengbte_t_range": false, - "shengbte_fworker": null, - "_fw_name": "{{atomate.vasp.firetasks.parse_outputs.CSLDForceConstantsToDB}}" - } - ], - "calc_locs": [ - { - "name": "perturbed supercell, idx: 0, disp_val: 0.010, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-01-06-49-396367" - }, - { - "name": "perturbed supercell, idx: 1, disp_val: 0.020, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-01-00-10-536875/launcher_2019-08-03-01-15-54-768794" - }, - { - "name": "perturbed supercell, idx: 2, disp_val: 0.030, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-01-53-25-787365" - }, - { - "name": "perturbed supercell, idx: 4, disp_val: 0.050, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-02-00-31-887278/launcher_2019-08-03-02-10-39-900305" - }, - { - "name": "perturbed supercell, idx: 3, disp_val: 0.040, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-01-00-10-536875/launcher_2019-08-03-02-03-16-191652" - }, - { - "name": "perturbed supercell, idx: 5, disp_val: 0.060, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-02-41-13-527053" - }, - { - "name": "perturbed supercell, idx: 6, disp_val: 0.070, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-02-00-31-887278/launcher_2019-08-03-02-51-25-930836" - }, - { - "name": "perturbed supercell, idx: 7, disp_val: 0.080, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-01-00-10-536875/launcher_2019-08-03-03-14-04-415140" - }, - { - "name": "perturbed supercell, idx: 8, disp_val: 0.090, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-03-00-15-983388/launcher_2019-08-03-03-20-49-969204" - }, - { - "name": "perturbed supercell, idx: 9, disp_val: 0.100, static", - "filesystem": null, - "path": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-03-00-47-30-571609/launcher_2019-08-03-03-29-56-163076" - } - ] - }, - "fw_id": 382, - "created_on": "2019-08-02T23:22:50.420334", - "updated_on": "2019-08-05T00:02:13.075974", - "launches": [ - { - "fworker": { - "name": "rees_the_fire_worker", - "category": "", - "query": "{\"spec._fworker\": \"rees_the_fire_worker\"}", - "env": { - "db_file": "/global/homes/r/rchang97/anywhere_called_anything/knl/db.json", - "vasp_cmd": "srun -n64 -c16 --cpu_bind=cores vasp_std", - "vasp_ncl": "srun -N 4 -n 32 -c16 --cpu_bind=cores vasp_ncl", - "vasp_vtst": "srun -n 32 vasp_vtst", - "shengbte_cmd": "srun -N 4 -n 32 --cpu_bind=cores ShengBTE", - "scratch_dir": null, - "incar_update": { - "KPAR": 4 - }, - "MAPI_KEY": "auNIrJ23VLXCqbpl", - "OMP_NUM_THREADS": 4 - } - }, - "fw_id": 382, - "launch_dir": "/global/project/projectdirs/m2439/rchang/test_CSLD_workflow_jul11/block_2019-07-11-20-46-47-559096/launcher_2019-08-04-23-48-07-539963/launcher_2019-08-05-00-02-10-420079", - "host": "nid02993", - "ip": "10.128.11.200", - "trackers": [], - "action": null, - "state": "RUNNING", - "state_history": [ - { - "state": "RUNNING", - "created_on": "2019-08-05T00:02:12.925440", - "updated_on": "2019-08-05T00:02:12.925456" - } - ], - "launch_id": 285 - } - ], - "state": "RUNNING", - "name": "Compressed Sensing Lattice Dynamics" - }, - { - "wf_meta": - {"wf_uuid": "b8ab536c-b75d-4011-a069-48cbab8b8bda"}, - "task_id": 73, - "task_label": "perturbed supercell, idx:9, disp_val: 0.100, static", - "output": - {"forces": [ - [ - 0.07831190000000000373, - 0.13348752999999999314, - -0.7885310199999999714 - ], - [ - -0.23123856000000000965, - 0.096098559999999999537, - -0.42135612000000000066 - ], - [ - 0.58627600000000001934, - -0.54241695999999994804, - 1.7035638600000000409 - ], - [ - -0.99997219000000003852, - -0.14053357999999999128, - 0.20597187999999999608 - ], - [ - -0.084016499999999993964, - -0.66620157000000002068, - 1.3024467399999999362 - ], - [ - 0.042476250000000000118, - 1.1488909899999999453, - 1.790629919999999986 - ], - [ - 0.79051106000000004315, - 1.2691133900000000079, - -0.32494996999999997689 - ], - [ - 0.5270944899999999711, - 1.1274580000000000712, - -0.52687927000000001065 - ], - [ - 1.3149132999999999516, - 0.14895844999999999225, - -1.0134311000000000291 - ], - [ - 0.64389313000000003573, - -0.48292942999999999287, - -1.1776767999999999681 - ], - [ - 1.5145975300000000807, - 0.5851555299999999793, - -1.061155279999999923 - ], - [ - -0.89103935000000000777, - 0.50084167000000001657, - 0.3583423299999999867 - ], - [ - 0.64216777999999996585, - -0.35038510999999999962, - -0.29322418000000000093 - ], - [ - -1.2954094800000000021, - -0.97275754999999997086, - -1.9234877200000000119 - ], - [ - -0.62535890999999999007, - 1.0499413399999999452, - 0.13253425999999998708 - ], - [ - -0.087670300000000006557, - -0.68315850000000000186, - 1.3583470200000000716 - ], - [ - 1.5463132500000000835, - 0.19501678000000000068, - -0.19524247999999999603 - ], - [ - -0.70032349999999998769, - 0.0049489499999999997035, - 0.66694388000000004446 - ], - [ - 0.9796890700000000507, - -1.4648347200000000345, - -0.081083359999999993217 - ], - [ - -1.1092457300000000409, - 1.7626276499999999903, - 0.0014913599999999999513 - ], - [ - -0.12279756999999999478, - 0.22585643999999999165, - 0.91203732999999997944 - ], - [ - 1.0306507300000000704, - -0.94734240999999996813, - 0.81078428999999996307 - ], - [ - 2.0477240600000001791, - 0.77306264000000002312, - -0.37277839000000001501 - ], - [ - -0.12977749999999999009, - -1.1385224599999999029, - 1.4968394000000000421 - ], - [ - 0.21039493000000000777, - 0.97166746999999997758, - 0.59281391000000005498 - ], - [ - -0.78512747000000004949, - -1.2550078700000000254, - -0.33886599000000000581 - ], - [ - 0.67743217000000000017, - -0.98036984000000004791, - -0.3980978900000000098 - ], - [ - -0.82411056999999998673, - -1.2909711100000000883, - -1.2323026500000000549 - ], - [ - -0.22584266000000000063, - 1.6371852200000001076, - 0.50890758000000002603 - ], - [ - -0.58444348999999995442, - 1.8089793800000000257, - 0.33931751999999998359 - ], - [ - 0.60701552999999996985, - 0.59774585999999996222, - 0.048081379999999999952 - ], - [ - -0.035545699999999999519, - 1.1661885000000000723, - 0.86634655999999998777 - ], - [ - 0.85057042999999998845, - 0.46391482000000000552, - 0.0076601999999999998217 - ], - [ - 0.53596458000000002375, - 1.4050670499999999841, - -0.21323982999999999133 - ], - [ - -1.2882882499999999126, - -0.71620264000000000149, - -1.2155741499999999089 - ], - [ - -0.091519009999999997862, - -0.5103751399999999494, - 1.7366616399999998954 - ], - [ - 0.10133767999999999943, - 1.0869468799999999487, - -0.68463534999999997588 - ], - [ - -0.061204130000000002421, - 0.58470761999999998348, - -0.15081370999999998972 - ], - [ - -0.19033634999999998749, - 0.92370163999999999049, - 0.88790815000000000712 - ], - [ - 0.72283881000000005379, - 1.3917510799999999183, - -0.93105172000000002708 - ], - [ - -1.4223688299999999174, - -0.99532498999999996503, - -1.1959716899999999207 - ], - [ - 0.69786245000000002303, - 0.20555810999999998834, - -1.1993644599999999656 - ], - [ - 0.66534751999999997008, - -1.8806021399999999222, - 0.074140209999999998058 - ], - [ - -0.70677151999999998644, - -1.2401579000000000352, - -0.60743424000000001417 - ], - [ - 0.40725887999999998978, - 0.22834728000000001358, - 0.61086996000000004514 - ], - [ - 0.62574004000000005288, - 0.072553480000000003525, - -0.77714974000000003329 - ], - [ - -0.89136011000000003879, - -1.6358562999999999299, - -0.92497541999999999263 - ], - [ - 1.4013913799999999643, - -0.096434980000000003475, - -1.0309077900000001016 - ], - [ - 0.48585639000000002685, - -1.8281268200000000412, - 0.29429448000000002494 - ], - [ - 0.44854590999999999212, - -0.078582769999999996235, - -0.56651185999999997822 - ], - [ - 1.5751037999999999428, - 0.54963850999999996905, - 1.0624619399999999381 - ], - [ - -0.22981135999999999231, - 0.95532461000000001849, - -0.71957930000000003279 - ], - [ - 0.30679977000000002718, - -0.51022266000000005004, - 0.59013344000000000911 - ], - [ - 0.95272164999999997548, - 0.68642924000000005158, - -0.013147360000000000296 - ], - [ - -0.18585524999999999962, - 1.146305490000000038, - 0.59491990999999999623 - ], - [ - 0.55832212999999997205, - 1.0742693500000000117, - 0.19820282999999999651 - ], - [ - 1.0368665299999999529, - -0.69249707000000004786, - -0.16991117000000000026 - ], - [ - -1.1572808400000000884, - 0.85230055999999998484, - -0.51185108000000001383 - ], - [ - -0.38697397000000000045, - 0.56901707999999995291, - -0.78654011000000001452 - ], - [ - 1.4335039099999999923, - -0.4602253700000000225, - 1.4169320800000000382 - ], - [ - -0.80782277000000002332, - -0.49654826000000001907, - -0.6662061900000000314 - ], - [ - -0.5673806500000000419, - -1.1048743299999999046, - 0.097453059999999994134 - ], - [ - 1.5067499900000000945, - -1.0445191300000000734, - -0.43452224999999999877 - ], - [ - 0.22517191999999999763, - -1.0810427700000000417, - 0.145784739999999996 - ], - [ - 0.99590813000000000255, - 0.54469199999999995399, - -0.16181857999999998965 - ], - [ - 0.35854939000000002336, - -0.4029563299999999737, - -0.035375530000000002251 - ], - [ - -0.73045963999999996563, - -0.012088929999999999468, - -1.1712885799999999126 - ], - [ - -0.96503956000000001847, - -0.53553134999999996158, - -0.23376389999999999669 - ], - [ - -0.73063480000000002867, - -0.25936473999999998252, - 0.86840996999999997552 - ], - [ - -0.18757809999999999762, - -0.14306530000000000635, - -1.1694111000000000367 - ], - [ - 0.46422714999999997731, - 0.29114118999999999415, - -1.6642626899999999335 - ], - [ - 0.19961806000000001382, - 0.1485304100000000016, - 0.22095952999999998734 - ], - [ - -1.1908655399999998892, - -1.0873266399999998999, - -0.87294629999999995285 - ], - [ - -0.43029753999999997838, - -1.0388015900000000524, - -1.6224912099999999615 - ], - [ - 0.53233841999999997885, - -0.17029970999999999304, - -1.7630797099999999666 - ], - [ - 1.1811808599999999991, - 1.2722882900000000994, - 0.1364686099999999902 - ], - [ - 2.0918387799999997867, - -0.19663389000000000562, - 0.38954675999999999192 - ], - [ - -1.6872029099999998891, - -1.216507629999999951, - -1.7687320399999999498 - ], - [ - -0.84237729999999999553, - 0.67121016000000000012, - -0.89954000999999994548 - ], - [ - -0.17766998999999999986, - -0.48801745000000001928, - 0.44154369999999998342 - ], - [ - 0.97200246999999995179, - 0.74845828999999997055, - -1.4009080000000000421 - ], - [ - 0.61467598999999994991, - -0.033541529999999999956, - -0.096046170000000000155 - ], - [ - 0.73757201999999999487, - -0.72137954000000004129, - 0.74599378000000005073 - ], - [ - -0.10717446999999999391, - -0.46557662999999999132, - -0.48696686999999999612 - ], - [ - -0.50246095999999995652, - -1.0235821199999999287, - -0.29832589999999997721 - ], - [ - 0.66755699000000001675, - 0.10815128000000000241, - -1.1369414499999999091 - ], - [ - 0.1687634399999999868, - -0.45037483999999999851, - 0.94882533000000002232 - ], - [ - -0.83145067999999999753, - -0.54748805000000000387, - 0.61275553999999998744 - ], - [ - -0.38073582000000000258, - -0.26274502999999999053, - 0.75778834999999999944 - ], - [ - -1.0994560099999999281, - 0.53176179999999995118, - -1.083134920000000001 - ], - [ - -1.5146261199999999647, - 1.7629046200000000333, - 0.8386093100000000522 - ], - [ - 1.6527131900000000542, - 0.70929196000000005462, - 0.39203806000000002152 - ], - [ - -1.3456532199999999833, - 0.75924530999999995107, - 0.72372687999999996133 - ], - [ - -0.87710114999999999608, - 1.0183585200000000448, - 0.60019449999999996415 - ], - [ - 0.107261490000000001, - -1.2640992499999998966, - -1.2511347699999999517 - ], - [ - -0.30938009999999999122, - 1.2530714000000000574, - -0.53480751000000004147 - ], - [ - -1.4350543399999999838, - 1.5933661100000000577, - 0.8024687400000000137 - ], - [ - -0.91177421000000002937, - -0.31927126000000000117, - 0.9528805399999999981 - ], - [ - -1.7684706900000000118, - -0.4729965799999999998, - -0.21386266000000000997 - ], - [ - 0.38548698999999997383, - -1.0809112599999999293, - -0.062500870000000000037 - ], - [ - 0.29287140000000000395, - 1.9271834400000000809, - -0.99369627999999998735 - ], - [ - -0.6418038099999999746, - 0.8107029599999999725, - 0.99841570000000001706 - ], - [ - -0.43243656000000002537, - -0.62609649000000000552, - 0.47940268000000002546 - ], - [ - -0.85587301000000004514, - 0.35386479999999997936, - 0.60735885999999994489 - ], - [ - -1.2008275399999999156, - -0.95377666000000005386, - -1.680977780000000088 - ], - [ - -1.5842240499999999948, - -0.39875189999999999246, - 0.88452953000000000827 - ], - [ - 0.25403247000000001021, - -0.36972863999999999729, - -0.67732921000000001488 - ], - [ - -0.16600395000000001122, - 1.3401555199999999335, - 0.96901139999999996721 - ], - [ - -1.781705749999999977, - -0.31685880999999999075, - 0.43421903000000000583 - ], - [ - 0.79681130000000000013, - 0.026636909999999999754, - -0.085323469999999998481 - ], - [ - 0.30926818000000000364, - -0.73817085000000004502, - 0.049475020000000001497 - ], - [ - 0.22312430999999999237, - -0.58111917999999995743, - 1.2391407299999999125 - ], - [ - 0.44991010999999997422, - 0.28888169000000002429, - -0.29395650000000000945 - ], - [ - 0.60490675000000004857, - -1.3652999500000000399, - -1.3070176600000000811 - ], - [ - 0.330630780000000013, - -0.0036849100000000000084, - 1.2069704000000001098 - ], - [ - -0.8584044100000000066, - -0.102687500000000001, - -1.048516819999999905 - ], - [ - -1.0581144300000000502, - 1.6681704399999999211, - -0.13306965000000001154 - ], - [ - -0.56035254999999994929, - 0.48939191999999998028, - 0.14192711999999998995 - ], - [ - -1.1821843000000000767, - 1.8629182500000001088, - -0.27243471000000002435 - ], - [ - 0.36188479000000001173, - 0.30532822999999997826, - -0.53161181999999995718 - ], - [ - 0.75902148000000002614, - 0.66224952999999997516, - 0.99443974999999995568 - ], - [ - -1.7742333400000001031, - 0.03149466000000000071, - -0.9416905500000000151 - ], - [ - 1.2413614699999999669, - -0.10979825000000000002, - 0.20034362000000000004 - ], - [ - 0.30895525000000001459, - 0.13095992000000000743, - -0.68820227000000000483 - ], - [ - -0.74436323999999998158, - 1.1300638800000000206, - -0.25068019000000002494 - ], - [ - 0.42731370000000001852, - -1.4713417300000000143, - 0.74109873000000003884 - ], - [ - -0.12345670999999999728, - 1.0167074099999999781, - 0.96949633000000001726 - ], - [ - 1.8160064600000001001, - 0.027944610000000001671, - -1.1622107600000000094 - ], - [ - 0.27132451000000001873, - 0.19986771999999999871, - -1.4822910199999999037 - ], - [ - -0.63319206999999999574, - 0.3522188399999999775, - -0.10759088999999999459 - ], - [ - -1.0318252599999999664, - -0.87525417000000005352, - -0.7480341000000000351 - ], - [ - 0.59946438000000001889, - -0.10202226999999999824, - -1.7502010999999999541 - ], - [ - -0.64627297999999999689, - -1.6258336099999999291, - 1.0833318000000000669 - ], - [ - -0.43041917000000001758, - -0.04910751000000000005, - 1.5509864799999999452 - ], - [ - -1.1718138700000000352, - -0.90183605000000000018, - 1.0916390199999999044 - ], - [ - 0.95308283000000004748, - 0.75112928000000001028, - 0.38559111000000001468 - ], - [ - 0.26458651999999999171, - -0.95043979999999994579, - 1.128888820000000015 - ], - [ - 0.83603415999999997066, - -1.1981267200000000894, - -1.7889941700000000502 - ], - [ - 0.52704019000000001949, - -0.95998888000000004439, - -0.12351779999999999704 - ], - [ - 0.81206047000000003422, - -1.0104732499999999895, - 0.53094713000000004488 - ], - [ - -1.0412716300000000036, - -1.1434011699999999667, - 0.81061377000000001125 - ], - [ - -0.59518559000000004211, - -1.6072862199999999877, - 0.44029684000000002264 - ], - [ - 0.71221310000000004337, - -0.31601391000000000897, - -0.8537947799999999754 - ], - [ - 0.29276771000000001433, - 0.62895613999999999688, - -1.5900651299999999377 - ], - [ - 1.5920982200000000084, - 0.6885572599999999488, - 0.45288893000000002287 - ], - [ - -1.4803201399999998955, - -0.67704492000000005003, - 0.99620447000000000859 - ], - [ - 2.2874607999999998498, - 0.35409158000000001687, - 1.3385848099999999583 - ], - [ - 0.55270706000000002778, - -0.80017325999999999731, - -0.95867215999999999543 - ], - [ - -0.97171572999999999976, - 0.42407735000000001957, - -0.85358146000000001408 - ], - [ - -1.5566404400000000141, - 0.57005410999999994726, - -0.54170421000000001932 - ], - [ - -1.1020061999999999358, - 2.0817658400000000896, - -0.72747726999999995368 - ], - [ - -1.0066090100000000263, - -0.13818797999999998805, - 0.1134109600000000051 - ], - [ - 0.1604153500000000121, - -0.33251275000000002358, - 0.30343645000000002421 - ], - [ - -0.75557441000000002962, - 0.196063230000000005, - 0.27960002000000000466 - ], - [ - -1.7560206000000000426, - -0.58666691999999998064, - 0.98748588000000003806 - ], - [ - -0.81968731999999999704, - 0.68227042999999998329, - 0.37288337999999998651 - ], - [ - 0.51342779999999998974, - 1.5376035100000000622, - -0.71732337999999995493 - ], - [ - -1.0561733300000000213, - 1.0897354400000001107, - -0.80847734999999998351 - ], - [ - 0.83446480999999994577, - -0.55333054000000003736, - -1.2335912399999999778 - ], - [ - 0.95448379999999999335, - 0.18556226000000000664, - -0.38305970000000000297 - ], - [ - -0.58733826000000000089, - 0.83072208000000002937, - 0.592835679999999976 - ], - [ - 1.8190498399999999179, - 0.39715525000000001521, - 1.3720469099999998974 - ], - [ - 0.8020531800000000322, - -2.0366091100000001113, - -0.31604282999999999682 - ], - [ - -1.1808565600000000551, - -1.2431400200000000122, - 0.19059365000000000334 - ], - [ - -1.0578574700000000774, - 0.18128862000000001142, - 1.0568589900000000537 - ], - [ - 1.326159599999999994, - -1.2147595200000000926, - -0.22141074999999998951 - ], - [ - -0.16927979000000001331, - -1.0755168500000000797, - 0.54983132000000001227 - ], - [ - -0.85147755000000002745, - -0.76105011000000000188, - -0.47147622000000000142 - ], - [ - 1.13345688, - -0.59476028000000003004, - 0.050848829999999997642 - ], - [ - 1.1228369600000001061, - 2.3260221900000002115, - 0.32467067999999998928 - ], - [ - -0.10715566999999999453, - 0.84710337000000002217, - 0.38750002999999999531 - ], - [ - 0.95104264000000005019, - 2.0416659199999998009, - 0.51941548000000004048 - ], - [ - -1.2716981599999999109, - -1.2761413600000000024, - 0.91090353999999995604 - ], - [ - 0.47580161999999998068, - 0.23842938999999999106, - -0.15584779000000001381 - ], - [ - -1.574573489999999909, - -2.0248185099999997938, - 1.0148207600000000994 - ], - [ - 0.43467855999999999161, - 0.60963750000000005436, - 0.97668445000000003731 - ], - [ - 0.79075452000000001629, - 0.23716354000000000601, - 1.5883876200000000001 - ], - [ - -0.58965686999999999962, - 0.58990777000000005348, - -0.037026870000000003391 - ], - [ - 0.16763605000000000866, - 1.2480702699999999261, - 0.47256605000000001526 - ], - [ - -1.21353544999999996, - 0.55432048000000000432, - -1.1228045300000000228 - ], - [ - 0.055387369999999998271, - 0.61416318000000003074, - 0.27860567000000002746 - ], - [ - 0.063420779999999996046, - 1.0651318899999999701, - 1.7060636899999999105 - ], - [ - -1.0464406799999999009, - 0.77651574999999994908, - 0.84169324000000000918 - ], - [ - -0.25344600000000000461, - -0.44617109999999998715, - -0.66358464999999999812 - ], - [ - -1.1788528300000000737, - -0.19355943999999999927, - 1.3685694299999999757 - ], - [ - -1.322010569999999996, - -1.1290357600000000549, - 0.77881993999999998834 - ], - [ - 0.58085730999999996005, - 0.039091080000000000272, - -1.0504798799999999215 - ], - [ - -0.5303951199999999977, - -0.44094931999999997796, - 0.79699781000000002873 - ], - [ - -0.93966751999999997835, - 0.6808800400000000197, - -0.061815599999999998326 - ], - [ - -0.34427423000000001441, - -0.78606496999999997399, - -0.34938816000000000317 - ], - [ - -0.080633709999999997331, - -0.13550016000000000838, - 0.65816757999999997431 - ], - [ - -1.4875186600000001036, - 0.31067684000000000966, - -1.1177371099999999782 - ], - [ - -0.21794589000000000323, - 0.052581469999999998211, - 1.1197926000000000268 - ], - [ - 1.2145393600000000678, - 0.31295009000000001409, - 0.43762961000000000222 - ], - [ - -1.1863570699999999025, - -0.12552225999999999662, - 0.36967160999999998383 - ], - [ - 0.54254860999999998672, - -1.1863322000000000589, - -0.097514770000000000616 - ], - [ - -0.015148069999999999591, - 0.26014512000000000747, - -0.71046690000000001231 - ], - [ - 1.3382988899999999077, - 0.87820692000000000199, - 0.54202134999999995735 - ], - [ - 2.1238952399999999621, - -1.1277893000000001056, - -1.5833483699999999494 - ], - [ - 0.58323871000000004905, - -0.52717824000000002016, - -0.088743030000000000523 - ], - [ - 0.19919038999999999495, - 0.68861346000000001055, - -0.77542144999999995658 - ], - [ - 1.5529822900000000985, - -0.90369516000000005285, - -0.25383573999999997639 - ], - [ - 0.27872448999999999142, - 1.0258831500000000769, - 2.0674279200000000856 - ], - [ - 0.49976879000000001829, - 0.12714253999999999833, - 1.3532128999999999408 - ], - [ - -0.60777380999999996991, - -1.209095299999999984, - -1.3059079300000000501 - ], - [ - -0.7011660899999999641, - -0.063854209999999994585, - -1.5781376199999999077 - ], - [ - 1.5501519399999998949, - 0.55358165999999997542, - 1.6625704400000000938 - ], - [ - 0.36506037000000002291, - 1.6310923100000001007, - 0.40482422000000001239 - ], - [ - -0.065815040000000005205, - -1.1950870600000000898, - -0.2148108699999999871 - ], - [ - 1.3276891600000000349, - -0.32405800000000001271, - 0.034694469999999998089 - ], - [ - 0.4153568599999999944, - -0.20443785999999999903, - 0.87052498000000000378 - ], - [ - -0.67810042000000003704, - -1.2251891800000000998, - 0.96712319999999996067 - ], - [ - -0.44125513999999999015, - 0.2097410500000000122, - 0.076529910000000006542 - ], - [ - 0.60216389000000003495, - -0.58914710000000003465, - -1.0336862899999998966 - ], - [ - 0.26492007000000000749, - 0.81453339999999996301, - 1.0819854499999999042 - ], - [ - 1.6347942600000000546, - -0.3844907900000000267, - -0.63217098999999998821 - ]]}, - "formula_pretty": "Si", - "state": "successful" - } -] \ No newline at end of file diff --git a/atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si b/atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si deleted file mode 100644 index 283220155..000000000 --- a/atomate/vasp/test_files/csld_wf/POSCAR-well_relaxed_Si +++ /dev/null @@ -1,10 +0,0 @@ -Si2 -1.0 -0.0000000000000000 2.7343639999999998 2.7343639999999998 -2.7343639999999998 0.0000000000000000 2.7343639999999998 -2.7343639999999998 2.7343639999999998 0.0000000000000000 -Si -2 -direct -0.5000000000000000 0.5000000000000000 0.5000000000000000 Si -0.7500000000000000 0.7500000000000000 0.7500000000000000 Si diff --git a/atomate/vasp/test_files/csld_wf/__init__.py b/atomate/vasp/test_files/csld_wf/__init__.py deleted file mode 100644 index e69de29bb..000000000 diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/INCAR b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/INCAR new file mode 100644 index 000000000..2d049b275 --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/INCAR @@ -0,0 +1,21 @@ +ADDGRID = True +ALGO = Normal +EDIFF = 1e-08 +ENCUT = 700 +IBRION = -1 +ICHARG = 0 +ISIF = 3 +ISMEAR = -5 +ISPIN = 2 +LAECHG = False +LASPH = True +LCHARG = False +LORBIT = 11 +LREAL = False +LVHAR = True +LWAVE = False +MAGMOM = 128*0.6 +NELM = 100 +NSW = 0 +PREC = Accurate +SIGMA = 0.05 diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/KPOINTS b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/KPOINTS new file mode 100644 index 000000000..6677fab59 --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/KPOINTS @@ -0,0 +1,4 @@ +pymatgen v2020.1.28 with grid density = 1239 / atom +0 +Monkhorst +2 2 2 diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POSCAR b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POSCAR new file mode 100644 index 000000000..56a563b58 --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POSCAR @@ -0,0 +1,136 @@ +Si128 +1.0 +15.360792 0.000000 0.000000 +7.680396 13.302841 0.000000 +0.000000 -8.868554 12.542036 +Si +128 +direct +0.002404 -0.002517 0.000123 Si +0.000357 -0.000777 0.252550 Si +0.004490 -0.001628 0.500263 Si +0.002106 -0.006496 0.747226 Si +0.002968 0.251340 -0.000424 Si +-0.003427 0.250985 0.250110 Si +-0.000782 0.251244 0.499624 Si +0.000512 0.249102 0.751360 Si +0.006130 0.492281 -0.004097 Si +-0.002867 0.504654 0.250646 Si +-0.002557 0.504956 0.501778 Si +-0.002017 0.505049 0.753557 Si +-0.000990 0.749992 0.002984 Si +-0.002484 0.747893 0.249024 Si +0.001491 0.747627 0.499072 Si +-0.002745 0.752763 0.751308 Si +0.250543 0.002043 0.002689 Si +0.250263 0.001233 0.251568 Si +0.249181 0.003382 0.499683 Si +0.252592 0.000338 0.750248 Si +0.248235 0.253531 0.002630 Si +0.251371 0.246532 0.246163 Si +0.247689 0.250186 0.499295 Si +0.248728 0.252353 0.751770 Si +0.247456 0.501566 0.000831 Si +0.245919 0.510981 0.258069 Si +0.250265 0.499354 0.499871 Si +0.248424 0.501149 0.748379 Si +0.247168 0.753267 -0.000149 Si +0.249007 0.747189 0.248607 Si +0.250103 0.751187 0.502381 Si +0.250548 0.753120 0.750159 Si +0.504837 -0.004255 -0.001475 Si +0.502158 0.000984 0.253542 Si +0.493063 0.004233 0.502475 Si +0.496057 0.004024 0.754290 Si +0.500139 0.251115 -0.000257 Si +0.496737 0.251876 0.254678 Si +0.496044 0.254600 0.500845 Si +0.497132 0.256958 0.752534 Si +0.496869 0.505817 0.003930 Si +0.500507 0.500335 0.248215 Si +0.497799 0.501539 0.498221 Si +0.498527 0.502456 0.752570 Si +0.499691 0.748601 -0.000097 Si +0.498840 0.750386 0.249273 Si +0.499950 0.751666 0.499152 Si +0.496771 0.749795 0.751294 Si +0.749428 0.001949 -0.000458 Si +0.751229 -0.002795 0.249361 Si +0.750397 -0.002559 0.500299 Si +0.748756 -0.000843 0.749283 Si +0.749923 0.249533 0.000966 Si +0.753039 0.243413 0.251122 Si +0.747658 0.252684 0.503283 Si +0.753566 0.247640 0.749662 Si +0.747313 0.502195 0.004115 Si +0.750050 0.499140 0.251465 Si +0.742704 0.506149 0.502660 Si +0.748272 0.506458 0.752443 Si +0.744373 0.752620 -0.001382 Si +0.749078 0.750121 0.249336 Si +0.750750 0.747982 0.499201 Si +0.747734 0.749730 0.746002 Si +0.187469 0.122464 0.189217 Si +0.184052 0.126282 0.437630 Si +0.180841 0.131891 0.692717 Si +0.187955 0.126552 0.941521 Si +0.190406 0.372753 0.187942 Si +0.185969 0.375798 0.438707 Si +0.190932 0.369119 0.683643 Si +0.184574 0.379973 0.942675 Si +0.186188 0.629074 0.191760 Si +0.186757 0.629134 0.443758 Si +0.189067 0.624236 0.687615 Si +0.185067 0.627484 0.938558 Si +0.188650 0.875055 0.188436 Si +0.189488 0.872896 0.434502 Si +0.188558 0.874926 0.687882 Si +0.189431 0.877489 0.938528 Si +0.434486 0.127784 0.186098 Si +0.437186 0.126922 0.436987 Si +0.430043 0.128728 0.693003 Si +0.435968 0.126353 0.933531 Si +0.439790 0.371458 0.184592 Si +0.435504 0.378703 0.441008 Si +0.440051 0.376642 0.688726 Si +0.438845 0.375748 0.937328 Si +0.441756 0.618757 0.184083 Si +0.440481 0.623350 0.435743 Si +0.434662 0.624163 0.686391 Si +0.438961 0.626271 0.940724 Si +0.436167 0.873872 0.183818 Si +0.442474 0.870235 0.433385 Si +0.433970 0.877630 0.687396 Si +0.437553 0.876921 0.938552 Si +0.685077 0.128538 0.190597 Si +0.688620 0.123968 0.436125 Si +0.686134 0.129310 0.685286 Si +0.686645 0.132644 0.943020 Si +0.687873 0.373540 0.186993 Si +0.689695 0.374393 0.438742 Si +0.686614 0.376172 0.689488 Si +0.687637 0.374833 0.938885 Si +0.690119 0.620944 0.187764 Si +0.685863 0.624962 0.438326 Si +0.687946 0.625392 0.686429 Si +0.688831 0.626261 0.939012 Si +0.688685 0.873769 0.186379 Si +0.690407 0.872704 0.436420 Si +0.690068 0.868895 0.681756 Si +0.689423 0.869237 0.939286 Si +0.934735 0.127559 0.186834 Si +0.939562 0.125044 0.437563 Si +0.935312 0.129003 0.689791 Si +0.940475 0.127166 0.937939 Si +0.942430 0.373299 0.186505 Si +0.937508 0.372289 0.436061 Si +0.936880 0.371913 0.686790 Si +0.935704 0.377405 0.934935 Si +0.935908 0.624800 0.189670 Si +0.940868 0.623802 0.437307 Si +0.939283 0.623943 0.684337 Si +0.936195 0.626949 0.942072 Si +0.936474 0.875867 0.187693 Si +0.939995 0.871104 0.436789 Si +0.938360 0.874652 0.687098 Si +0.938896 0.873531 0.937362 Si diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POTCAR b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POTCAR new file mode 100644 index 000000000..ae2291fdf --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/inputs/POTCAR @@ -0,0 +1,1768 @@ + PAW_PBE Si 05Jan2001 + 4.00000000000000000 + parameters from PSCTR are: + VRHFIN =Si: s2p2 + LEXCH = PE + EATOM = 103.0669 eV, 7.5752 Ry + + TITEL = PAW_PBE Si 05Jan2001 + LULTRA = F use ultrasoft PP ? + IUNSCR = 1 unscreen: 0-lin 1-nonlin 2-no + RPACOR = 1.500 partial core radius + POMASS = 28.085; ZVAL = 4.000 mass and valenz + RCORE = 1.900 outmost cutoff radius + RWIGS = 2.480; RWIGS = 1.312 wigner-seitz radius (au A) + ENMAX = 245.345; ENMIN = 184.009 eV + ICORE = 2 local potential + LCOR = T correct aug charges + LPAW = T paw PP + EAUG = 322.069 + DEXC = -.007 + RMAX = 2.944 core radius for proj-oper + RAUG = 1.300 factor for augmentation sphere + RDEP = 1.993 radius for radial grids + QCUT = -4.246; QGAM = 8.493 optimization parameters + + Description + l E TYP RCUT TYP RCUT + 0 .000 23 1.900 + 0 .000 23 1.900 + 1 .000 23 1.900 + 1 .000 23 1.900 + 2 .000 7 1.900 + Error from kinetic energy argument (eV) + NDATA = 100 + STEP = 20.000 1.050 + 10.1 9.04 8.56 7.65 7.23 6.44 5.73 5.40 + 4.79 4.25 4.00 3.54 3.13 2.77 2.45 2.16 + 1.91 1.69 1.50 1.24 1.10 .975 .812 .718 + .636 .529 .440 .388 .322 .266 .219 .180 + .148 .121 .986E-01 .804E-01 .614E-01 .504E-01 .392E-01 .328E-01 + .265E-01 .220E-01 .189E-01 .166E-01 .149E-01 .135E-01 .123E-01 .109E-01 + .977E-02 .840E-02 .707E-02 .605E-02 .488E-02 .387E-02 .290E-02 .229E-02 + .185E-02 .152E-02 .134E-02 .125E-02 .121E-02 .117E-02 .112E-02 .102E-02 + .915E-03 .776E-03 .640E-03 .524E-03 .425E-03 .369E-03 .331E-03 .310E-03 + .294E-03 .273E-03 .242E-03 .210E-03 .175E-03 .146E-03 .124E-03 .113E-03 + .105E-03 .973E-04 .879E-04 .755E-04 .633E-04 .539E-04 .478E-04 .438E-04 + .404E-04 .362E-04 .308E-04 .264E-04 .229E-04 .209E-04 .192E-04 .170E-04 + .145E-04 .126E-04 .112E-04 .103E-04 +END of PSCTR-controll parameters + local part + 98.2657514061040160 + .84157696E+01 .84210616E+01 .84276868E+01 .84387430E+01 .84542501E+01 + .84742336E+01 .84987229E+01 .85277486E+01 .85613410E+01 .85995276E+01 + .86423322E+01 .86897735E+01 .87418643E+01 .87986117E+01 .88600162E+01 + .89260725E+01 .89967686E+01 .90720854E+01 .91519966E+01 .92364669E+01 + .93254512E+01 .94188926E+01 .95167214E+01 .96188530E+01 .97251866E+01 + .98356042E+01 .99499691E+01 .10068126E+02 .10189900E+02 .10315095E+02 + .10443498E+02 .10574872E+02 .10708964E+02 .10845497E+02 .10984178E+02 + .11124691E+02 .11266702E+02 .11409858E+02 .11553785E+02 .11698096E+02 + .11842382E+02 .11986223E+02 .12129182E+02 .12270810E+02 .12410650E+02 + .12548232E+02 .12683081E+02 .12814718E+02 .12942658E+02 .13066416E+02 + .13185509E+02 .13299456E+02 .13407780E+02 .13510014E+02 .13605699E+02 + .13694388E+02 .13775652E+02 .13849074E+02 .13914259E+02 .13970835E+02 + .14018449E+02 .14056778E+02 .14085523E+02 .14104415E+02 .14113216E+02 + .14111719E+02 .14099752E+02 .14077176E+02 .14043889E+02 .13999825E+02 + .13944955E+02 .13879288E+02 .13802872E+02 .13715793E+02 .13618173E+02 + .13510175E+02 .13391996E+02 .13263872E+02 .13126073E+02 .12978903E+02 + .12822702E+02 .12657838E+02 .12484712E+02 .12303753E+02 .12115415E+02 + .11920177E+02 .11718543E+02 .11511033E+02 .11298186E+02 .11080557E+02 + .10858712E+02 .10633228E+02 .10404688E+02 .10173679E+02 .99407918E+01 + .97066146E+01 .94717325E+01 .92367246E+01 .90021609E+01 .87686001E+01 + .85365874E+01 .83066514E+01 .80793026E+01 .78550308E+01 .76343035E+01 + .74175636E+01 .72052280E+01 .69976861E+01 .67952984E+01 .65983952E+01 + .64072758E+01 .62222076E+01 .60434252E+01 .58711303E+01 .57054911E+01 + .55466426E+01 .53946862E+01 .52496902E+01 .51116906E+01 .49806911E+01 + .48566645E+01 .47395534E+01 .46292712E+01 .45257038E+01 .44287105E+01 + .43381258E+01 .42537607E+01 .41754049E+01 .41028282E+01 .40357822E+01 + .39740031E+01 .39172124E+01 .38651203E+01 .38174267E+01 .37738238E+01 + .37339979E+01 .36976315E+01 .36644056E+01 .36340010E+01 .36061008E+01 + .35803917E+01 .35565663E+01 .35343243E+01 .35133745E+01 .34934357E+01 + .34742388E+01 .34555274E+01 .34370596E+01 .34186083E+01 .33999627E+01 + .33809285E+01 .33613290E+01 .33410052E+01 .33198164E+01 .32976401E+01 + .32743723E+01 .32499276E+01 .32242387E+01 .31972561E+01 .31689481E+01 + .31393000E+01 .31083133E+01 .30760055E+01 .30424087E+01 .30075693E+01 + .29715463E+01 .29344112E+01 .28962459E+01 .28571426E+01 .28172018E+01 + .27765317E+01 .27352466E+01 .26934662E+01 .26513138E+01 .26089155E+01 + .25663991E+01 .25238927E+01 .24815236E+01 .24394173E+01 .23976966E+01 + .23564804E+01 .23158831E+01 .22760134E+01 .22369739E+01 .21988600E+01 + .21617599E+01 .21257533E+01 .20909116E+01 .20572974E+01 .20249638E+01 + .19939548E+01 .19643045E+01 .19360379E+01 .19091701E+01 .18837069E+01 + .18596450E+01 .18369720E+01 .18156670E+01 .17957010E+01 .17770368E+01 + .17596305E+01 .17434311E+01 .17283816E+01 .17144193E+01 .17014768E+01 + .16894823E+01 .16783607E+01 .16680338E+01 .16584212E+01 .16494415E+01 + .16410120E+01 .16330504E+01 .16254746E+01 .16182040E+01 .16111597E+01 + .16042653E+01 .15974473E+01 .15906355E+01 .15837638E+01 .15767703E+01 + .15695978E+01 .15621941E+01 .15545123E+01 .15465111E+01 .15381544E+01 + .15294125E+01 .15202610E+01 .15106817E+01 .15006619E+01 .14901947E+01 + .14792788E+01 .14679182E+01 .14561221E+01 .14439046E+01 .14312844E+01 + .14182846E+01 .14049321E+01 .13912574E+01 .13772942E+01 .13630791E+01 + .13486509E+01 .13340503E+01 .13193195E+01 .13045019E+01 .12896412E+01 + .12747815E+01 .12599666E+01 .12452397E+01 .12306428E+01 .12162167E+01 + .12020006E+01 .11880314E+01 .11743437E+01 .11609697E+01 .11479386E+01 + .11352766E+01 .11230067E+01 .11111486E+01 .10997186E+01 .10887293E+01 + .10781902E+01 .10681067E+01 .10584813E+01 .10493127E+01 .10405964E+01 + .10323246E+01 .10244865E+01 .10170685E+01 .10100542E+01 .10034245E+01 + .99715846E+00 .99123280E+00 .98562260E+00 .98030145E+00 .97524173E+00 + .97041488E+00 .96579171E+00 .96134265E+00 .95703806E+00 .95284844E+00 + .94874473E+00 .94469858E+00 .94068254E+00 .93667031E+00 .93263696E+00 + .92855909E+00 .92441506E+00 .92018509E+00 .91585142E+00 .91139842E+00 + .90681263E+00 .90208291E+00 .89720039E+00 .89215854E+00 .88695315E+00 + .88158229E+00 .87604630E+00 .87034770E+00 .86449110E+00 .85848313E+00 + .85233229E+00 .84604884E+00 .83964465E+00 .83313300E+00 .82652847E+00 + .81984671E+00 .81310428E+00 .80631845E+00 .79950703E+00 .79268813E+00 + .78588003E+00 .77910097E+00 .77236895E+00 .76570159E+00 .75911593E+00 + .75262828E+00 .74625407E+00 .74000773E+00 .73390251E+00 .72795041E+00 + .72216209E+00 .71654675E+00 .71111209E+00 .70586428E+00 .70080787E+00 + .69594584E+00 .69127954E+00 .68680877E+00 .68253173E+00 .67844513E+00 + .67454418E+00 .67082274E+00 .66727331E+00 .66388721E+00 .66065462E+00 + .65756473E+00 .65460586E+00 .65176555E+00 .64903076E+00 .64638795E+00 + .64382325E+00 .64132257E+00 .63887178E+00 .63645678E+00 .63406371E+00 + .63167900E+00 .62928956E+00 .62688288E+00 .62444710E+00 .62197118E+00 + .61944494E+00 .61685919E+00 .61420575E+00 .61147755E+00 .60866866E+00 + .60577434E+00 .60279104E+00 .59971643E+00 .59654939E+00 .59329003E+00 + .58993961E+00 .58650056E+00 .58297643E+00 .57937181E+00 .57569230E+00 + .57194440E+00 .56813547E+00 .56427363E+00 .56036764E+00 .55642683E+00 + .55246099E+00 .54848026E+00 .54449503E+00 .54051583E+00 .53655322E+00 + .53261771E+00 .52871961E+00 .52486898E+00 .52107551E+00 .51734843E+00 + .51369641E+00 .51012750E+00 .50664907E+00 .50326768E+00 .49998911E+00 + .49681824E+00 .49375908E+00 .49081468E+00 .48798715E+00 .48527763E+00 + .48268632E+00 .48021244E+00 .47785431E+00 .47560930E+00 .47347392E+00 + .47144387E+00 .46951402E+00 .46767855E+00 .46593095E+00 .46426412E+00 + .46267047E+00 .46114194E+00 .45967012E+00 .45824632E+00 .45686169E+00 + .45550723E+00 .45417395E+00 .45285292E+00 .45153535E+00 .45021267E+00 + .44887661E+00 .44751931E+00 .44613331E+00 .44471171E+00 .44324816E+00 + .44173692E+00 .44017295E+00 .43855190E+00 .43687017E+00 .43512491E+00 + .43331405E+00 .43143631E+00 .42949120E+00 .42747899E+00 .42540073E+00 + .42325823E+00 .42105400E+00 .41879126E+00 .41647384E+00 .41410622E+00 + .41169341E+00 .40924089E+00 .40675462E+00 .40424088E+00 .40170629E+00 + .39915769E+00 .39660209E+00 .39404660E+00 .39149835E+00 .38896445E+00 + .38645189E+00 .38396749E+00 .38151784E+00 .37910923E+00 .37674758E+00 + .37443844E+00 .37218685E+00 .36999739E+00 .36787409E+00 .36582039E+00 + .36383915E+00 .36193261E+00 .36010239E+00 .35834945E+00 .35667414E+00 + .35507613E+00 .35355450E+00 .35210772E+00 .35073362E+00 .34942953E+00 + .34819219E+00 .34701788E+00 .34590241E+00 .34484117E+00 .34382921E+00 + .34286125E+00 .34193178E+00 .34103506E+00 .34016522E+00 .33931629E+00 + .33848229E+00 .33765725E+00 .33683525E+00 .33601054E+00 .33517754E+00 + .33433091E+00 .33346559E+00 .33257683E+00 .33166028E+00 .33071198E+00 + .32972841E+00 .32870651E+00 .32764370E+00 .32653791E+00 .32538758E+00 + .32419168E+00 .32294968E+00 .32166161E+00 .32032797E+00 .31894980E+00 + .31752862E+00 .31606640E+00 .31456556E+00 .31302895E+00 .31145977E+00 + .30986158E+00 .30823823E+00 .30659385E+00 .30493275E+00 .30325946E+00 + .30157859E+00 .29989486E+00 .29821301E+00 .29653778E+00 .29487386E+00 + .29322581E+00 .29159807E+00 .28999490E+00 .28842031E+00 .28687807E+00 + .28537164E+00 .28390415E+00 .28247839E+00 .28109677E+00 .27976132E+00 + .27847363E+00 .27723491E+00 .27604592E+00 .27490700E+00 .27381809E+00 + .27277867E+00 .27178784E+00 .27084428E+00 .26994630E+00 .26909186E+00 + .26827855E+00 .26750369E+00 .26676430E+00 .26605715E+00 .26537882E+00 + .26472568E+00 .26409398E+00 .26347988E+00 .26287945E+00 .26228874E+00 + .26170381E+00 .26112076E+00 .26053579E+00 .25994520E+00 .25934545E+00 + .25873320E+00 .25810531E+00 .25745888E+00 .25679129E+00 .25610022E+00 + .25538363E+00 .25463983E+00 .25386744E+00 .25306545E+00 .25223318E+00 + .25137030E+00 .25047684E+00 .24955316E+00 .24859996E+00 .24761829E+00 + .24660949E+00 .24557519E+00 .24451731E+00 .24343801E+00 .24233971E+00 + .24122498E+00 .24009659E+00 .23895746E+00 .23781060E+00 .23665912E+00 + .23550617E+00 .23435492E+00 .23320855E+00 .23207016E+00 .23094281E+00 + .22982945E+00 .22873289E+00 .22765579E+00 .22660063E+00 .22556967E+00 + .22456498E+00 .22358834E+00 .22264131E+00 .22172517E+00 .22084092E+00 + .21998928E+00 .21917068E+00 .21838526E+00 .21763287E+00 .21691308E+00 + .21622517E+00 .21556818E+00 .21494086E+00 .21434175E+00 .21376913E+00 + .21322111E+00 .21269560E+00 .21219035E+00 .21170297E+00 .21123098E+00 + .21077179E+00 .21032276E+00 .20988120E+00 .20944443E+00 .20900979E+00 + .20857462E+00 .20813639E+00 .20769262E+00 .20724095E+00 .20677916E+00 + .20630522E+00 .20581722E+00 .20531350E+00 .20479256E+00 .20425315E+00 + .20369424E+00 .20311502E+00 .20251496E+00 .20189372E+00 .20125124E+00 + .20058769E+00 .19990349E+00 .19919926E+00 .19847589E+00 .19773443E+00 + .19697618E+00 .19620258E+00 .19541527E+00 .19461602E+00 .19380673E+00 + .19298941E+00 .19216618E+00 .19133918E+00 .19051063E+00 .18968276E+00 + .18885780E+00 .18803797E+00 .18722542E+00 .18642227E+00 .18563052E+00 + .18485209E+00 .18408877E+00 .18334220E+00 .18261388E+00 .18190512E+00 + .18121707E+00 .18055068E+00 .17990670E+00 .17928569E+00 .17868800E+00 + .17811376E+00 .17756291E+00 .17703518E+00 .17653009E+00 .17604697E+00 + .17558497E+00 .17514306E+00 .17472002E+00 .17431452E+00 .17392507E+00 + .17355005E+00 .17318776E+00 .17283640E+00 .17249410E+00 .17215895E+00 + .17182901E+00 .17150232E+00 .17117693E+00 .17085094E+00 .17052245E+00 + .17018966E+00 .16985084E+00 .16950435E+00 .16914867E+00 .16878242E+00 + .16840433E+00 .16801331E+00 .16760841E+00 .16718886E+00 .16675406E+00 + .16630358E+00 .16583717E+00 .16535477E+00 .16485650E+00 .16434264E+00 + .16381366E+00 .16327018E+00 .16271301E+00 .16214308E+00 .16156147E+00 + .16096939E+00 .16036817E+00 .15975923E+00 .15914407E+00 .15852427E+00 + .15790145E+00 .15727728E+00 .15665345E+00 .15603163E+00 .15541350E+00 + .15480071E+00 .15419486E+00 .15359747E+00 .15301002E+00 .15243388E+00 + .15187030E+00 .15132044E+00 .15078533E+00 .15026585E+00 .14976275E+00 + .14927662E+00 .14880791E+00 .14835691E+00 .14792374E+00 .14750838E+00 + .14711065E+00 .14673019E+00 .14636653E+00 .14601903E+00 .14568691E+00 + .14536927E+00 .14506509E+00 .14477325E+00 .14449251E+00 .14422157E+00 + .14395905E+00 .14370352E+00 .14345350E+00 .14320750E+00 .14296399E+00 + .14272149E+00 .14247848E+00 .14223350E+00 .14198515E+00 .14173206E+00 + .14147294E+00 .14120659E+00 .14093190E+00 .14064788E+00 .14035363E+00 + .14004840E+00 .13973155E+00 .13940258E+00 .13906112E+00 .13870694E+00 + .13833997E+00 .13796025E+00 .13756799E+00 .13716350E+00 .13674725E+00 + .13631982E+00 .13588193E+00 .13543440E+00 .13497814E+00 .13451417E+00 + .13404360E+00 .13356759E+00 .13308736E+00 .13260419E+00 .13211937E+00 + .13163425E+00 .13115013E+00 .13066836E+00 .13019023E+00 .12971703E+00 + .12924998E+00 .12879027E+00 .12833900E+00 .12789721E+00 .12746584E+00 + .12704575E+00 .12663767E+00 .12624224E+00 .12585999E+00 .12549130E+00 + .12513646E+00 .12479563E+00 .12446883E+00 .12415596E+00 .12385682E+00 + .12357106E+00 .12329824E+00 .12303778E+00 .12278902E+00 .12255119E+00 + .12232344E+00 .12210482E+00 .12189434E+00 .12169092E+00 .12149346E+00 + .12130080E+00 .12111176E+00 .12092515E+00 .12073978E+00 .12055446E+00 + .12036801E+00 .12017930E+00 .11998723E+00 .11979076E+00 .11958890E+00 + .11938073E+00 .11916544E+00 .11894226E+00 .11871055E+00 .11846975E+00 + .11821943E+00 .11795923E+00 .11768892E+00 .11740838E+00 .11711760E+00 + .11681667E+00 .11650581E+00 .11618532E+00 .11585561E+00 .11551720E+00 + .11517070E+00 .11481679E+00 .11445623E+00 .11408986E+00 .11371858E+00 + .11334333E+00 .11296511E+00 .11258491E+00 .11220379E+00 .11182279E+00 + .11144296E+00 .11106534E+00 .11069096E+00 .11032079E+00 .10995580E+00 + .10959689E+00 .10924491E+00 .10890064E+00 .10856478E+00 .10823798E+00 + .10792077E+00 .10761362E+00 .10731688E+00 .10703084E+00 .10675565E+00 + .10649140E+00 .10623807E+00 .10599552E+00 .10576356E+00 .10554186E+00 + .10533004E+00 .10512760E+00 .10493399E+00 .10474857E+00 .10457063E+00 + .10439942E+00 .10423412E+00 .10407387E+00 .10391779E+00 .10376497E+00 + .10361446E+00 .10346535E+00 .10331669E+00 .10316756E+00 .10301705E+00 + .10286430E+00 .10270846E+00 .10254874E+00 .10238439E+00 .10221475E+00 + .10203918E+00 .10185715E+00 .10166820E+00 .10147193E+00 .10126804E+00 + .10105631E+00 .10083661E+00 .10060889E+00 .10037320E+00 .10012965E+00 + .99878467E-01 .99619932E-01 .99354416E-01 .99082363E-01 .98804288E-01 + .98520765E-01 .98232428E-01 .97939960E-01 .97644087E-01 .97345569E-01 + .97045195E-01 .96743772E-01 .96442116E-01 .96141050E-01 .95841391E-01 + .95543942E-01 .95249488E-01 .94958785E-01 .94672554E-01 .94391474E-01 + .94116174E-01 .93847229E-01 .93585152E-01 .93330392E-01 .93083329E-01 + .92844268E-01 .92613442E-01 .92391008E-01 .92177045E-01 .91971556E-01 + .91774467E-01 .91585628E-01 .91404815E-01 .91231735E-01 .91066024E-01 + .90907255E-01 .90754941E-01 .90608543E-01 .90467470E-01 .90331093E-01 + .90198744E-01 .90069732E-01 .89943339E-01 .89818838E-01 .89695492E-01 + .89572566E-01 .89449332E-01 .89325075E-01 .89199102E-01 .89070749E-01 + .88939383E-01 .88804416E-01 .88665301E-01 .88521548E-01 .88372720E-01 + .88218440E-01 .88058396E-01 .87892342E-01 .87720097E-01 .87541550E-01 + .87356660E-01 .87165453E-01 .86968025E-01 .86764537E-01 .86555218E-01 + .86340357E-01 .86120303E-01 .85895462E-01 .85666290E-01 .85433289E-01 + .85197004E-01 .84958012E-01 .84716921E-01 .84474359E-01 .84230970E-01 + .83987410E-01 .83744335E-01 .83502399E-01 .83262247E-01 .83024506E-01 + .82789784E-01 .82558658E-01 .82331673E-01 .82109336E-01 .81892108E-01 + .81680401E-01 .81474576E-01 .81274938E-01 .81081732E-01 .80895145E-01 + .80715299E-01 .80542258E-01 .80376020E-01 .80216523E-01 .80063643E-01 + .79917196E-01 .79776941E-01 .79642582E-01 .79513768E-01 .79390103E-01 + .79271145E-01 .79156412E-01 .79045389E-01 .78937532E-01 .78832272E-01 + .78729025E-01 .78627196E-01 .78526182E-01 .78425382E-01 .78324201E-01 + .78222055E-01 .78118379E-01 .78012628E-01 .77904287E-01 .77792874E-01 + .77677943E-01 .77559095E-01 .77435971E-01 .77308267E-01 .77175728E-01 + .77038154E-01 .76895403E-01 .76747386E-01 .76594073E-01 .76435492E-01 + .76271726E-01 .76102913E-01 .75929245E-01 .75750968E-01 .75568374E-01 + gradient corrections used for XC + 5 + core charge-density (partial) + .13681950E+01 .13676960E+01 .13662001E+01 .13637105E+01 .13602325E+01 + .13557734E+01 .13503429E+01 .13439524E+01 .13366153E+01 .13283473E+01 + .13191655E+01 .13090892E+01 .12981393E+01 .12863384E+01 .12737107E+01 + .12602820E+01 .12460794E+01 .12311314E+01 .12154677E+01 .11991194E+01 + .11821181E+01 .11644970E+01 .11462895E+01 .11275301E+01 .11082538E+01 + .10884962E+01 .10682931E+01 .10476808E+01 .10266957E+01 .10053741E+01 + .98375267E+00 .96186759E+00 .93975503E+00 .91745077E+00 .89499021E+00 + .87240826E+00 .84973926E+00 .82701690E+00 .80427415E+00 .78154320E+00 + .75885536E+00 .73624104E+00 .71372967E+00 .69134969E+00 .66912843E+00 + .64709213E+00 .62526592E+00 .60367371E+00 .58233824E+00 .56128104E+00 + .54052238E+00 .52008130E+00 .49997559E+00 .48022178E+00 .46083513E+00 + .44182968E+00 .42321820E+00 .40501225E+00 .38722216E+00 .36985707E+00 + .35292495E+00 .33643262E+00 .32038578E+00 .30478902E+00 .28964588E+00 + .27495886E+00 .26072949E+00 .24695832E+00 .23364498E+00 .22078822E+00 + .20838596E+00 .19643530E+00 .18493258E+00 .17387344E+00 .16325283E+00 + .15306507E+00 .14330386E+00 .13396240E+00 .12503332E+00 .11650883E+00 + .10838067E+00 .10064023E+00 .93278522E-01 .86286250E-01 .79653846E-01 + .73371505E-01 .67429216E-01 .61816797E-01 .56523934E-01 .51540202E-01 + .46855108E-01 .42458109E-01 .38338647E-01 .34486174E-01 .30890174E-01 + .27540191E-01 .24425850E-01 .21536879E-01 .18863125E-01 .16394577E-01 + .14121382E-01 .12033860E-01 .10122516E-01 .83780589E-02 .67914092E-02 + .53537108E-02 .40563408E-02 .28909177E-02 .18493086E-02 .92363545E-03 + .10628041E-03 -.61011044E-03 -.12326237E-02 -.17680763E-02 -.22230146E-02 + -.26037134E-02 -.29161762E-02 -.31661368E-02 -.33590603E-02 -.35001462E-02 + -.35943310E-02 -.36462916E-02 -.36604501E-02 -.36409780E-02 -.35918012E-02 + -.35166058E-02 -.34188439E-02 -.33017396E-02 -.31682957E-02 -.30213004E-02 + -.28633344E-02 -.26967780E-02 -.25238182E-02 -.23464568E-02 -.21665171E-02 + -.19856525E-02 -.18053531E-02 -.16269545E-02 -.14516446E-02 -.12804716E-02 + -.11143516E-02 -.95407590E-03 -.80031868E-03 -.65364406E-03 -.51451335E-03 + -.38329201E-03 -.26025656E-03 -.14560117E-03 -.39444206E-04 .58165516E-04 + .14724263E-03 .22785937E-03 .30013989E-03 .36425487E-03 .42041630E-03 + .46887251E-03 .50990347E-03 .54381628E-03 .57094091E-03 .59162620E-03 + .60623608E-03 .61514601E-03 .61873968E-03 .61740593E-03 .61153588E-03 + .60152031E-03 .58774722E-03 .57059965E-03 .55045362E-03 .52767640E-03 + .50262485E-03 .47564400E-03 .44706580E-03 .41720805E-03 .38637350E-03 + .35484906E-03 .32290522E-03 .29079555E-03 .25875641E-03 .22700669E-03 + .19574775E-03 .16516340E-03 .13542004E-03 .10666685E-03 .79036088E-04 + .52643451E-04 .27588517E-04 .39552464E-05 -.18187465E-04 -.38785178E-04 + -.57797264E-04 -.75196221E-04 -.90966959E-04 -.10510606E-03 -.11762104E-03 + -.12852953E-03 -.13785858E-03 -.14564378E-03 -.15192858E-03 -.15676343E-03 + -.16020507E-03 -.16231575E-03 -.16316249E-03 -.16281641E-03 -.16135195E-03 + -.15884628E-03 -.15537859E-03 -.15102952E-03 -.14588056E-03 -.14001345E-03 + -.13350974E-03 -.12645021E-03 -.11891448E-03 -.11098056E-03 -.10272445E-03 + -.94219808E-04 -.85537643E-04 -.76746000E-04 -.67909727E-04 -.59090263E-04 + -.50345446E-04 -.41729367E-04 -.33292247E-04 -.25080349E-04 -.17135911E-04 + -.94971159E-05 -.21980781E-05 .47311376E-05 .11264479E-04 .17379846E-04 + .23059012E-04 .28287521E-04 .33054577E-04 .37352910E-04 .41178632E-04 + .44531079E-04 .47412645E-04 .49828605E-04 .51786930E-04 .53298094E-04 + .54374884E-04 .55032195E-04 .55286832E-04 .55157309E-04 .54663646E-04 + .53827166E-04 .52670302E-04 .51216402E-04 .49489534E-04 .47514310E-04 + .45315700E-04 .42918863E-04 .40348986E-04 .37631124E-04 .34790051E-04 + .31850126E-04 .28835162E-04 .25768303E-04 .22671916E-04 .19567494E-04 + .16475560E-04 .13415592E-04 .10405948E-04 .74638126E-05 .46051404E-05 + .18446197E-05 -.80436009E-06 -.33297302E-05 -.57207550E-05 -.79680369E-05 + -.10063512E-04 -.12000439E-04 -.13773381E-04 -.15378177E-04 -.16811912E-04 + -.18072880E-04 -.19160536E-04 -.20075451E-04 -.20819258E-04 -.21394593E-04 + -.21805038E-04 -.22055054E-04 -.22149917E-04 -.22095649E-04 -.21898951E-04 + -.21567128E-04 -.21108022E-04 -.20529940E-04 -.19841582E-04 -.19051971E-04 + -.18170387E-04 -.17206293E-04 -.16169276E-04 -.15068980E-04 -.13915042E-04 + -.12717039E-04 -.11484427E-04 -.10226489E-04 -.89522887E-05 -.76706186E-05 + -.63899617E-05 -.51184500E-05 -.38638299E-05 -.26334298E-05 -.14341327E-05 + -.27235171E-06 .84599016E-06 .19154768E-05 .29312118E-05 .38888277E-05 + .47844919E-05 .56149089E-05 .63773192E-05 .70694955E-05 .76897350E-05 + .82368500E-05 .87101545E-05 .91094496E-05 .94350052E-05 .96875413E-05 + .98682052E-05 .99785491E-05 .10020505E-04 .99963570E-05 .99087173E-05 + .97604944E-05 .95548661E-05 .92952495E-05 .89852710E-05 .86287366E-05 + .82296019E-05 .77919423E-05 .73199237E-05 .68177739E-05 .62897539E-05 + .57401315E-05 .51731543E-05 .45930247E-05 .40038758E-05 .34097487E-05 + .28145712E-05 .22221377E-05 .16360907E-05 .10599042E-05 .49686829E-06 + -.49924253E-07 -.57759018E-06 -.10834658E-05 -.15651156E-05 -.20203391E-05 + -.24471763E-05 -.28439110E-05 -.32090729E-05 -.35414382E-05 -.38400286E-05 + -.41041086E-05 -.43331819E-05 -.45269862E-05 -.46854867E-05 -.48088688E-05 + -.48975294E-05 -.49520671E-05 -.49732722E-05 -.49621152E-05 -.49197348E-05 + -.48474253E-05 -.47466238E-05 -.46188963E-05 -.44659241E-05 -.42894897E-05 + -.40914626E-05 -.38737848E-05 -.36384571E-05 -.33875243E-05 -.31230618E-05 + -.28471617E-05 -.25619196E-05 -.22694215E-05 -.19717316E-05 -.16708804E-05 + -.13688530E-05 -.10675792E-05 -.76892250E-06 -.47467171E-06 -.18653188E-06 + .93883276E-07 .36505838E-06 .62558254E-06 .87415472E-06 .11095882E-05 + .13308143E-05 .15368851E-05 .17269757E-05 .19003854E-05 .20565379E-05 + .21949813E-05 .23153868E-05 .24175471E-05 .25013741E-05 .25668952E-05 + .26142503E-05 .26436874E-05 .26555573E-05 .26503093E-05 .26284844E-05 + .25907101E-05 .25376938E-05 .24702158E-05 .23891225E-05 .22953197E-05 + .21897645E-05 .20734587E-05 .19474411E-05 .18127798E-05 .16705653E-05 + .15219029E-05 .13679056E-05 .12096872E-05 .10483551E-05 .88500422E-06 + .72071043E-06 .55652452E-06 .39346658E-06 .23252066E-06 .74629737E-07 + -.79308789E-07 -.22844732E-06 -.37199180E-06 -.50920504E-06 -.63940961E-06 + -.76199029E-06 -.87639606E-06 -.98214167E-06 -.10788088E-05 -.11660466E-05 + -.12435721E-05 -.13111700E-05 -.13686922E-05 -.14160567E-05 -.14532461E-05 + -.14803064E-05 -.14973448E-05 -.15045271E-05 -.15020754E-05 -.14902650E-05 + -.14694216E-05 -.14399174E-05 -.14021681E-05 -.13566289E-05 -.13037909E-05 + -.12441768E-05 -.11783371E-05 -.11068459E-05 -.10302970E-05 -.94929926E-06 + -.86447308E-06 -.77644588E-06 -.68584828E-06 -.59331011E-06 -.49945662E-06 + -.40490476E-06 -.31025967E-06 -.21611128E-06 -.12303110E-06 -.31569232E-07 + .57748417E-07 .14442274E-06 .22798375E-06 .30799272E-06 .38404404E-06 + .45576684E-06 .52282633E-06 .58492498E-06 .64180332E-06 .69324058E-06 + .73905504E-06 .77910418E-06 .81328449E-06 .84153118E-06 .86381756E-06 + .88015426E-06 .89058820E-06 .89520145E-06 .89410978E-06 .88746118E-06 + .87543410E-06 .85823565E-06 .83609958E-06 .80928424E-06 .77807038E-06 + .74275888E-06 .70366841E-06 .66113309E-06 .61550004E-06 .56712696E-06 + .51637968E-06 .46362976E-06 .40925205E-06 .35362235E-06 .29711509E-06 + .24010107E-06 .18294532E-06 .12600496E-06 .69627264E-07 .14147759E-07 + -.40111547E-07 -.92843792E-07 -.14375878E-06 -.19258433E-06 -.23906756E-06 + -.28297591E-06 -.32409812E-06 -.36224500E-06 -.39725006E-06 -.42897001E-06 + -.45728507E-06 -.48209916E-06 -.50333994E-06 -.52095868E-06 -.53493001E-06 + -.54525155E-06 -.55194338E-06 -.55504739E-06 -.55462656E-06 -.55076402E-06 + -.54356216E-06 -.53314150E-06 -.51963959E-06 -.50320973E-06 -.48401975E-06 + -.46225056E-06 -.43809484E-06 -.41175555E-06 -.38344448E-06 -.35338073E-06 + -.32178926E-06 -.28889934E-06 -.25494308E-06 -.22015395E-06 -.18476531E-06 + -.14900903E-06 -.11311405E-06 -.77305110E-07 -.41801433E-07 -.68155287E-08 + .27447957E-07 .60793314E-07 .93034769E-07 .12399739E-06 .15351793E-06 + .18144553E-06 .20764243E-06 .23198447E-06 .25436154E-06 .27467801E-06 + .29285294E-06 .30882027E-06 .32252892E-06 .33394275E-06 .34304049E-06 + .34981549E-06 .35427554E-06 .35644241E-06 .35635150E-06 .35405130E-06 + .34960280E-06 .34307888E-06 .33456359E-06 .32415143E-06 .31194653E-06 + .29806180E-06 .28261809E-06 .26574327E-06 .24757131E-06 .22824130E-06 + .20789655E-06 .18668360E-06 .16475125E-06 .14224962E-06 .11932921E-06 + .96139976E-07 .72830407E-07 .49546673E-07 .26431773E-07 .36247299E-08 + -.18740176E-07 -.40534125E-07 -.61634436E-07 -.81925182E-07 -.10129776E-06 + -.11965142E-06 -.13689368E-06 -.15294077E-06 -.16771791E-06 -.18115966E-06 + -.19321005E-06 -.20382276E-06 -.21296125E-06 -.22059870E-06 -.22671807E-06 + -.23131193E-06 -.23438237E-06 -.23594076E-06 -.23600750E-06 -.23461175E-06 + -.23179103E-06 -.22759086E-06 -.22206431E-06 -.21527152E-06 -.20727921E-06 + -.19816014E-06 -.18799253E-06 -.17685950E-06 -.16484845E-06 -.15205045E-06 + -.13855963E-06 -.12447250E-06 -.10988738E-06 -.94903693E-07 -.79621403E-07 + -.64140357E-07 -.48559691E-07 -.32977235E-07 -.17488949E-07 -.21883673E-08 + .12833922E-07 .27490772E-07 .41698943E-07 .55379535E-07 .68458384E-07 + .80866426E-07 .92540020E-07 .10342123E-06 .11345807E-06 .12260472E-06 + .13082167E-06 .13807584E-06 .14434069E-06 .14959622E-06 .15382900E-06 + .15703211E-06 .15920506E-06 .16035369E-06 .16048999E-06 .15963194E-06 + .15780325E-06 .15503317E-06 .15135615E-06 .14681154E-06 .14144331E-06 + .13529963E-06 .12843256E-06 .12089759E-06 .11275333E-06 .10406100E-06 + .94884087E-07 .85287862E-07 .75338981E-07 .65105041E-07 .54654154E-07 + .44054522E-07 .33374019E-07 .22679784E-07 .12037823E-07 .15126319E-08 + -.88331734E-08 -.18939204E-07 -.28747623E-07 -.38203459E-07 -.47254879E-07 + -.55853459E-07 -.63954411E-07 -.71516793E-07 -.78503690E-07 -.84882368E-07 + -.90624396E-07 -.95705746E-07 -.10010686E-06 -.10381269E-06 -.10681271E-06 + -.10910090E-06 -.11067571E-06 -.11153996E-06 -.11170080E-06 -.11116954E-06 + -.10996154E-06 -.10809603E-06 -.10559591E-06 -.10248761E-06 -.98800764E-07 + -.94568078E-07 -.89825012E-07 -.84609535E-07 -.78961853E-07 -.72924121E-07 + -.66540155E-07 -.59855131E-07 -.52915295E-07 -.45767653E-07 -.38459679E-07 + -.31039013E-07 -.23553171E-07 -.16049254E-07 -.85736709E-08 -.11718662E-08 + .61119401E-08 .13235002E-07 .20156282E-07 .26836672E-07 .33239202E-07 + .39329224E-07 .45074589E-07 .50445798E-07 .55416137E-07 .59961796E-07 + .64061959E-07 .67698890E-07 .70857979E-07 .73527788E-07 .75700062E-07 + .77369726E-07 .78534869E-07 .79196695E-07 .79359469E-07 .79030439E-07 + .78219742E-07 .76940295E-07 .75207668E-07 .73039951E-07 .70457594E-07 + .67483252E-07 .64141602E-07 .60459169E-07 .56464125E-07 .52186096E-07 + .47655955E-07 .42905616E-07 .37967819E-07 .32875920E-07 .27663675E-07 + .22365030E-07 .17013912E-07 .11644017E-07 .62886154E-08 .98035002E-09 + -.42489487E-08 -.93684454E-08 -.14348472E-07 -.19160688E-07 -.23778234E-07 + -.28175873E-07 -.32330112E-07 -.36219324E-07 -.39823850E-07 -.43126080E-07 + -.46110537E-07 -.48763931E-07 -.51075210E-07 -.53035587E-07 -.54638563E-07 + -.55879925E-07 -.56757740E-07 -.57272329E-07 -.57426230E-07 -.57224146E-07 + -.56672886E-07 -.55781287E-07 -.54560129E-07 -.53022041E-07 -.51181392E-07 + -.49054178E-07 -.46657901E-07 -.44011436E-07 -.41134893E-07 -.38049481E-07 + -.34777357E-07 -.31341477E-07 -.27765446E-07 -.24073361E-07 -.20289659E-07 + -.16438960E-07 -.12545917E-07 -.86350647E-08 -.47306693E-08 -.85658746E-09 + .29638742E-08 .67080927E-08 .10354256E-07 .13881483E-07 .17269938E-07 + .20500935E-07 .23557035E-07 .26422131E-07 .29081528E-07 .31522012E-07 + .33731907E-07 .35701122E-07 .37421190E-07 .38885296E-07 .40088291E-07 + .41026702E-07 .41698723E-07 .42104208E-07 .42244640E-07 .42123103E-07 + .41744235E-07 .41114181E-07 .40240528E-07 .39132243E-07 .37799593E-07 + .36254067E-07 .34508283E-07 .32575899E-07 .30471515E-07 .28210563E-07 + .25809209E-07 .23284239E-07 .20652949E-07 .17933030E-07 .15142458E-07 + .12299377E-07 .94219886E-08 .65284367E-08 .36367011E-08 .76448864E-09 + -.20708706E-08 -.48525235E-08 -.75641896E-08 -.10190252E-07 -.12715843E-07 + -.15126924E-07 -.17410360E-07 -.19553985E-07 -.21546662E-07 -.23378338E-07 + -.25040091E-07 -.26524161E-07 -.27823991E-07 -.28934240E-07 -.29850805E-07 + -.30570824E-07 -.31092681E-07 -.31415990E-07 -.31541587E-07 -.31471506E-07 + -.31208947E-07 -.30758242E-07 -.30124811E-07 -.29315117E-07 -.28336607E-07 + -.27197656E-07 -.25907504E-07 -.24476182E-07 -.22914446E-07 -.21233696E-07 + -.19445902E-07 -.17563519E-07 -.15599409E-07 -.13566750E-07 -.11478958E-07 + -.93495989E-08 -.71923027E-08 -.50206814E-08 -.28482455E-08 -.68832285E-09 + .14460198E-08 .35420528E-08 .55874571E-08 .75703930E-08 .94795661E-08 + .11304289E-07 .13034536E-07 .14660999E-07 .16175132E-07 .17569192E-07 + .18836275E-07 .19970351E-07 .20966282E-07 .21819848E-07 .22527755E-07 + .23087645E-07 .23498096E-07 .23758620E-07 .23869653E-07 .23832536E-07 + .23649501E-07 .23323639E-07 .22858875E-07 .22259928E-07 .21532276E-07 + .20682107E-07 .19716277E-07 .18642256E-07 .17468077E-07 .16202275E-07 + .14853832E-07 .13432115E-07 .11946814E-07 .10407878E-07 .88254519E-08 + .72098100E-08 .55712944E-08 .39202488E-08 .22669566E-08 .62157842E-09 + -.10059081E-08 -.26057666E-08 -.41685584E-08 -.56851958E-08 -.71469932E-08 + -.85457147E-08 -.98736182E-08 -.11123496E-07 -.12288713E-07 -.13363238E-07 + -.14341672E-07 -.15219277E-07 -.15991990E-07 -.16656444E-07 -.17209978E-07 + -.17650643E-07 -.17977205E-07 -.18189145E-07 -.18286649E-07 -.18270602E-07 + -.18142572E-07 -.17904790E-07 -.17560130E-07 -.17112081E-07 -.16564719E-07 + -.15922676E-07 -.15191103E-07 -.14375631E-07 -.13482331E-07 -.12517674E-07 + -.11488483E-07 -.10401887E-07 -.92652762E-08 -.80862521E-08 -.68725780E-08 + -.56321299E-08 -.43728474E-08 -.31026842E-08 -.18295592E-08 -.56130924E-09 + .69435835E-09 .19299107E-08 .31380331E-08 .43116711E-08 .54440703E-08 + .65288132E-08 .75598547E-08 .85315540E-08 .94387041E-08 .10276558E-07 + .11040851E-07 .11727823E-07 .12334232E-07 .12857371E-07 .13295074E-07 + .13645724E-07 .13908258E-07 .14082165E-07 .14167479E-07 .14164778E-07 + .14075170E-07 .13900281E-07 .13642236E-07 .13303645E-07 .12887576E-07 + .12397533E-07 .11837429E-07 .11211558E-07 .10524561E-07 .97813978E-08 + .89873084E-08 .81477813E-08 .72685147E-08 .63553801E-08 .54143841E-08 + .44516300E-08 .34732798E-08 .24855153E-08 .14945008E-08 .50634509E-09 + -.47293461E-09 -.14374486E-08 -.23814688E-08 -.32994621E-08 -.41861213E-08 + -.50363950E-08 -.58455154E-08 -.66090238E-08 -.73227938E-08 -.79830533E-08 + -.85864022E-08 -.91298293E-08 -.96107260E-08 -.10026897E-07 -.10376569E-07 + atomic pseudo charge-density + .40000000E+01 .39865777E+01 .39466377E+01 .38811433E+01 .37916420E+01 + .36801845E+01 .35492225E+01 .34014950E+01 .32399100E+01 .30674335E+01 + .28869885E+01 .27013712E+01 .25131849E+01 .23247937E+01 .21382919E+01 + .19554911E+01 .17779180E+01 .16068237E+01 .14431992E+01 .12877965E+01 + .11411517E+01 .10036103E+01 .87535141E+00 .75641220E+00 .64671001E+00 + .54606321E+00 .45420994E+00 .37082490E+00 .29553413E+00 .22792793E+00 + .16757210E+00 .11401744E+00 .66807913E-01 .25487409E-01 -.10394612E-01 + -.41278562E-01 -.67591071E-01 -.89742138E-01 -.10812299E+00 -.12310456E+00 + -.13503646E+00 -.14424640E+00 -.15104001E+00 -.15570097E+00 -.15849133E+00 + -.15965211E+00 -.15940402E+00 -.15794831E+00 -.15546772E+00 -.15212749E+00 + -.14807638E+00 -.14344771E+00 -.13836047E+00 -.13292033E+00 -.12722065E+00 + -.12134348E+00 -.11536052E+00 -.10933401E+00 -.10331756E+00 -.97357004E-01 + -.91491144E-01 -.85752437E-01 -.80167666E-01 -.74758549E-01 -.69542302E-01 + -.64532148E-01 -.59737801E-01 -.55165888E-01 -.50820352E-01 -.46702805E-01 + -.42812854E-01 -.39148390E-01 -.35705858E-01 -.32480486E-01 -.29466501E-01 + -.26657315E-01 -.24045694E-01 -.21623904E-01 -.19383841E-01 -.17317148E-01 + -.15415313E-01 -.13669756E-01 -.12071903E-01 -.10613252E-01 -.92854249E-02 + -.80802150E-02 -.69896243E-02 -.60058943E-02 -.51215314E-02 -.43293260E-02 + -.36223673E-02 -.29940535E-02 -.24380983E-02 -.19485349E-02 -.15197159E-02 + -.11463120E-02 -.82330764E-03 -.54599586E-03 -.30997081E-03 -.11111957E-03 + .54387194E-04 .19010535E-03 .29932800E-03 .38509665E-03 .45021268E-03 + .49724900E-03 .52856177E-03 .54630216E-03 .55242795E-03 .54871497E-03 + .53676839E-03 .51803365E-03 .49380712E-03 .46524642E-03 .43338037E-03 + .39911853E-03 .36326031E-03 .32650377E-03 .28945387E-03 .25263036E-03 + .21647525E-03 .18135985E-03 .14759141E-03 .11541928E-03 .85040816E-04 + .56606764E-04 .30226352E-04 .59719919E-05 -.16116354E-04 -.36027141E-04 + -.53773520E-04 -.69389928E-04 -.82928949E-04 -.94458459E-04 -.10405902E-03 + -.11182151E-03 -.11784499E-03 -.12223478E-03 -.12510073E-03 -.12655567E-03 + -.12671407E-03 -.12569076E-03 -.12359997E-03 -.12055430E-03 -.11666399E-03 + -.11203621E-03 -.10677448E-03 -.10097820E-03 -.94742231E-04 -.88156609E-04 + -.81306283E-04 -.74270942E-04 -.67124899E-04 -.59937023E-04 -.52770714E-04 + -.45683928E-04 -.38729233E-04 -.31953896E-04 -.25400000E-04 -.19104585E-04 + -.13099806E-04 -.74131135E-05 -.20674438E-05 .29185776E-05 .75304221E-05 + .11757438E-04 .15592625E-04 .19032404E-04 .22076388E-04 .24727147E-04 + .26989979E-04 .28872677E-04 .30385308E-04 .31539981E-04 .32350635E-04 + .32832821E-04 .33003493E-04 .32880805E-04 .32483918E-04 .31832808E-04 + .30948085E-04 .29850818E-04 .28562372E-04 .27104248E-04 .25497933E-04 + .23764761E-04 .21925781E-04 .20001631E-04 .18012428E-04 .15977661E-04 + .13916095E-04 .11845684E-04 .97834913E-05 .77456253E-05 .57471751E-05 + .38021614E-05 .19234941E-05 .12293798E-06 -.15889121E-05 -.32026485E-05 + -.47100596E-05 -.61041317E-05 -.73790420E-05 -.85301460E-05 -.95539569E-05 + -.10448119E-04 -.11211374E-04 -.11843524E-04 -.12345387E-04 -.12718747E-04 + -.12966301E-04 -.13091602E-04 -.13099000E-04 -.12993572E-04 -.12781064E-04 + -.12467816E-04 -.12060693E-04 -.11567014E-04 -.10994484E-04 -.10351114E-04 + -.96451558E-05 -.88850290E-05 -.80792508E-05 -.72363684E-05 -.63648931E-05 + -.54732369E-05 -.45696518E-05 -.36621723E-05 -.27585615E-05 -.18662606E-05 + -.99234299E-06 -.14347216E-06 .67413606E-06 .14547465E-05 .21931331E-05 + .28846026E-05 .35250133E-05 .41107897E-05 .46389311E-05 .51070171E-05 + .55132071E-05 .58562363E-05 .61354066E-05 .63505743E-05 .65021328E-05 + .65909923E-05 .66185560E-05 .65866927E-05 .64977074E-05 .63543081E-05 + .61595714E-05 .59169057E-05 .56300130E-05 .53028493E-05 .49395841E-05 + .45445596E-05 .41222492E-05 .36772171E-05 .32140765E-05 .27374510E-05 + .22519347E-05 .17620554E-05 .12722380E-05 .78677129E-06 .30977508E-06 + -.15482897E-06 -.60334483E-06 -.10323267E-05 -.14386008E-05 -.18192846E-05 + -.21718029E-05 -.24939006E-05 -.27836530E-05 -.30394730E-05 -.32601147E-05 + -.34446746E-05 -.35925898E-05 -.37036332E-05 -.37779061E-05 -.38158282E-05 + -.38181253E-05 -.37858143E-05 -.37201867E-05 -.36227899E-05 -.34954069E-05 + -.33400340E-05 -.31588583E-05 -.29542334E-05 -.27286543E-05 -.24847319E-05 + -.22251674E-05 -.19527264E-05 -.16702126E-05 -.13804427E-05 -.10862214E-05 + -.79031713E-06 -.49543860E-06 -.20421280E-06 .80835994E-07 .35730573E-06 + .62293455E-06 .87561703E-06 .11134188E-05 .13345890E-05 .15375714E-05 + .17210128E-05 .18837700E-05 .20249147E-05 .21437361E-05 .22397418E-05 + .23126566E-05 .23624198E-05 .23891799E-05 .23932885E-05 .23752919E-05 + .23359216E-05 .22760829E-05 .21968428E-05 .20994165E-05 .19851530E-05 + .18555195E-05 .17120855E-05 .15565066E-05 .13905072E-05 .12158635E-05 + .10343865E-05 .84790465E-06 .65824737E-06 .46722828E-06 .27662940E-06 + .88185931E-07 -.96428306E-07 -.27561447E-06 -.44786132E-06 -.61175681E-06 + -.76599844E-06 -.90940250E-06 -.10409120E-05 -.11596031E-05 -.12646906E-05 + -.13555318E-05 -.14316288E-05 -.14926300E-05 -.15383297E-05 -.15686666E-05 + -.15837213E-05 -.15837121E-05 -.15689899E-05 -.15400323E-05 -.14974360E-05 + -.14419091E-05 -.13742618E-05 -.12953968E-05 -.12062995E-05 -.11080263E-05 + -.10016944E-05 -.88846949E-06 -.76955446E-06 -.64617751E-06 -.51958041E-06 + -.39100686E-06 -.26169110E-06 -.13284687E-06 -.56567587E-08 .11873791E-06 + .23924662E-06 .35483853E-06 .46455060E-06 .56749495E-06 .66286537E-06 + .74994293E-06 .82810073E-06 .89680762E-06 .95563110E-06 .10042391E-05 + .10424010E-05 .10699876E-05 .10869699E-05 .10934176E-05 .10894963E-05 + .10754638E-05 .10516660E-05 .10185318E-05 .97656733E-06 .92634993E-06 + .86852113E-06 .80377954E-06 .73287323E-06 .65659178E-06 .57575821E-06 + .49122066E-06 .40384412E-06 .31450207E-06 .22406824E-06 .13340862E-06 + .43373545E-07 -.45209782E-07 -.13154447E-06 -.21487070E-06 -.29447198E-06 + -.36968088E-06 -.43988425E-06 -.50452780E-06 -.56312000E-06 -.61523545E-06 + -.66051743E-06 -.69867990E-06 -.72950871E-06 -.75286218E-06 -.76867098E-06 + -.77693736E-06 -.77773372E-06 -.77120057E-06 -.75754389E-06 -.73703197E-06 + -.70999169E-06 -.67680437E-06 -.63790116E-06 -.59375810E-06 -.54489085E-06 + -.49184910E-06 -.43521085E-06 -.37557652E-06 -.31356289E-06 -.24979711E-06 + -.18491069E-06 -.11953347E-06 -.54287909E-07 .10216647E-07 .73389332E-07 + .13466292E-06 .19349867E-06 .24939075E-06 .30187039E-06 .35050951E-06 + .39492395E-06 .43477623E-06 .46977785E-06 .49969099E-06 .52432989E-06 + .54356153E-06 .55730595E-06 .56553599E-06 .56827660E-06 .56560363E-06 + .55764217E-06 .54456455E-06 .52658783E-06 .50397094E-06 .47701156E-06 + .44604260E-06 .41142848E-06 .37356115E-06 .33285592E-06 .28974721E-06 + .24468411E-06 .19812594E-06 .15053779E-06 .10238605E-06 .54134036E-07 + .62377485E-08 -.40858297E-07 -.86724999E-07 -.13095241E-06 -.17315324E-06 + -.21296604E-06 -.25005819E-06 -.28412845E-06 -.31490922E-06 -.34216852E-06 + -.36571146E-06 -.38538147E-06 -.40106106E-06 -.41267227E-06 -.42017671E-06 + -.42357521E-06 -.42290716E-06 -.41824948E-06 -.40971522E-06 -.39745192E-06 + -.38163962E-06 -.36248861E-06 -.34023695E-06 -.31514777E-06 -.28750638E-06 + -.25761720E-06 -.22580063E-06 -.19238970E-06 -.15772682E-06 -.12216035E-06 + -.86041260E-07 -.49719795E-07 -.13542196E-07 .22152473E-07 .57035389E-07 + .90790880E-07 .12311917E-06 .15373892E-06 .18238958E-06 .20883345E-06 + .23285758E-06 .25427531E-06 .27292764E-06 .28868422E-06 .30144412E-06 + .31113631E-06 .31771980E-06 .32118358E-06 .32154617E-06 .31885504E-06 + .31318563E-06 .30464021E-06 .29334649E-06 .27945601E-06 .26314228E-06 + .24459889E-06 .22403726E-06 .20168446E-06 .17778076E-06 .15257718E-06 + .12633296E-06 .99313001E-07 .71785264E-07 .44018215E-07 .16278288E-07 + -.11172588E-07 -.38079379E-07 -.64196236E-07 -.89288663E-07 -.11313554E-06 + -.13553101E-06 -.15628613E-06 -.17523044E-06 -.19221325E-06 -.20710472E-06 + -.21979681E-06 -.23020392E-06 -.23826335E-06 -.24393555E-06 -.24720411E-06 + -.24807556E-06 -.24657898E-06 -.24276534E-06 -.23670668E-06 -.22849515E-06 + -.21824179E-06 -.20607522E-06 -.19214012E-06 -.17659568E-06 -.15961382E-06 + -.14137741E-06 -.12207837E-06 -.10191572E-06 -.81093609E-07 -.59819294E-07 + -.38301156E-07 -.16746712E-07 .46393247E-08 .25656936E-07 .46112607E-07 + .65821059E-07 .84606867E-07 .10230597E-06 .11876703E-06 .13385271E-06 + .14744070E-06 .15942470E-06 .16971515E-06 .17823984E-06 .18494433E-06 + .18979218E-06 .19276508E-06 .19386268E-06 .19310238E-06 .19051891E-06 + .18616370E-06 .18010418E-06 .17242290E-06 .16321656E-06 .15259483E-06 + .14067917E-06 .12760150E-06 .11350279E-06 .98531640E-07 .82842700E-07 + .66595175E-07 .49951237E-07 .33074453E-07 .16128219E-07 -.72577625E-09 + -.17329056E-07 -.33527803E-07 -.49174248E-07 -.64127974E-07 -.78257139E-07 + -.91439597E-07 -.10356391E-06 -.11453026E-06 -.12425121E-06 -.13265235E-06 + -.13967283E-06 -.14526574E-06 -.14939835E-06 -.15205219E-06 -.15322310E-06 + -.15292097E-06 -.15116952E-06 -.14800585E-06 -.14347989E-06 -.13765379E-06 + -.13060111E-06 -.12240601E-06 -.11316226E-06 -.10297228E-06 -.91945972E-07 + -.80199652E-07 -.67854818E-07 -.55036943E-07 -.41874230E-07 -.28496367E-07 + -.15033277E-07 -.16138861E-08 .11635077E-07 .24590251E-07 .37132763E-07 + .49149288E-07 .60533043E-07 .71184711E-07 .81013270E-07 .89936746E-07 + .97882862E-07 .10478959E-06 .11060558E-06 .11529055E-06 .11881544E-06 + .12116261E-06 .12232579E-06 .12231003E-06 .12113146E-06 .11881704E-06 + .11540410E-06 .11093987E-06 .10548093E-06 .99092491E-07 .91847710E-07 + .83826869E-07 .75116526E-07 .65808610E-07 .55999479E-07 .45788955E-07 + .35279324E-07 .24574344E-07 .13778238E-07 .29947066E-08 -.76740497E-08 + -.18128276E-07 -.28271574E-07 -.38011770E-07 -.47261731E-07 -.55940124E-07 + -.63972103E-07 -.71289941E-07 -.77833567E-07 -.83551041E-07 -.88398935E-07 + -.92342635E-07 -.95356547E-07 -.97424227E-07 -.98538416E-07 -.98700985E-07 + -.97922800E-07 -.96223506E-07 -.93631217E-07 -.90182152E-07 -.85920176E-07 + -.80896292E-07 -.75168063E-07 -.68798986E-07 -.61857809E-07 -.54417817E-07 + -.46556076E-07 -.38352659E-07 -.29889847E-07 -.21251322E-07 -.12521359E-07 + -.37840174E-08 .48776497E-08 .13382368E-07 .21651391E-07 .29609210E-07 + .37184230E-07 .44309397E-07 .50922773E-07 .56968061E-07 .62395062E-07 + .67160077E-07 .71226235E-07 .74563758E-07 .77150151E-07 .78970324E-07 + .80016644E-07 .80288910E-07 .79794261E-07 .78547019E-07 .76568461E-07 + .73886532E-07 .70535495E-07 .66555530E-07 .61992277E-07 .56896336E-07 + .51322727E-07 .45330316E-07 .38981204E-07 .32340106E-07 .25473698E-07 + .18449969E-07 .11337555E-07 .42050839E-08 -.28794736E-08 -.98494415E-08 + -.16640052E-07 -.23189038E-07 -.29437186E-07 -.35328866E-07 -.40812512E-07 + -.45841055E-07 -.50372323E-07 -.54369371E-07 -.57800775E-07 -.60640853E-07 + -.62869847E-07 -.64474033E-07 -.65445776E-07 -.65783533E-07 -.65491787E-07 + -.64580939E-07 -.63067132E-07 -.60972029E-07 -.58322543E-07 -.55150519E-07 + -.51492371E-07 -.47388682E-07 -.42883771E-07 -.38025227E-07 -.32863421E-07 + -.27450993E-07 -.21842328E-07 -.16093019E-07 -.10259328E-07 -.43976434E-08 + .14360549E-08 .71867203E-08 .12800750E-07 .18226475E-07 .23414627E-07 + .28318775E-07 .32895734E-07 .37105930E-07 .40913739E-07 .44287771E-07 + .47201122E-07 .49631572E-07 .51561743E-07 .52979202E-07 .53876527E-07 + .54251311E-07 .54106131E-07 .53448462E-07 .52290552E-07 .50649243E-07 + .48545767E-07 .46005485E-07 .43057604E-07 .39734853E-07 .36073132E-07 + .32111137E-07 .27889957E-07 .23452663E-07 .18843870E-07 .14109304E-07 + .92953505E-08 .44486096E-08 -.38454644E-09 -.51584109E-08 -.98283672E-08 + -.14351299E-07 -.18685979E-07 -.22793441E-07 -.26637321E-07 -.30184169E-07 + -.33403735E-07 -.36269219E-07 -.38757483E-07 -.40849228E-07 -.42529135E-07 + -.43785962E-07 -.44612604E-07 -.45006116E-07 -.44967688E-07 -.44502592E-07 + -.43620082E-07 -.42333262E-07 -.40658921E-07 -.38617326E-07 -.36231996E-07 + -.33529441E-07 -.30538878E-07 -.27291922E-07 -.23822258E-07 -.20165306E-07 + -.16357859E-07 -.12437720E-07 -.84433384E-08 -.44134316E-08 -.38662064E-09 + .35989364E-08 .75059000E-08 .11298093E-07 .14940832E-07 .18401234E-07 + .21648514E-07 .24654246E-07 .27392612E-07 .29840613E-07 .31978257E-07 + .33788713E-07 .35258437E-07 .36377263E-07 .37138462E-07 .37538764E-07 + .37578356E-07 .37260840E-07 .36593157E-07 .35585490E-07 .34251130E-07 + .32606315E-07 .30670044E-07 .28463867E-07 .26011653E-07 .23339341E-07 + .20474668E-07 .17446888E-07 .14286482E-07 .11024851E-07 .76940136E-08 + .43262926E-08 .95400876E-09 -.23908262E-08 -.56768089E-08 -.88734341E-08 + -.11951374E-07 -.14882742E-07 -.17641344E-07 -.20202900E-07 -.22545264E-07 + -.24648601E-07 -.26495553E-07 -.28071378E-07 -.29364057E-07 -.30364384E-07 + -.31066017E-07 -.31465510E-07 -.31562315E-07 -.31358754E-07 -.30859967E-07 + -.30073833E-07 -.29010868E-07 -.27684093E-07 -.26108889E-07 -.24302823E-07 + -.22285459E-07 -.20078151E-07 -.17703825E-07 -.15186743E-07 -.12552259E-07 + -.98265679E-08 -.70364516E-08 -.42090155E-08 -.13714314E-08 .14493211E-08 + .42267068E-08 .69348812E-08 .95489280E-08 .12045084E-07 .14400953E-07 + .16595700E-07 .18610236E-07 .20427375E-07 .22031979E-07 .23411080E-07 + .24553978E-07 .25452321E-07 .26100155E-07 .26493958E-07 .26632648E-07 + .26517566E-07 .26152438E-07 .25543316E-07 .24698497E-07 .23628420E-07 + .22345546E-07 .20864215E-07 .19200499E-07 .17372025E-07 .15397796E-07 + .13297997E-07 .11093789E-07 .88071036E-08 .64604261E-08 .40765756E-08 + .16784879E-08 -.71100283E-09 -.30693782E-08 -.53746454E-08 -.76055391E-08 + -.97417153E-08 -.11763934E-07 -.13654229E-07 -.15396065E-07 -.16974480E-07 + -.18376205E-07 -.19589781E-07 -.20605640E-07 -.21416183E-07 -.22015826E-07 + -.22401035E-07 -.22570340E-07 -.22524323E-07 -.22265595E-07 -.21798749E-07 + -.21130301E-07 -.20268601E-07 -.19223743E-07 -.18007448E-07 -.16632937E-07 + -.15114794E-07 -.13468809E-07 -.11711822E-07 -.98615529E-08 -.79364227E-08 + -.59553751E-08 -.39376911E-08 -.19028042E-08 .12988462E-09 .21411892E-08 + .41123172E-08 .60250428E-08 .78618736E-08 .96062079E-08 .11242483E-07 + .12756310E-07 .14134601E-07 .15365675E-07 .16439358E-07 .17347061E-07 + .18081847E-07 .18638478E-07 .19013451E-07 .19205011E-07 .19213151E-07 + .19039596E-07 .18687766E-07 .18162730E-07 .17471142E-07 .16621162E-07 + .15622363E-07 .14485631E-07 .13223043E-07 .11847748E-07 .10373827E-07 + .88161544E-08 .71902497E-08 .55121243E-08 .37981263E-08 .20647829E-08 + .32864295E-09 -.13938797E-08 -.30866595E-08 -.47340081E-08 -.63208176E-08 + -.78326971E-08 -.92561016E-08 -.10578451E-07 -.11788240E-07 -.12875136E-07 + -.13830065E-07 -.14645284E-07 -.15314441E-07 -.15832624E-07 -.16196389E-07 + -.16403779E-07 -.16454334E-07 -.16349071E-07 -.16090471E-07 -.15682433E-07 + -.15130227E-07 -.14440433E-07 -.13620859E-07 -.12680467E-07 -.11629267E-07 + 19.8421228800786942 T + Non local Part + 0 2 1.55770284366884382 + 8.48191151414740752 -0.636078516188222226E-01 -0.636078516188222226E-01 0.376965742998787998E-02 + Reciprocal Space Part + .87079657E+01 .86905268E+01 .86383852E+01 .85520639E+01 .84324261E+01 + .82806628E+01 .80982759E+01 .78870568E+01 .76490608E+01 .73865785E+01 + .71021037E+01 .67982989E+01 .64779593E+01 .61439752E+01 .57992933E+01 + .54468791E+01 .50896789E+01 .47305835E+01 .43723936E+01 .40177873E+01 + .36692907E+01 .33292513E+01 .29998152E+01 .26829081E+01 .23802200E+01 + .20931942E+01 .18230205E+01 .15706325E+01 .13367087E+01 .11216776E+01 + .92572621E+00 .74881221E+00 .59067848E+00 .45087066E+00 .32875652E+00 + .22354716E+00 .13431939E+00 .60038835E-01 -.41655140E-03 -.48233192E-01 + -.84639053E-01 -.11088174E+00 -.12820783E+00 -.13784377E+00 -.14097860E+00 + -.13874855E+00 -.13222400E+00 -.12239850E+00 -.11018019E+00 -.96385516E-01 + -.81735140E-01 -.66852083E-01 -.52261834E-01 -.38394355E-01 -.25587745E-01 + -.14093369E-01 -.40822094E-02 .43477954E-02 .11163663E-01 .16388781E-01 + .20094049E-01 .22388976E-01 .23412932E-01 .23326746E-01 .22304805E-01 + .20527794E-01 .18176188E-01 .15424571E-01 .12436845E-01 .93623490E-02 + .63329000E-02 .34607215E-02 .83723118E-03 -.14673812E-02 -.34038583E-02 + -.49429505E-02 -.60739569E-02 -.68028370E-02 -.71499932E-02 -.71478312E-02 + -.68381952E-02 -.62697733E-02 -.54955578E-02 -.45704368E-02 -.35489799E-02 + -.24834728E-02 -.14222372E-02 -.40826592E-03 .52181480E-03 .13384515E-02 + .20195476E-02 .25505425E-02 .29242131E-02 .31402290E-02 .32045017E-02 + .31283679E-02 .29276511E-02 .26216452E-02 .22320639E-02 .17819939E-02 + Real Space Part + .10679849E+02 .10674516E+02 .10658521E+02 .10631882E+02 .10594629E+02 + .10546798E+02 .10488435E+02 .10419590E+02 .10340316E+02 .10250666E+02 + .10150691E+02 .10040442E+02 .99199643E+01 .97892993E+01 .96484877E+01 + .94975699E+01 .93365905E+01 .91656025E+01 .89846735E+01 .87938923E+01 + .85933769E+01 .83832826E+01 .81638104E+01 .79352160E+01 .76978177E+01 + .74520045E+01 .71982421E+01 .69370789E+01 .66691491E+01 .63951751E+01 + .61159665E+01 .58324186E+01 .55455066E+01 .52562794E+01 .49658496E+01 + .46753825E+01 .43860825E+01 .40991787E+01 .38159080E+01 .35374987E+01 + .32651527E+01 .30000279E+01 .27432213E+01 .24957525E+01 .22585487E+01 + .20324314E+01 .18181051E+01 .16161478E+01 .14270049E+01 .12509847E+01 + .10882570E+01 .93885502E+00 .80267855E+00 .67950082E+00 .56897697E+00 + .47065459E+00 .38398603E+00 .30834185E+00 .24302540E+00 .18728774E+00 + .14034296E+00 .10138309E+00 .69592617E-01 .44162070E-01 .24300516E-01 + .92466753E-02 -.17214853E-02 -.92788061E-02 -.14046714E-01 -.16588732E-01 + -.17407693E-01 -.16944568E-01 -.15578795E-01 -.13629958E-01 -.11360623E-01 + -.89801560E-02 -.66492956E-02 -.44852808E-02 -.25673264E-02 -.94224811E-03 + .36993817E-03 .13706046E-02 .20774200E-02 .25196886E-02 .27342003E-02 + .27616467E-02 .26436316E-02 .24202815E-02 .21284366E-02 .18003892E-02 + .14631174E-02 .11379537E-02 .84061912E-03 .58155029E-03 .36644718E-03 + .19697068E-03 .71525435E-04 -.13929925E-04 -.65094077E-04 -.88595362E-04 + Reciprocal Space Part + -.33459269E+02 -.32885812E+02 -.31175324E+02 -.28357261E+02 -.24480084E+02 + -.19610327E+02 -.13831310E+02 -.72415472E+01 .47142272E-01 .79117577E+01 + .16220445E+02 .24834975E+02 .33613317E+02 .42412261E+02 .51090027E+02 + .59508819E+02 .67537255E+02 .75052646E+02 .81943063E+02 .88109160E+02 + .93465720E+02 .97942900E+02 .10148714E+03 .10406175E+03 .10564715E+03 + .10624077E+03 .10585660E+03 .10452449E+03 .10228909E+03 .99208571E+02 + .95353099E+02 .90803154E+02 .85647663E+02 .79982052E+02 .73906232E+02 + .67522572E+02 .60933898E+02 .54241560E+02 .47543611E+02 .40933123E+02 + .34496680E+02 .28313063E+02 .22452162E+02 .16974111E+02 .11928669E+02 + .73548473E+01 .32807727E+01 -.27621319E+00 -.33092347E+01 -.58213610E+01 + -.78249039E+01 -.93405595E+01 -.10396421E+02 -.11026891E+02 -.11271526E+02 + -.11173833E+02 -.10780072E+02 -.10138054E+02 -.92960043E+01 -.83014828E+01 + -.72003946E+01 -.60361114E+01 -.48487123E+01 -.36743572E+01 -.25447982E+01 + -.14870336E+01 -.52310141E+00 .32999049E+00 .10602053E+01 .16603003E+01 + .21275436E+01 .24633402E+01 .26727834E+01 .27641476E+01 .27483410E+01 + .26383351E+01 .24485880E+01 .21944773E+01 .18917574E+01 .15560536E+01 + .12024051E+01 .84486462E+00 .49616263E+00 .16743966E+00 -.13195032E+00 + -.39456569E+00 -.61493394E+00 -.78954326E+00 -.91677435E+00 -.99677914E+00 + -.10313144E+01 -.10235387E+01 -.97778206E+00 -.89929746E+00 -.79400304E+00 + -.66822444E+00 -.52844495E+00 -.38107084E+00 -.23221848E+00 -.87528095E-01 + Real Space Part + .47043595E+03 .47061811E+03 .47114518E+03 .47195957E+03 .47296738E+03 + .47404142E+03 .47502541E+03 .47573899E+03 .47598368E+03 .47554935E+03 + .47422109E+03 .47178640E+03 .46804221E+03 .46280172E+03 .45590085E+03 + .44720395E+03 .43660875E+03 .42405037E+03 .40950423E+03 .39298784E+03 + .37456135E+03 .35432699E+03 .33242725E+03 .30904200E+03 .28438464E+03 + .25869730E+03 .23224536E+03 .20531141E+03 .17818879E+03 .15117498E+03 + .12456500E+03 .98644898E+02 .73685748E+02 .49938027E+02 .27626718E+02 + .69471588E+01 -.11938243E+02 -.28902388E+02 -.43854906E+02 -.56742633E+02 + -.67549163E+02 -.76293525E+02 -.83028062E+02 -.87835614E+02 -.90826098E+02 + -.92132623E+02 -.91907271E+02 -.90316654E+02 -.87537414E+02 -.83751758E+02 + -.79143172E+02 -.73892400E+02 -.68173791E+02 -.62152082E+02 -.55979677E+02 + -.49794451E+02 -.43718116E+02 -.37855127E+02 -.32292132E+02 -.27097928E+02 + -.22323878E+02 -.18004740E+02 -.14159842E+02 -.10794541E+02 -.79018948E+01 + -.54644709E+01 -.34562340E+01 -.18444414E+01 -.59149265E+00 .34331959E+00 + .10021984E+01 .14274044E+01 .16600147E+01 .17388937E+01 .16998820E+01 + .15752010E+01 .13930648E+01 .11774834E+01 .94823819E+00 .72100557E+00 + .50760296E+00 .31633056E+00 .15238184E+00 .18296902E-01 -.85564833E-01 + -.16055420E+00 -.20928196E+00 -.23520343E+00 -.24224903E+00 -.23450846E+00 + -.21597247E+00 -.19033347E+00 -.16084311E+00 -.13022316E+00 -.10062372E+00 + -.73622006E-01 -.50254001E-01 -.31070866E-01 -.16212387E-01 -.54900275E-02 + Non local Part + 1 2 1.55770284366884382 + 2.65859659160385764 -0.504801881867953453E-01 -0.504801881867953453E-01 0.892956271679604986E-02 + Reciprocal Space Part + .00000000E+00 .55360975E+00 .11020032E+01 .16400357E+01 .21627048E+01 + .26652186E+01 .31430596E+01 .35920450E+01 .40083810E+01 .43887098E+01 + .47301505E+01 .50303314E+01 .52874138E+01 .55001078E+01 .56676786E+01 + .57899444E+01 .58672657E+01 .59005262E+01 .58911063E+01 .58408488E+01 + .57520191E+01 .56272596E+01 .54695387E+01 .52820975E+01 .50683934E+01 + .48320418E+01 .45767578E+01 .43062991E+01 .40244089E+01 .37347632E+01 + .34409202E+01 .31462743E+01 .28540152E+01 .25670915E+01 .22881811E+01 + .20196669E+01 .17636193E+01 .15217840E+01 .12955770E+01 .10860853E+01 + .89407229E+00 .71998985E+00 .56399389E+00 .42596477E+00 .30553088E+00 + .20209532E+00 .11486458E+00 .42878783E-01 -.14957234E-01 -.59842780E-01 + -.93050595E-01 -.11589722E+00 -.12971495E+00 -.13582584E+00 -.13551809E+00 + -.13002523E+00 -.12050824E+00 -.10804072E+00 -.93597327E-01 -.78045331E-01 + -.62139262E-01 -.46518532E-01 -.31707803E-01 -.18119864E-01 -.60607310E-02 + .42633380E-02 .12737265E-01 .19327344E-01 .24070560E-01 .27063374E-01 + .28450306E-01 .28412605E-01 .27157313E-01 .24906934E-01 .21889935E-01 + .18332245E-01 .14449871E-01 .10442718E-01 .64896733E-02 .27449375E-02 + -.66440255E-03 -.36396321E-02 -.61105795E-02 -.80348118E-02 -.93959825E-02 + -.10201473E-01 -.10479476E-01 -.10275671E-01 -.96496464E-02 -.86712031E-02 + -.74166865E-02 -.59654538E-02 -.43965915E-02 -.27859668E-02 -.12036827E-02 + .28801366E-03 .16363396E-02 .27990903E-02 .37452630E-02 .44552150E-02 + Real Space Part + .00000000E+00 .64359942E+00 .12860893E+01 .19263130E+01 .25630221E+01 + .31948350E+01 .38202017E+01 .44373750E+01 .50443910E+01 .56390587E+01 + .62189597E+01 .67814592E+01 .73237268E+01 .78427678E+01 .83354645E+01 + .87986250E+01 .92290406E+01 .96235469E+01 .99790905E+01 .10292796E+02 + .10562036E+02 .10784491E+02 .10958218E+02 .11081699E+02 .11153897E+02 + .11174283E+02 .11142876E+02 .11060254E+02 .10927558E+02 .10746490E+02 + .10519290E+02 .10248709E+02 .99379673E+01 .95907014E+01 .92109083E+01 + .88028781E+01 .83711229E+01 .79203026E+01 .74551481E+01 .69803858E+01 + .65006629E+01 .60204776E+01 .55441132E+01 .50755794E+01 .46185613E+01 + .41763765E+01 .37519415E+01 .33477477E+01 .29658468E+01 .26078460E+01 + .22749116E+01 .19677819E+01 .16867871E+01 .14318761E+01 .12026495E+01 + .99839626E+00 .81813432E+00 .66065330E+00 .52455802E+00 .40831211E+00 + .31028032E+00 .22876897E+00 .16206345E+00 .10846228E+00 .66307278E-01 + .34009364E-01 .10069850E-01 -.69027801E-02 -.18180606E-01 -.24908286E-01 + -.28099078E-01 -.28634490E-01 -.27267117E-01 -.24626205E-01 -.21225416E-01 + -.17472311E-01 -.13679034E-01 -.10073742E-01 -.68123372E-02 -.39901212E-02 + -.16530358E-02 .19178102E-03 .15663369E-02 .25131785E-02 .30879320E-02 + .33530317E-02 .33726336E-02 .32086679E-02 .29179506E-02 .25502513E-02 + .21471944E-02 .17418610E-02 .13589554E-02 .10154019E-02 .72124547E-03 + .48074009E-03 .29352474E-03 .15580136E-03 .61447592E-04 .30138377E-05 + Reciprocal Space Part + .00000000E+00 -.26932227E+01 -.52971472E+01 -.77244363E+01 -.98916316E+01 + -.11720983E+02 -.13142152E+02 -.14093748E+02 -.14524661E+02 -.14395175E+02 + -.13677819E+02 -.12357950E+02 -.10434056E+02 -.79177661E+01 -.48335806E+01 + -.12183197E+01 .28796906E+01 .74016747E+01 .12279682E+02 .17438045E+02 + .22794994E+02 .28264383E+02 .33757491E+02 .39184855E+02 .44458102E+02 + .49491724E+02 .54204777E+02 .58522445E+02 .62377462E+02 .65711339E+02 + .68475389E+02 .70631527E+02 .72152827E+02 .73023834E+02 .73240630E+02 + .72810652E+02 .71752282E+02 .70094218E+02 .67874635E+02 .65140188E+02 + .61944855E+02 .58348663E+02 .54416332E+02 .50215862E+02 .45817101E+02 + .41290320E+02 .36704841E+02 .32127729E+02 .27622587E+02 .23248472E+02 + .19058953E+02 .15101330E+02 .11416015E+02 .80360965E+01 .49870782E+01 + .22867940E+01 -.54504994E-01 -.20339040E+01 -.36554301E+01 -.49295269E+01 + -.58724172E+01 -.65053728E+01 -.68539157E+01 -.69469702E+01 -.68159914E+01 + -.64940905E+01 -.60151778E+01 -.54131449E+01 -.47211011E+01 -.39706812E+01 + -.31914370E+01 -.24103219E+01 -.16512754E+01 -.93491359E+00 -.27832313E+00 + .30503924E+00 .80534852E+00 .12163201E+01 .15350341E+01 .17616860E+01 + .18992752E+01 .19532440E+01 .19310803E+01 .18418981E+01 .16960073E+01 + .15044873E+01 .12787746E+01 .10302757E+01 .77001425E+00 .50831954E+00 + .25456290E+00 .16945576E-01 -.19765940E+00 -.38381089E+00 -.53754978E+00 + -.65639825E+00 -.73931205E+00 -.78659086E+00 -.79975259E+00 -.78137851E+00 + Real Space Part + .00000000E+00 .32174412E+02 .64081200E+02 .95454901E+02 .12603438E+03 + .15556504E+03 .18380101E+03 .21050740E+03 .23546257E+03 .25846040E+03 + .27931254E+03 .29785062E+03 .31392841E+03 .32742382E+03 .33824076E+03 + .34631080E+03 .35159451E+03 .35408254E+03 .35379625E+03 .35078802E+03 + .34514103E+03 .33696853E+03 .32641275E+03 .31364309E+03 .29885400E+03 + .28226227E+03 .26410388E+03 .24463049E+03 .22410561E+03 .20280043E+03 + .18098955E+03 .15894661E+03 .13693992E+03 .11522816E+03 .94056367E+02 + .73652166E+02 .54222369E+02 .35950069E+02 .18992243E+02 .34779240E+01 + -.10493014E+02 -.22850445E+02 -.33553946E+02 -.42592145E+02 -.49981475E+02 + -.55764394E+02 -.60007127E+02 -.62796996E+02 -.64239417E+02 -.64454665E+02 + -.63574472E+02 -.61738574E+02 -.59091275E+02 -.55778129E+02 -.51942809E+02 + -.47724232E+02 -.43254004E+02 -.38654223E+02 -.34035686E+02 -.29496509E+02 + -.25121167E+02 -.20979967E+02 -.17128906E+02 -.13609921E+02 -.10451462E+02 + -.76693710E+01 -.52679941E+01 -.32414933E+01 -.15752887E+01 -.24758462E+00 + .76907715E+00 .15062828E+01 .19982770E+01 .22805946E+01 .23888267E+01 + .23575419E+01 .22193827E+01 .20043426E+01 .17392288E+01 .14473034E+01 + .11480951E+01 .85736431E+00 .58720519E+00 .34626103E+00 .14003133E+00 + -.28753785E-01 -.15971487E+00 -.25438251E+00 -.31575466E+00 -.34786993E+00 + -.35541133E+00 -.34335220E+00 -.31665261E+00 -.28001124E+00 -.23767485E+00 + -.19330460E+00 -.14989599E+00 -.10974754E+00 -.74471444E-01 -.45038872E-01 + PAW radial sets + 323 0.989218471734281124 +(5E20.12) + augmentation charges (non sperical) + -.118612867153E+00 -.756362247412E-03 -.532145531503E-01 -.130926919871E-02 -.756362247412E-03 + -.210856503823E-04 -.122603249007E-03 .363423839020E-05 -.532145531503E-01 -.122603249007E-03 + -.179689875812E-01 -.555432069872E-03 -.130926919871E-02 .363423839020E-05 -.555432069872E-03 + .498671741032E-04 + uccopancies in atom + .200000000162E+01 .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 + .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 + .666666667141E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 + .000000000000E+00 + grid + .353278105438E-04 .364765828105E-04 .376627102856E-04 .388874076671E-04 .401519291522E-04 + .414575697215E-04 .428056664648E-04 .441975999512E-04 .456347956421E-04 .471187253514E-04 + .486509087530E-04 .502329149365E-04 .518663640144E-04 .535529287814E-04 .552943364272E-04 + .570923703053E-04 .589488717596E-04 .608657420098E-04 .628449440985E-04 .648885049016E-04 + .669985172040E-04 .691771418426E-04 .714266099194E-04 .737492250864E-04 .761473659044E-04 + .786234882792E-04 .811801279764E-04 .838199032186E-04 .865455173661E-04 .893597616862E-04 + .922655182109E-04 .952657626888E-04 .983635676325E-04 .101562105465E-03 .104864651768E-03 + .108274588638E-03 .111795408149E-03 .115430715926E-03 .119184234844E-03 .123059808833E-03 + .127061406819E-03 .131193126789E-03 .135459199986E-03 .139863995240E-03 .144412023447E-03 + .149107942186E-03 .153956560487E-03 .158962843759E-03 .164131918874E-03 .169469079417E-03 + .174979791106E-03 .180669697392E-03 .186544625235E-03 .192610591076E-03 .198873806993E-03 + .205340687067E-03 .212017853948E-03 .218912145639E-03 .226030622496E-03 .233380574462E-03 + .240969528530E-03 .248805256452E-03 .256895782699E-03 .265249392676E-03 .273874641209E-03 + .282780361308E-03 .291975673207E-03 .301469993709E-03 .311273045829E-03 .321394868748E-03 + .331845828098E-03 .342636626573E-03 .353778314896E-03 .365282303127E-03 .377160372357E-03 + .389424686766E-03 .402087806084E-03 .415162698451E-03 .428662753701E-03 .442601797068E-03 + .456994103352E-03 .471854411533E-03 .487197939863E-03 .503040401457E-03 .519398020380E-03 + .536287548263E-03 .553726281459E-03 .571732078754E-03 .590323379658E-03 .609519223288E-03 + .629339267864E-03 .649803810846E-03 .670933809712E-03 .692750903429E-03 .715277434606E-03 + .738536472381E-03 .762551836040E-03 .787348119413E-03 .812950716063E-03 .839385845286E-03 + .866680578963E-03 .894862869287E-03 .923961577387E-03 .954006502881E-03 .985028414399E-03 + .101705908109E-02 .105013130516E-02 .108427895544E-02 .111953700213E-02 .115594155253E-02 + .119352988810E-02 .123234050257E-02 .127241314140E-02 .131378884247E-02 .135650997813E-02 + .140062029854E-02 .144616497653E-02 .149319065382E-02 .154174548883E-02 .159187920594E-02 + .164364314647E-02 .169709032120E-02 .175227546473E-02 .180925509145E-02 .186808755348E-02 + .192883310041E-02 .199155394099E-02 .205631430683E-02 .212318051821E-02 .219222105197E-02 + .226350661166E-02 .233711019991E-02 .241310719324E-02 .249157541920E-02 .257259523611E-02 + .265624961535E-02 .274262422631E-02 .283180752413E-02 .292389084032E-02 .301896847624E-02 + .311713779968E-02 .321849934462E-02 .332315691413E-02 .343121768671E-02 .354279232604E-02 + .365799509430E-02 .377694396919E-02 .389976076474E-02 .402657125610E-02 .415750530828E-02 + .429269700920E-02 .443228480697E-02 .457641165169E-02 .472522514185E-02 .487887767547E-02 + .503752660617E-02 .520133440431E-02 .537046882339E-02 .554510307185E-02 .572541599040E-02 + .591159223525E-02 .610382246712E-02 .630230354657E-02 .650723873558E-02 .671883790569E-02 + .693731775293E-02 .716290201977E-02 .739582172419E-02 .763631539635E-02 .788462932276E-02 + .814101779859E-02 .840574338805E-02 .867907719326E-02 .896129913194E-02 .925269822400E-02 + .955357288758E-02 .986423124464E-02 .101849914365E-01 .105161819495E-01 .108581419519E-01 + .112112216404E-01 .115757825996E-01 .119521981717E-01 .123408538391E-01 .127421476193E-01 + .131564904721E-01 .135843067208E-01 .140260344867E-01 .144821261375E-01 .149530487510E-01 + .154392845931E-01 .159413316118E-01 .164597039470E-01 .169949324574E-01 .175475652638E-01 + .181181683104E-01 .187073259445E-01 .193156415151E-01 .199437379906E-01 .205922585965E-01 + .212618674747E-01 .219532503631E-01 .226671152982E-01 .234041933402E-01 .241652393213E-01 + .249510326191E-01 .257623779547E-01 .266001062165E-01 .274650753115E-01 .283581710436E-01 + .292803080210E-01 .302324305924E-01 .312155138146E-01 .322305644506E-01 .332786220011E-01 + .343607597686E-01 .354780859567E-01 .366317448050E-01 .378229177610E-01 .390528246900E-01 + .403227251240E-01 .416339195521E-01 .429877507520E-01 .443856051652E-01 .458289143166E-01 + .473191562810E-01 .488578571964E-01 .504465928270E-01 .520869901769E-01 .537807291563E-01 + .555295443019E-01 .573352265534E-01 .591996250870E-01 .611246492098E-01 .631122703148E-01 + .651645238996E-01 .672835116512E-01 .694714035982E-01 .717304403333E-01 .740629353074E-01 + .764712771991E-01 .789579323611E-01 .815254473456E-01 .841764515121E-01 .869136597208E-01 + .897398751118E-01 .926579919768E-01 .956709987225E-01 .987819809310E-01 .101994124520E+00 + .105310719005E+00 .108735160869E+00 .112270957040E+00 .115921728481E+00 .119691213902E+00 + .123583273585E+00 .127601893339E+00 .131751188583E+00 .136035408556E+00 .140458940676E+00 + .145026315024E+00 .149742208992E+00 .154611452068E+00 .159639030781E+00 .164830093811E+00 + .170189957261E+00 .175724110099E+00 .181438219781E+00 .187338138056E+00 .193429906954E+00 + .199719764979E+00 .206214153496E+00 .212919723327E+00 .219843341560E+00 .226992098585E+00 + .234373315355E+00 .241994550880E+00 .249863609972E+00 .257988551235E+00 .266377695319E+00 + .275039633439E+00 .283983236179E+00 .293217662568E+00 .302752369466E+00 .312597121246E+00 + .322761999795E+00 .333257414835E+00 .344094114590E+00 .355283196787E+00 .366836120023E+00 + .378764715502E+00 .391081199148E+00 .403798184116E+00 .416928693710E+00 .430486174720E+00 + .444484511190E+00 .458938038641E+00 .473861558747E+00 .489270354497E+00 .505180205845E+00 + .521607405869E+00 .538568777456E+00 .556081690535E+00 .574164079857E+00 .592834463369E+00 + .612111961177E+00 .632016315122E+00 .652567909002E+00 .673787789445E+00 .695697687463E+00 + .718320040705E+00 .741678016440E+00 .765795535274E+00 .790697295655E+00 .816408799161E+00 + .842956376619E+00 .870367215068E+00 .898669385601E+00 .927891872115E+00 .958064600989E+00 + .989218471734E+00 .102138538864E+01 .105459829343E+01 + aepotential + .249296618412E+05 .247076583257E+05 .244443255599E+05 .241414371172E+05 .238011681064E+05 + .234259054160E+05 .230182276498E+05 .225808680933E+05 .221166790321E+05 .216285959644E+05 + .211196020425E+05 .205926935296E+05 .200508469868E+05 .194969885786E+05 .189339660140E+05 + .183645234482E+05 .177912796436E+05 .172167095020E+05 .166431291099E+05 .160726841798E+05 + .155073419145E+05 .149488860093E+05 .143989147023E+05 .138588415092E+05 .133298984061E+05 + .128131411287E+05 .123094562646E+05 .118195698156E+05 .113440569063E+05 .108833523432E+05 + .104377617399E+05 .100074729506E+05 .959256758265E+04 .919303239296E+04 .880877039590E+04 + .843961154725E+04 .808532289425E+04 .774561810756E+04 .742016634235E+04 .710860038888E+04 + .681052409519E+04 .652551907131E+04 .625315067621E+04 .599297332353E+04 .574453513086E+04 + .550738195528E+04 .528106086162E+04 .506512306412E+04 .485912638819E+04 .466263730249E+04 + .447523256840E+04 .429650053920E+04 .412604216570E+04 .396347173509E+04 .380841738005E+04 + .366052140119E+04 .351944041296E+04 .338484535875E+04 .325642140535E+04 .313386774487E+04 + .301689731751E+04 .290523647712E+04 .279862460324E+04 .269681368551E+04 .259956787532E+04 + .250666302499E+04 .241788621528E+04 .233303528113E+04 .225191833487E+04 .217435329790E+04 + .210016743837E+04 .202919692087E+04 .196128636819E+04 .189628843674E+04 .183406340726E+04 + .177447879164E+04 .171740895648E+04 .166273476188E+04 .161034321676E+04 .156012715054E+04 + .151198490272E+04 .146582002337E+04 .142154099431E+04 .137906095998E+04 .133829747604E+04 + .129917226882E+04 .126161100972E+04 .122554310047E+04 .119090147066E+04 .115762238690E+04 + .112564527212E+04 .109491253468E+04 .106536940758E+04 .103696379654E+04 .100964613669E+04 + .983369256582E+03 .958088251357E+03 .933760361363E+03 .910344858922E+03 .887802940737E+03 + .866097626532E+03 .845193663442E+03 .825057435693E+03 .805656879371E+03 .786961401872E+03 + .768941805860E+03 .751570217559E+03 .734820018832E+03 .718665782978E+03 .703083214326E+03 + .688049090980E+03 .673541210507E+03 .659538338921E+03 .646020162215E+03 .632967240499E+03 + .620360964749E+03 .608183515718E+03 .596417825223E+03 .585047539244E+03 .574056983177E+03 + .563431128839E+03 .553155563184E+03 .543216458754E+03 .533600545498E+03 .524295084194E+03 + .515287841173E+03 .506567064354E+03 .498121460542E+03 .489940173731E+03 .482012764716E+03 + .474329191586E+03 .466879791201E+03 .459655261667E+03 .452646645612E+03 .445845314309E+03 + .439242952579E+03 .432831544450E+03 .426603359477E+03 .420550939758E+03 .414667087568E+03 + .408944853585E+03 .403377525679E+03 .397958618253E+03 .392681862072E+03 .387541194587E+03 + .382530750726E+03 .377644854114E+03 .372878008707E+03 .368224890830E+03 .363680341587E+03 + .359239359657E+03 .354897094389E+03 .350648839276E+03 .346490025719E+03 .342416217091E+03 + .338423103118E+03 .334506494502E+03 .330662317854E+03 .326886610852E+03 .323175517677E+03 + .319525284662E+03 .315932256206E+03 .312392870893E+03 .308903657842E+03 .305461233272E+03 + .302062297267E+03 .298703630762E+03 .295382092719E+03 .292094617500E+03 .288838212437E+03 + .285609955593E+03 .282406993707E+03 .279226540330E+03 .276065874141E+03 .272922337452E+03 + .269793334886E+03 .266676332242E+03 .263568855544E+03 .260468490264E+03 .257372880728E+03 + .254279729706E+03 .251186798183E+03 .248091905310E+03 .244992928548E+03 .241887803987E+03 + .238774526866E+03 .235651152274E+03 .232515796051E+03 .229366635883E+03 .226201912602E+03 + .223019931688E+03 .219819064985E+03 .216597752635E+03 .213354505238E+03 .210087906247E+03 + .206796614606E+03 .203479367655E+03 .200134984304E+03 .196762368500E+03 .193360513013E+03 + .189928503567E+03 .186465523338E+03 .182970857876E+03 .179443900479E+03 .175884158076E+03 + .172291257693E+03 .168664953559E+03 .165005134953E+03 .161311834879E+03 .157585239680E+03 + .153825699735E+03 .150033741355E+03 .146210080040E+03 .142355635261E+03 .138471546918E+03 + .134559193631E+03 .130620212984E+03 .126656523815E+03 .122670350542E+03 .118664249404E+03 + .114641136335E+03 .110604315898E+03 .106557510391E+03 .102504887754E+03 .984510863142E+02 + .944012336261E+02 .903609557846E+02 .863363724670E+02 .823340718078E+02 .783610579892E+02 + .744246633582E+02 .705324162159E+02 .666918555610E+02 .629102856287E+02 .591944669183E+02 + .555502477826E+02 .519821532120E+02 .484929672536E+02 .450833747318E+02 .417517679306E+02 + .384943726247E+02 .353058986338E+02 .321809414460E+02 .291163276325E+02 .261144334538E+02 + .231871492547E+02 .203596538297E+02 .176726025177E+02 .151810751243E+02 .129490421749E+02 + .110393419236E+02 .950085943829E+01 .835601596774E+01 .759220035195E+01 .716026979128E+01 + .698171586735E+01 .696337537316E+01 .701521042419E+01 .706481632887E+01 .706399956522E+01 + .698712622280E+01 .682461424434E+01 .657568967629E+01 .624298209986E+01 .582958804938E+01 + .533805380599E+01 .477041519949E+01 .412860165824E+01 .341481131402E+01 .263171136544E+01 + .178246368857E+01 .870634878579E+00 -.999438728779E-01 -.112531868169E+01 -.220152969452E+01 + -.332469269108E+01 -.449104609659E+01 -.569696875391E+01 -.693897492955E+01 -.821369210611E+01 + -.951782536530E+01 -.108481102767E+02 -.122012545007E+02 -.135738669876E+02 -.149623728146E+02 + -.163629115444E+02 -.177712178383E+02 -.191824854283E+02 -.205912200739E+02 -.219910944781E+02 + -.233748284178E+02 -.247341312735E+02 -.260597521130E+02 -.273417019240E+02 -.285696929862E+02 + -.297338408481E+02 -.308256300402E+02 -.318391145291E+02 -.327722934381E+02 -.336286096960E+02 + -.344184453032E+02 -.351602594335E+02 -.358801411316E+02 -.366068307978E+02 -.373574862777E+02 + -.381118849160E+02 -.387867273418E+02 -.392441857634E+02 -.393634904186E+02 -.391349287009E+02 + -.386756216504E+02 -.381417407639E+02 -.376357898778E+02 -.371876084285E+02 -.367857308718E+02 + -.364089017521E+02 -.360404072746E+02 -.356705440643E+02 -.352947736909E+02 -.349113812250E+02 + -.345198086599E+02 -.341197549222E+02 -.337108274651E+02 + core charge-density + .566100405752E-04 .603274790726E-04 .642889041986E-04 .685103164325E-04 .730087642691E-04 + .778024127357E-04 .829106163764E-04 .883539969928E-04 .941545264508E-04 .100335614880E-03 + .106922204616E-03 .113940870262E-03 .121419925256E-03 .129389535376E-03 .137881839620E-03 + .146931078955E-03 .156573733420E-03 .166848668143E-03 .177797288839E-03 .189463707397E-03 + .201894918215E-03 .215140985966E-03 .229255245539E-03 .244294514933E-03 .260319321939E-03 + .277394145493E-03 .295587672651E-03 .314973072166E-03 .335628285763E-03 .357636338214E-03 + .381085667437E-03 .406070475885E-03 .432691104597E-03 .461054431344E-03 .491274294413E-03 + .523471943665E-03 .557776520581E-03 .594325569167E-03 .633265579655E-03 .674752567074E-03 + .718952686923E-03 .766042890258E-03 .816211620710E-03 .869659556058E-03 .926600397160E-03 + .987261707239E-03 .105188580466E-02 .112073071253E-02 .119407116880E-02 .127219970037E-02 + .135542776555E-02 .144408696885E-02 .153853035261E-02 .163913377046E-02 .174629734739E-02 + .186044703187E-02 .198203624583E-02 .211154763822E-02 .224949494879E-02 .239642498860E-02 + .255291974450E-02 .271959861504E-02 .289712078585E-02 .308618775280E-02 .328754600198E-02 + .350198985578E-02 .373036449505E-02 .397356916791E-02 .423256059621E-02 .450835659128E-02 + .480203989148E-02 .511476223442E-02 .544774867755E-02 .580230218169E-02 .617980847259E-02 + .658174119662E-02 .700966738736E-02 .746525326090E-02 .795027035842E-02 .846660205552E-02 + .901625045908E-02 .960134371288E-02 .102241437348E-01 .108870544090E-01 .115926302582E-01 + .123435856218E-01 .131428043661E-01 .139933501568E-01 .148984773211E-01 .158616423311E-01 + .168865159410E-01 .179769960102E-01 .191372210475E-01 .203715845116E-01 .216847499059E-01 + .230816667048E-01 .245675871519E-01 .261480839698E-01 .278290690246E-01 .296168129868E-01 + .315179660337E-01 .335395796374E-01 .356891294839E-01 .379745395704E-01 .404042075275E-01 + .429870312127E-01 .457324366235E-01 .486504071769E-01 .517515144015E-01 .550469500898E-01 + .585485599535E-01 .622688788272E-01 .662211674610E-01 .704194509412E-01 .748785587749E-01 + .796141666712E-01 .846428400460E-01 .899820792747E-01 .956503667062E-01 .101667215451E+00 + .108053219945E+00 .114830108271E+00 .122020796239E+00 .129649443177E+00 .137741509388E+00 + .146323815234E+00 .155424601742E+00 .165073592657E+00 .175302057823E+00 .186142877738E+00 + .197630609132E+00 .209801551371E+00 .222693813452E+00 .236347381338E+00 .250804185329E+00 + .266108167138E+00 .282305346272E+00 .299443885308E+00 .317574153560E+00 .336748788604E+00 + .357022755061E+00 .378453399961E+00 .401100503966E+00 .425026327615E+00 .450295651730E+00 + .476975810973E+00 .505136719518E+00 .534850887654E+00 .566193428081E+00 .599242050517E+00 + .634077043169E+00 .670781239474E+00 .709439968420E+00 .750140986642E+00 .792974390370E+00 + .838032505174E+00 .885409751349E+00 .935202482669E+00 .987508796104E+00 .104242831002E+01 + .110006190827E+01 .116051144745E+01 .122387942461E+01 .129026860260E+01 .135978159017E+01 + .143252037390E+01 .150858579919E+01 .158807699749E+01 .167109075688E+01 .175772083353E+01 + .184805720162E+01 .194218523933E+01 .204018484914E+01 .214212951079E+01 .224808526583E+01 + .235810963304E+01 .247225045485E+01 .259054467535E+01 .271301705146E+01 .283967879975E+01 + .297052618226E+01 .310553903613E+01 .324467925296E+01 .338788921520E+01 .353509019870E+01 + .368618075190E+01 .384103506433E+01 .399950133877E+01 .416140018359E+01 .432652304404E+01 + .449463069343E+01 .466545180749E+01 .483868164752E+01 .501398088047E+01 .519097456619E+01 + .536925134438E+01 .554836285615E+01 .572782343649E+01 .590711011606E+01 .608566297177E+01 + .626288586635E+01 .643814761788E+01 .661078363938E+01 .678009808823E+01 .694536656274E+01 + .710583938103E+01 .726074547323E+01 .740929691345E+01 .755069411170E+01 .768413167876E+01 + .780880496809E+01 .792391728912E+01 .802868777438E+01 .812235987040E+01 .820421040778E+01 + .827355919064E+01 .832977902881E+01 .837230611874E+01 .840065066096E+01 .841440758325E+01 + .841326722016E+01 .839702578152E+01 .836559542526E+01 .831901373419E+01 .825745238298E+01 + .818122477058E+01 .809079238605E+01 .798676967249E+01 .786992715557E+01 .774119261011E+01 + .760165005169E+01 .745253636003E+01 .729523536819E+01 .713126928576E+01 .696228736593E+01 + .679005177517E+01 .661642067944E+01 .644332862203E+01 .627276433335E+01 .610674618159E+01 + .594729554133E+01 .579640842184E+01 .565602576681E+01 .552800287068E+01 .541407839925E+01 + .531584353892E+01 .523471177953E+01 .517188984282E+01 .512835026211E+01 .510480613184E+01 + .510168858572E+01 .511912762968E+01 .515693703459E+01 .521460405617E+01 .529128475754E+01 + .538580562001E+01 .549667189770E+01 .562208280769E+01 .575995323743E+01 .590794134470E+01 + .606348131935E+01 .622382063669E+01 .638606123530E+01 .654720408632E+01 .670419655739E+01 + .685398184633E+01 .699354961718E+01 .711998685544E+01 .723052788809E+01 .732260249172E+01 + .739388103439E+01 .744231565540E+01 .746617657427E+01 .746408272963E+01 .743502607482E+01 + .737838899666E+01 .729395447390E+01 .718190874815E+01 .704283644131E+01 .687770821462E+01 + .668786122365E+01 .647497277612E+01 .624102774402E+01 .598828041327E+01 .571921157222E+01 + .543648174187E+01 .514288153425E+01 .484128019032E+01 .453457339482E+01 .422563149315E+01 + .391724924503E+01 .361209824281E+01 .331268309860E+01 .302130245731E+01 .274001582420E+01 + .247061708263E+01 .221461541805E+01 .197322413413E+01 .174735759662E+01 .153763606876E+01 + .134439807766E+01 .116771931577E+01 .100743688382E+01 .863177180939E+00 .734385201328E+00 + .620352489207E+00 .520241312105E+00 .433105012361E+00 .357908953755E+00 .293558971531E+00 + .238939332961E+00 .192952602310E+00 .154550561105E+00 .122752025089E+00 .966509456742E-01 + .754197389551E-01 .583105713293E-01 .446553155083E-01 .338641489723E-01 .254227504169E-01 + .188882123217E-01 .138839144900E-01 .100936595806E-01 + kinetic energy-density + .667223264162E+01 .673711797765E+01 .680446051695E+01 .687434851945E+01 .694687595542E+01 + .702214224715E+01 .710025264340E+01 .718131851959E+01 .726545770326E+01 .735279480889E+01 + .744346157547E+01 .753759722098E+01 .763534880551E+01 .773687160651E+01 .784232950769E+01 + .795189540556E+01 .806575163262E+01 .818409040251E+01 .830711427710E+01 .843503666033E+01 + .856808232008E+01 .870648794174E+01 .885050271727E+01 .900038897044E+01 .915642282528E+01 + .931889491632E+01 .948811114834E+01 .966439350589E+01 .984808091773E+01 .100395301784E+02 + .102391169326E+02 .104472367229E+02 .106643061077E+02 .108907638526E+02 .111270721976E+02 + .113737182071E+02 .116312152061E+02 .119001043069E+02 .121809560330E+02 .124743720445E+02 + .127809869719E+02 .131014703626E+02 .134365287498E+02 .137869078483E+02 .141533948854E+02 + .145368210760E+02 .149380642484E+02 .153580516325E+02 .157977628176E+02 .162582328917E+02 + .167405557713E+02 .172458877376E+02 .177754511847E+02 .183305385986E+02 .189125167802E+02 + .195228313211E+02 .201630113570E+02 .208346746071E+02 .215395327218E+02 .222793969540E+02 + .230561841768E+02 .238719232645E+02 .247287618625E+02 .256289735654E+02 .265749655308E+02 + .275692865534E+02 .286146356255E+02 .297138710144E+02 .308700198863E+02 .320862885081E+02 + .333660730613E+02 .347129711045E+02 .361307937197E+02 .376235783832E+02 .391956026049E+02 + .408513983733E+02 .425957674600E+02 .444337976250E+02 .463708797814E+02 .484127261615E+02 + .505653895529E+02 .528352836548E+02 .552292046175E+02 .577543538336E+02 .604183620400E+02 + .632293148117E+02 .661957795124E+02 .693268337816E+02 .726320956402E+02 .761217552952E+02 + .798066087313E+02 .836980931813E+02 .878083245648E+02 .921501369964E+02 .967371244646E+02 + .101583684778E+03 .106705065895E+03 .112117414743E+03 .117837828637E+03 .123884409424E+03 + .130276320461E+03 .137033846552E+03 .144178456977E+03 .151732871716E+03 .159721131020E+03 + .168168668441E+03 .177102387447E+03 .186550741762E+03 .196543819548E+03 .207113431542E+03 + .218293203301E+03 .230118671632E+03 .242627385346E+03 .255859010429E+03 .269855439723E+03 + .284660907211E+03 .300322106967E+03 .316888316840E+03 .334411526903E+03 .352946572698E+03 + .372551273268E+03 .393286573957E+03 .415216693909E+03 .438409278191E+03 .462935554406E+03 + .488870493624E+03 .516292975418E+03 .545285956739E+03 .575936644299E+03 .608336670067E+03 + .642582269425E+03 .678774461430E+03 .717019230563E+03 .757427709234E+03 .800116360219E+03 + .845207158092E+03 .892827768584E+03 .943111724662E+03 .996198598018E+03 .105223416443E+04 + .111137056136E+04 .117376643592E+04 .123958708122E+04 .130900455875E+04 .138219780446E+04 + .145935271573E+04 .154066221641E+04 .162632629657E+04 .171655202365E+04 .181155352120E+04 + .191155191114E+04 .201677521519E+04 .212745821087E+04 .224384223707E+04 .236617494387E+04 + .249470998100E+04 .262970661903E+04 .277142929698E+04 .292014708990E+04 .307613308942E+04 + .323966369031E+04 .341101777559E+04 .359047579274E+04 .377831871320E+04 .397482686744E+04 + .418027864771E+04 .439494907065E+04 .461910819220E+04 .485301936717E+04 .509693734651E+04 + .535110620572E+04 .561575709823E+04 .589110582872E+04 .617735024215E+04 .647466742549E+04 + .678321072048E+04 .710310654759E+04 .743445104313E+04 .777730651347E+04 .813169771335E+04 + .849760795736E+04 .887497507731E+04 .926368724144E+04 .966357865505E+04 .100744251666E+05 + .104959398071E+05 .109277682965E+05 .113694845538E+05 .118205862555E+05 .122804904900E+05 + .127485295625E+05 .132239470112E+05 .137058938992E+05 .141934254546E+05 .146854981352E+05 + .151809671997E+05 .156785848725E+05 .161769991918E+05 .166747536369E+05 .171702876279E+05 + .176619379985E+05 .181479415367E+05 .186264386884E+05 .190954785183E+05 .195530250094E+05 + .199969647834E+05 .204251163067E+05 .208352406373E+05 .212250537526E+05 .215922404774E+05 + .219344700116E+05 .222494130342E+05 .225347603288E+05 .227882428528E+05 .230076531342E+05 + .231908678498E+05 .233358714016E+05 .234407802719E+05 .235038678982E+05 .235235897755E+05 + .234986084530E+05 .234278180618E+05 .233103679754E+05 .231456851799E+05 .229334949056E+05 + .226738390590E+05 .223670919806E+05 .220139730591E+05 .216155557379E+05 .211732724746E+05 + .206889152456E+05 .201646312393E+05 .196029134408E+05 .190065858947E+05 .183787835298E+05 + .177229265428E+05 .170426894747E+05 .163419652635E+05 .156248247191E+05 .148954720435E+05 + .141581971857E+05 .134173261542E+05 .126771693102E+05 .119419713654E+05 .112158605938E+05 + .105028007380E+05 .980654499989E+04 .913059236999E+04 .847814611827E+04 .785207438837E+04 + .725487344929E+04 .668863511301E+04 .615502069364E+04 .565524417361E+04 .519006672766E+04 + .475980357784E+04 .436434266402E+04 .400317320563E+04 .367542131406E+04 .337988973053E+04 + .311509948092E+04 .287933226802E+04 .267067318949E+04 .248705363715E+04 .232629412847E+04 + .218614659385E+04 .206433545994E+04 .195859678351E+04 .186671469198E+04 .178655445016E+04 + .171609157853E+04 .165343658116E+04 .159685499112E+04 .154478259599E+04 .149583585719E+04 + .144881767535E+04 .140271877451E+04 .135671507596E+04 .131016150708E+04 .126258274155E+04 + .121366139499E+04 .116322420862E+04 .111122674356E+04 .105773708455E+04 .100291901627E+04 + .947015091482E+03 .890329959869E+03 .833214272270E+03 .776049418457E+03 .719233299337E+03 + .663167278558E+03 .608244406410E+03 .554838966220E+03 .503297358442E+03 .453930336633E+03 + .407006601755E+03 .362747806752E+03 .321325033168E+03 .282856907413E+03 .247409252478E+03 + .214996590257E+03 .185585245619E+03 .159098177908E+03 .135421633456E+03 .114413857777E+03 + .959157099433E+02 .797613979036E+02 .657850515169E+02 .538188522131E+02 .436847873034E+02 + .351899916323E+02 .281331203679E+02 .223174729841E+02 .175614967879E+02 .137029357329E+02 + .105987319431E+02 .812353742881E+01 .616817860109E+01 .463832203023E+01 .345324816958E+01 + .254463542651E+01 .185531926861E+01 .133803588607E+01 + pspotential + -.284668580974E+02 -.284683169301E+02 -.284697298194E+02 -.284710982122E+02 -.284724235102E+02 + -.284737070698E+02 -.284749502063E+02 -.284761541924E+02 -.284773202611E+02 -.284784496066E+02 + -.284795433857E+02 -.284806027180E+02 -.284816286891E+02 -.284826223489E+02 -.284835847157E+02 + -.284845167748E+02 -.284854194805E+02 -.284862937574E+02 -.284871405012E+02 -.284879605786E+02 + -.284887548297E+02 -.284895240675E+02 -.284902690805E+02 -.284909906311E+02 -.284916894586E+02 + -.284923662782E+02 -.284930217837E+02 -.284936566461E+02 -.284942715156E+02 -.284948670220E+02 + -.284954437749E+02 -.284960023654E+02 -.284965433652E+02 -.284970673288E+02 -.284975747926E+02 + -.284980662764E+02 -.284985422834E+02 -.284990033014E+02 -.284994498023E+02 -.284998822437E+02 + -.285003010685E+02 -.285007067055E+02 -.285010995703E+02 -.285014800653E+02 -.285018485803E+02 + -.285022054928E+02 -.285025511684E+02 -.285028859612E+02 -.285032102143E+02 -.285035242597E+02 + -.285038284193E+02 -.285041230047E+02 -.285044083177E+02 -.285046846506E+02 -.285049522867E+02 + -.285052115003E+02 -.285054625570E+02 -.285057057141E+02 -.285059412208E+02 -.285061693187E+02 + -.285063902416E+02 -.285066042160E+02 -.285068114613E+02 -.285070121901E+02 -.285072066083E+02 + -.285073949154E+02 -.285075773047E+02 -.285077539632E+02 -.285079250725E+02 -.285080908082E+02 + -.285082513405E+02 -.285084068344E+02 -.285085574497E+02 -.285087033412E+02 -.285088446592E+02 + -.285089815489E+02 -.285091141512E+02 -.285092426028E+02 -.285093670362E+02 -.285094875796E+02 + -.285096043574E+02 -.285097174903E+02 -.285098270953E+02 -.285099332857E+02 -.285100361716E+02 + -.285101358596E+02 -.285102324533E+02 -.285103260530E+02 -.285104167563E+02 -.285105046579E+02 + -.285105898494E+02 -.285106724202E+02 -.285107524569E+02 -.285108300437E+02 -.285109052623E+02 + -.285109781925E+02 -.285110489115E+02 -.285111174947E+02 -.285111840153E+02 -.285112485448E+02 + -.285113111527E+02 -.285113719068E+02 -.285114308734E+02 -.285114881171E+02 -.285115437009E+02 + -.285115976866E+02 -.285116501346E+02 -.285117011040E+02 -.285117506529E+02 -.285117988383E+02 + -.285118457160E+02 -.285118913411E+02 -.285119357679E+02 -.285119790499E+02 -.285120212399E+02 + -.285120623903E+02 -.285121025528E+02 -.285121417791E+02 -.285121801201E+02 -.285122176271E+02 + -.285122543509E+02 -.285122903425E+02 -.285123256531E+02 -.285123603339E+02 -.285123944366E+02 + -.285124280136E+02 -.285124611175E+02 -.285124938019E+02 -.285125261211E+02 -.285125581306E+02 + -.285125898869E+02 -.285126214480E+02 -.285126528730E+02 -.285126842231E+02 -.285127155610E+02 + -.285127469515E+02 -.285127784618E+02 -.285128101613E+02 -.285128421220E+02 -.285128744192E+02 + -.285129071308E+02 -.285129403386E+02 -.285129741276E+02 -.285130085872E+02 -.285130438109E+02 + -.285130798969E+02 -.285131169482E+02 -.285131550734E+02 -.285131943868E+02 -.285132350088E+02 + -.285132770666E+02 -.285133206943E+02 -.285133660339E+02 -.285134132352E+02 -.285134624572E+02 + -.285135138679E+02 -.285135676456E+02 -.285136239791E+02 -.285136830688E+02 -.285137451272E+02 + -.285138103801E+02 -.285138790671E+02 -.285139514428E+02 -.285140277778E+02 -.285141083597E+02 + -.285141934943E+02 -.285142835068E+02 -.285143787430E+02 -.285144795711E+02 -.285145863826E+02 + -.285146995943E+02 -.285148196500E+02 -.285149470220E+02 -.285150822131E+02 -.285152257590E+02 + -.285153782298E+02 -.285155402330E+02 -.285157124155E+02 -.285158954666E+02 -.285160901204E+02 + -.285162971590E+02 -.285165174159E+02 -.285167517787E+02 -.285170011938E+02 -.285172666691E+02 + -.285175492789E+02 -.285178501680E+02 -.285181705563E+02 -.285185117440E+02 -.285188751165E+02 + -.285192621507E+02 -.285196744202E+02 -.285201136023E+02 -.285205814849E+02 -.285210799732E+02 + -.285216110981E+02 -.285221770239E+02 -.285227800576E+02 -.285234226581E+02 -.285241074462E+02 + -.285248372152E+02 -.285256149423E+02 -.285264438010E+02 -.285273271733E+02 -.285282686643E+02 + -.285292721163E+02 -.285303416243E+02 -.285314815531E+02 -.285326965547E+02 -.285339915870E+02 + -.285353719343E+02 -.285368432283E+02 -.285384114710E+02 -.285400830591E+02 -.285418648095E+02 + -.285437639871E+02 -.285457883340E+02 -.285479461006E+02 -.285502460786E+02 -.285526976368E+02 + -.285553107581E+02 -.285580960799E+02 -.285610649366E+02 -.285642294047E+02 -.285676023510E+02 + -.285711974839E+02 -.285750294079E+02 -.285791136815E+02 -.285834668789E+02 -.285881066552E+02 + -.285930518163E+02 -.285983223931E+02 -.286039397193E+02 -.286099265159E+02 -.286163069793E+02 + -.286231068758E+02 -.286303536416E+02 -.286380764889E+02 -.286463065191E+02 -.286550768420E+02 + -.286644227033E+02 -.286743816188E+02 -.286849935181E+02 -.286963008955E+02 -.287083489715E+02 + -.287211858626E+02 -.287348627628E+02 -.287494341353E+02 -.287649579152E+02 -.287814957256E+02 + -.287991131063E+02 -.288178797557E+02 -.288378697884E+02 -.288591620081E+02 -.288818401970E+02 + -.289059934240E+02 -.289317163713E+02 -.289591096822E+02 -.289882803316E+02 -.290193420199E+02 + -.290524155945E+02 -.290876294986E+02 -.291251202524E+02 -.291650329680E+02 -.292075219026E+02 + -.292527510523E+02 -.293008947930E+02 -.293521385709E+02 -.294066796496E+02 -.294647279184E+02 + -.295265067689E+02 -.295922540467E+02 -.296622230833E+02 -.297366838166E+02 -.298159240051E+02 + -.299002505394E+02 -.299899908538E+02 -.300854944348E+02 -.301871344177E+02 -.302953092527E+02 + -.304104444074E+02 -.305329940542E+02 -.306634426595E+02 -.308023063576E+02 -.309501339324E+02 + -.311075071620E+02 -.312750401800E+02 -.314533773784E+02 -.316431892087E+02 -.318451650241E+02 + -.320600018433E+02 -.322883876156E+02 -.325309772422E+02 -.327883593234E+02 -.330610114486E+02 + -.333492420108E+02 -.336531172581E+02 -.339723739182E+02 -.343063205135E+02 -.346537343042E+02 + -.350127645096E+02 -.353808527148E+02 -.357546711895E+02 -.361300477034E+02 -.365017781319E+02 + -.368631244736E+02 -.372047033483E+02 -.375125520335E+02 -.377657440182E+02 -.379353182676E+02 + -.379879388728E+02 -.378969924352E+02 -.376572675510E+02 -.372895576252E+02 -.368609887562E+02 + -.364580390768E+02 -.360705398248E+02 -.356893343561E+02 -.353112759338E+02 -.349371692255E+02 + -.345669009212E+02 -.341257373489E+02 -.337108274651E+02 + core charge-density (pseudized) + .158850907132E-07 .169349744559E-07 .180542475326E-07 .192474960507E-07 .205196092244E-07 + .218757994079E-07 .233216234522E-07 .248630054739E-07 .265062611287E-07 .282581234892E-07 + .301257706327E-07 .321168550529E-07 .342395350151E-07 .365025079838E-07 .389150462599E-07 + .414870349726E-07 .442290125832E-07 .471522140648E-07 .502686169368E-07 .535909903417E-07 + .571329473648E-07 .609090008129E-07 .649346226787E-07 .692263075359E-07 .738016401239E-07 + .786793673994E-07 .838794753501E-07 .894232708855E-07 .953334691390E-07 .101634286542E-06 + .108351540046E-06 .115512752907E-06 .123147267460E-06 .131286365342E-06 .139963395669E-06 + .149213911678E-06 .159075816404E-06 .169589517985E-06 .180798095227E-06 .192747474115E-06 + .205486615992E-06 .219067718171E-06 .233546427810E-06 .248982069915E-06 .265437890425E-06 + .282981315349E-06 .301684227038E-06 .321623258718E-06 .342880108482E-06 .365541874040E-06 + .389701409594E-06 .415457706293E-06 .442916297843E-06 .472189692914E-06 .503397836133E-06 + .536668599544E-06 .572138306547E-06 .609952290465E-06 .650265490033E-06 .693243084236E-06 + .739061169114E-06 .787907479286E-06 .839982157176E-06 .895498573063E-06 .954684199344E-06 + .101778154256E-05 .108504913706E-05 .115676260427E-05 .123321578204E-05 .131472192859E-05 + .140161500606E-05 .149425104883E-05 .159300962235E-05 .169829537834E-05 .181053971277E-05 + .193020253346E-05 .205777414445E-05 .219377725496E-05 .233876912105E-05 .249334382893E-05 + .265813472909E-05 .283381703132E-05 .302111057124E-05 .322078275972E-05 .343365172714E-05 + .366058967549E-05 .390252645204E-05 .416045335916E-05 .443542721593E-05 .472857468816E-05 + .504109690465E-05 .537427437842E-05 .572947225328E-05 .610814589706E-05 .651184686453E-05 + .694222925437E-05 .740105648627E-05 .789020852588E-05 .841168958728E-05 .896763634441E-05 + .956032668519E-05 .101921890442E-04 .108658123520E-04 .115839566421E-04 .123495643585E-04 + .131657724114E-04 .140359250280E-04 .149635874541E-04 .159525605604E-04 .170068964137E-04 + .181309148776E-04 .193292213099E-04 .206067254291E-04 .219686614285E-04 .234206094181E-04 + .249685182840E-04 .266187300582E-04 .283780058984E-04 .302535537841E-04 .322530580431E-04 + .343847108279E-04 .366572456728E-04 .390799732669E-04 .416628195906E-04 .444163665717E-04 + .473518954273E-04 .504814328676E-04 .538178003533E-04 .573746666051E-04 .611666035821E-04 + .652091461570E-04 .695188557326E-04 .741133880594E-04 .790115655314E-04 .842334542561E-04 + .898004462130E-04 .957353468361E-04 .102062468380E-03 .108807729446E-03 .115998761083E-03 + .123665019889E-03 .131837908571E-03 .140550904475E-03 .149839696579E-03 .159742331544E-03 + .170299369380E-03 .181554049396E-03 .193552467086E-03 .206343762684E-03 .219980322147E-03 + .234517991391E-03 .250016304646E-03 .266538727861E-03 .284152918146E-03 .302931000300E-03 + .322949861560E-03 .344291465748E-03 .367043188107E-03 .391298172159E-03 .417155710061E-03 + .444721647953E-03 .474108817981E-03 .505437498701E-03 .538835905735E-03 .574440714657E-03 + .612397618202E-03 .652861920041E-03 .695999167499E-03 .741985825749E-03 .791009996188E-03 + .843272181843E-03 .898986102869E-03 .958379565380E-03 .102169538706E-02 .108919238320E-02 + .116114641712E-02 .123785151900E-02 .131962107766E-02 .140678910979E-02 .149971161181E-02 + .159876799938E-02 .170436264031E-02 .181692648675E-02 .193691881296E-02 .206482906523E-02 + .220117883122E-02 .234652393586E-02 .250145667215E-02 .266660817484E-02 .284265094610E-02 + .303030154244E-02 .323032343282E-02 .344353003832E-02 .367078796445E-02 .391302043770E-02 + .417121095843E-02 .444640718317E-02 .473972504961E-02 .505235315859E-02 .538555742793E-02 + .574068603353E-02 .611917465425E-02 .652255203717E-02 .695244590122E-02 .741058919732E-02 + .789882674413E-02 .841912225897E-02 .897356580441E-02 .956438167099E-02 .101939367177E-01 + .108647491919E-01 .115794980501E-01 .123410328028E-01 .131523839044E-01 .140167737110E-01 + .149376280269E-01 .159185882611E-01 .169635242136E-01 .180765475092E-01 .192620256957E-01 + .205245970213E-01 .218691859007E-01 .233010190786E-01 .248256424935E-01 .264489388384E-01 + .281771458098E-01 .300168750282E-01 .319751316050E-01 .340593343169E-01 .362773363404E-01 + .386374464823E-01 .411484508237E-01 .438196346781E-01 .466608047400E-01 .496823112734E-01 + .528950701615E-01 .563105846042E-01 .599409662088E-01 .637989551781E-01 .678979392487E-01 + .722519709725E-01 .768757828747E-01 .817847999463E-01 .869951488479E-01 .925236631107E-01 + .983878835213E-01 .104606052760E+00 .111197103239E+00 .118180636950E+00 .125576895976E+00 + .133406722150E+00 .141691504177E+00 .150453110317E+00 .159713804529E+00 .169496143740E+00 + .179822853659E+00 .190716680317E+00 .202200214208E+00 .214295683694E+00 .227024713996E+00 + .240408047883E+00 .254465223863E+00 .269214207487E+00 .284670971153E+00 .300849017672E+00 + .317758842779E+00 .335407331821E+00 .353797086014E+00 .372925673998E+00 .392784804976E+00 + .413359420546E+00 .434626703479E+00 .456555003242E+00 .479102680107E+00 .502216872244E+00 + .525832193516E+00 .549869373680E+00 .574233857642E+00 .598814386387E+00 .623481589187E+00 + .648086625061E+00 .672459920978E+00 .696410065316E+00 .719722927378E+00 .742161087375E+00 + .763463676005E+00 .783346738217E+00 .801504251502E+00 .817609944243E+00 .831320073323E+00 + .842277330789E+00 .850116055018E+00 .854468920152E+00 .854975265373E+00 .851291199249E+00 + .843101569433E+00 .830133819226E+00 .812173654295E+00 .789082308931E+00 .760815025548E+00 + .727440137991E+00 .689157874534E+00 .646317668655E+00 .599432387566E+00 .549187469489E+00 + .496442519212E+00 .442222478719E+00 .387695112852E+00 .334131296257E+00 .282844548501E+00 + .235106556397E+00 .192036190812E+00 .154460937507E+00 .122751901168E+00 .966509456742E-01 + .754197389551E-01 .583105713293E-01 .446553155083E-01 .338641489723E-01 .254227504169E-01 + .188882123217E-01 .138839144900E-01 .100936595806E-01 + pseudo wavefunction + .575355356415E-04 .594064477253E-04 .613381972024E-04 .633327623533E-04 .653921857868E-04 + .675185765325E-04 .697141122004E-04 .719810412106E-04 .743216850967E-04 .767384408824E-04 + .792337835369E-04 .818102685089E-04 .844705343442E-04 .872173053874E-04 .900533945721E-04 + .929817063013E-04 .960052394220E-04 .991270902962E-04 .102350455972E-03 .105678637457E-03 + .109115043101E-03 .112663192082E-03 .116326718016E-03 .120109372672E-03 .124015029819E-03 + .128047689192E-03 .132211480586E-03 .136510668086E-03 .140949654437E-03 .145532985548E-03 + .150265355149E-03 .155151609602E-03 .160196752857E-03 .165405951581E-03 .170784540448E-03 + .176338027603E-03 .182072100302E-03 .187992630735E-03 .194105682043E-03 .200417514522E-03 + .206934592042E-03 .213663588656E-03 .220611395446E-03 .227785127571E-03 .235192131559E-03 + .242839992828E-03 .250736543454E-03 .258889870194E-03 .267308322765E-03 .276000522397E-03 + .284975370659E-03 .294242058578E-03 .303810076049E-03 .313689221556E-03 .323889612204E-03 + .334421694082E-03 .345296252956E-03 .356524425323E-03 .368117709807E-03 .380087978939E-03 + .392447491317E-03 .405208904153E-03 .418385286245E-03 .431990131351E-03 .446037372013E-03 + .460541393824E-03 .475517050162E-03 .490979677395E-03 .506945110594E-03 .523429699744E-03 + .540450326492E-03 .558024421429E-03 .576169981949E-03 .594905590672E-03 .614250434477E-03 + .634224324152E-03 .654847714681E-03 .676141726189E-03 .698128165574E-03 .720829548839E-03 + .744269124145E-03 .768470895626E-03 .793459647966E-03 .819260971781E-03 .845901289826E-03 + .873407884057E-03 .901808923562E-03 .931133493415E-03 .961411624459E-03 .992674324057E-03 + .102495360785E-02 .105828253254E-02 .109269522973E-02 .112822694092E-02 .116491405352E-02 + .120279413821E-02 .124190598731E-02 .128228965460E-02 .132398649626E-02 .136703921328E-02 + .141149189515E-02 .145739006503E-02 .150478072633E-02 .155371241090E-02 .160423522870E-02 + .165640091909E-02 .171026290385E-02 .176587634186E-02 .182329818560E-02 .188258723945E-02 + .194380421993E-02 .200701181784E-02 .207227476250E-02 .213965988796E-02 .220923620153E-02 + .228107495436E-02 .235524971443E-02 .243183644189E-02 .251091356682E-02 .259256206952E-02 + .267686556349E-02 .276391038097E-02 .285378566135E-02 .294658344250E-02 .304239875489E-02 + .314132971901E-02 .324347764574E-02 .334894714010E-02 .345784620834E-02 .357028636854E-02 + .368638276474E-02 .380625428484E-02 .393002368229E-02 .405781770175E-02 .418976720886E-02 + .432600732415E-02 .446667756139E-02 .461192197039E-02 .476188928438E-02 .491673307231E-02 + .507661189599E-02 .524168947234E-02 .541213484098E-02 .558812253715E-02 .576983277035E-02 + .595745160873E-02 .615117116944E-02 .635118981518E-02 .655771235717E-02 .677095026461E-02 + .699112188101E-02 .721845264752E-02 .745317533347E-02 .769553027439E-02 .794576561781E-02 + .820413757691E-02 .847091069247E-02 .874635810329E-02 .903076182533E-02 .932441303995E-02 + .962761239135E-02 .994067029381E-02 .102639072487E-01 .105976541719E-01 .109422527315E-01 + .112980556968E-01 .116654272983E-01 .120447435995E-01 .124363928804E-01 .128407760336E-01 + .132583069731E-01 .136894130563E-01 .141345355194E-01 .145941299272E-01 .150686666365E-01 + .155586312758E-01 .160645252384E-01 .165868661936E-01 .171261886122E-01 .176830443099E-01 + .182580030081E-01 .188516529119E-01 .194646013071E-01 .200974751761E-01 .207509218330E-01 + .214256095793E-01 .221222283799E-01 .228414905610E-01 .235841315294E-01 .243509105150E-01 + .251426113360E-01 .259600431889E-01 .268040414619E-01 .276754685752E-01 .285752148462E-01 + .295041993818E-01 .304633709985E-01 .314537091706E-01 .324762250072E-01 .335319622594E-01 + .346219983579E-01 .357474454814E-01 .369094516585E-01 .381092019006E-01 .393479193701E-01 + .406268665822E-01 .419473466418E-01 .433107045170E-01 .447183283484E-01 .461716507967E-01 + .476721504277E-01 .492213531363E-01 .508208336098E-01 .524722168313E-01 .541771796234E-01 + .559374522328E-01 .577548199563E-01 .596311248087E-01 .615682672319E-01 .635682078464E-01 + .656329692451E-01 .677646378278E-01 .699653656785E-01 .722373724825E-01 .745829474842E-01 + .770044514849E-01 .795043188773E-01 .820850597180E-01 .847492618341E-01 .874995929625E-01 + .903388029198E-01 .932697257982E-01 .962952821862E-01 .994184814074E-01 .102642423774E+00 + .105970302852E+00 .109405407722E+00 .112951125248E+00 .116610942317E+00 .120388448077E+00 + .124287336121E+00 .128311406648E+00 .132464568547E+00 .136750841429E+00 .141174357551E+00 + .145739363643E+00 .150450222608E+00 .155311415056E+00 .160327540676E+00 .165503319382E+00 + .170843592230E+00 .176353322051E+00 .182037593757E+00 .187901614291E+00 .193950712150E+00 + .200190336440E+00 .206626055381E+00 .213263554212E+00 .220108632399E+00 .227167200068E+00 + .234445273557E+00 .241948969987E+00 .249684500724E+00 .257658163593E+00 .265876333703E+00 + .274345452710E+00 .283072016330E+00 .292062559898E+00 .301323641738E+00 .310861824101E+00 + .320683651362E+00 .330795625188E+00 .341204176307E+00 .351915632491E+00 .362936182330E+00 + .374271834305E+00 .385928370642E+00 .397911295339E+00 .410225775742E+00 .422876576925E+00 + .435867988095E+00 .449203740138E+00 .462886913351E+00 .476919834292E+00 .491303960597E+00 + .506039752485E+00 .521126529587E+00 .536562311577E+00 .552343640997E+00 .568465386534E+00 + .584920524858E+00 .601699899070E+00 .618791951638E+00 .636182429658E+00 .653854060191E+00 + .671786193400E+00 .689954411226E+00 .708330099434E+00 .726879981021E+00 .745565609229E+00 + .764342818847E+00 .783161135014E+00 .801963139531E+00 .820683795679E+00 .839249733873E+00 + .857578502086E+00 .875577787069E+00 .893144614848E+00 .910164542018E+00 .926510852941E+00 + .942043782108E+00 .956609785792E+00 .970040892551E+00 .982154168203E+00 .992751337468E+00 + .100161861137E+01 .100852677652E+01 .101323160906E+01 .101547468225E+01 .101498464091E+01 + .101147901878E+01 .100466111560E+01 .994375951175E+00 + ae wavefunction + .723210491674E-03 .746578583504E-03 .770700951777E-03 .795601892046E-03 .821306479222E-03 + .847840592364E-03 .875230940233E-03 .903505087646E-03 .932691482648E-03 .962819484530E-03 + .993919392710E-03 .102602247652E-02 .105916100589E-02 .109336828301E-02 .112867867496E-02 + .116512764731E-02 .120275179882E-02 .124158889712E-02 .128167791559E-02 .132305907123E-02 + .136577386383E-02 .140986511623E-02 .145537701585E-02 .150235515746E-02 .155084658728E-02 + .160089984836E-02 .165256502735E-02 .170589380272E-02 .176093949434E-02 .181775711461E-02 + .187640342107E-02 .193693697064E-02 .199941817539E-02 .206390935997E-02 .213047482081E-02 + .219918088694E-02 .227009598271E-02 .234329069219E-02 .241883782559E-02 .249681248751E-02 + .257729214718E-02 .266035671067E-02 .274608859525E-02 .283457280576E-02 .292589701322E-02 + .302015163557E-02 .311742992074E-02 .321782803195E-02 .332144513543E-02 .342838349055E-02 + .353874854230E-02 .365264901643E-02 .377019701702E-02 .389150812670E-02 .401670150953E-02 + .414590001658E-02 .427923029422E-02 .441682289522E-02 .455881239271E-02 .470533749697E-02 + .485654117518E-02 .501257077409E-02 .517357814572E-02 .533971977604E-02 .551115691676E-02 + .568805572017E-02 .587058737709E-02 .605892825797E-02 .625326005711E-02 .645376994004E-02 + .666065069409E-02 .687410088207E-02 .709432499912E-02 .732153363272E-02 .755594362580E-02 + .779777824289E-02 .804726733939E-02 .830464753379E-02 .857016238277E-02 .884406255928E-02 + .912660603329E-02 .941805825521E-02 .971869234197E-02 .100287892654E-01 .103486380429E-01 + .106785359304E-01 .110187886169E-01 .113697104211E-01 .117316244893E-01 .121048629944E-01 + .124897673360E-01 .128866883414E-01 .132959864662E-01 .137180319953E-01 .141532052432E-01 + .146018967537E-01 .150645074973E-01 .155414490675E-01 .160331438739E-01 .165400253324E-01 + .170625380517E-01 .176011380142E-01 .181562927528E-01 .187284815203E-01 .193181954522E-01 + .199259377210E-01 .205522236809E-01 .211975810029E-01 .218625497970E-01 .225476827224E-01 + .232535450820E-01 .239807149024E-01 .247297829946E-01 .255013529962E-01 .262960413920E-01 + .271144775113E-01 .279573034995E-01 .288251742619E-01 .297187573775E-01 .306387329797E-01 + .315857936016E-01 .325606439823E-01 .335640008323E-01 .345965925527E-01 .356591589072E-01 + .367524506409E-01 .378772290432E-01 .390342654498E-01 .402243406813E-01 .414482444099E-01 + .427067744540E-01 .440007359916E-01 .453309406888E-01 .466982057375E-01 .481033527959E-01 + .495472068255E-01 .510305948176E-01 .525543444026E-01 .541192823346E-01 .557262328435E-01 + .573760158460E-01 .590694450081E-01 .608073256492E-01 .625904524789E-01 .644196071575E-01 + .662955556690E-01 .682190454976E-01 .701908025956E-01 .722115281337E-01 .742818950192E-01 + .764025441734E-01 .785740805545E-01 .807970689137E-01 .830720292724E-01 .853994321068E-01 + .877796932277E-01 .902131683422E-01 .927001472824E-01 .952408478902E-01 .978354095427E-01 + .100483886305E+00 .103186239701E+00 .105942331082E+00 .108751913586E+00 .111614623678E+00 + .114529972255E+00 .117497335304E+00 .120515944107E+00 .123584874990E+00 .126703038594E+00 + .129869168677E+00 .133081810436E+00 .136339308348E+00 .139639793532E+00 .142981170636E+00 + .146361104253E+00 .149777004875E+00 .153226014404E+00 .156704991228E+00 .160210494897E+00 + .163738770409E+00 .167285732154E+00 .170846947546E+00 .174417620387E+00 .177992574025E+00 + .181566234348E+00 .185132612703E+00 .188685288794E+00 .192217393669E+00 .195721592871E+00 + .199190069873E+00 .202614509914E+00 .205986084362E+00 .209295435754E+00 .212532663666E+00 + .215687311579E+00 .218748354949E+00 .221704190648E+00 .224542628026E+00 .227250881804E+00 + .229815567059E+00 .232222696565E+00 .234457680772E+00 .236505330719E+00 .238349864209E+00 + .239974915563E+00 .241363549317E+00 .242498278209E+00 .243361085852E+00 .243933454457E+00 + .244196398032E+00 .244130501447E+00 .243715965781E+00 .242932660377E+00 .241760182005E+00 + .240177921559E+00 .238165138679E+00 .235701044686E+00 .232764894196E+00 .229336085751E+00 + .225394271769E+00 .220919478069E+00 .215892233186E+00 .210293707615E+00 .204105863065E+00 + .197311611722E+00 .189894985412E+00 .181841314484E+00 .173137416083E+00 .163771791405E+00 + .153734831344E+00 .143019029848E+00 .131619204110E+00 .119532720583E+00 .106759725623E+00 + .933033793783E-01 .791700913290E-01 .643697556467E-01 .489159842705E-01 .328263352823E-01 + .161225338086E-01 -.116931769311E-02 -.190185432589E-01 -.373897150652E-01 -.562424965567E-01 + -.755315101746E-01 -.952062316141E-01 -.115210910670E+00 -.135484516518E+00 -.155960703517E+00 + -.176567793429E+00 -.197228772403E+00 -.217861306439E+00 -.238377786432E+00 -.258685421094E+00 + -.278686400098E+00 -.298278147634E+00 -.317353677390E+00 -.335802046575E+00 -.353508895291E+00 + -.370357053514E+00 -.386227201622E+00 -.400998577469E+00 -.414549728634E+00 -.426759310469E+00 + -.437506929404E+00 -.446674028239E+00 -.454144807390E+00 -.459807173979E+00 -.463553709570E+00 + -.465282646961E+00 -.464898846615E+00 -.462314763759E+00 -.457451397642E+00 -.450239215005E+00 + -.440619040214E+00 -.428542904958E+00 -.413974850650E+00 -.396891676910E+00 -.377283629551E+00 + -.355155021405E+00 -.330524779042E+00 -.303426907952E+00 -.273910868147E+00 -.242041851308E+00 + -.207900949827E+00 -.171585207413E+00 -.133207540559E+00 -.928965205479E-01 -.507960069887E-01 + -.706462660247E-02 .381249046254E-01 .845866118155E-01 .132122232827E+00 .180522312943E+00 + .229567399836E+00 .279029316983E+00 .328672503777E+00 .378255433412E+00 .427532158406E+00 + .476254091096E+00 .524172202057E+00 .571039898221E+00 .616616860053E+00 .660673895312E+00 + .702998092998E+00 .743396069181E+00 .781691750831E+00 .817716502043E+00 .851295258407E+00 + .882238299672E+00 .910345743397E+00 .935421491735E+00 .957287299205E+00 .975791213531E+00 + .990810701652E+00 .100225314042E+01 .101005569012E+01 .101418535258E+01 .101463927777E+01 + .101144510801E+01 .100466111560E+01 .994375951175E+00 + pseudo wavefunction + .138848147713E-05 .143363143073E-05 .148024954817E-05 .152838357046E-05 .157808279106E-05 + .162939810629E-05 .168238206754E-05 .173708893499E-05 .179357473326E-05 .185189730873E-05 + .191211638882E-05 .197429364312E-05 .203849274656E-05 .210477944463E-05 .217322162069E-05 + .224388936550E-05 .231685504901E-05 .239219339443E-05 .246998155480E-05 .255029919199E-05 + .263322855826E-05 .271885458052E-05 .280726494727E-05 .289855019843E-05 .299280381807E-05 + .309012233011E-05 .319060539717E-05 .329435592268E-05 .340148015621E-05 .351208780231E-05 + .362629213282E-05 .374421010294E-05 .386596247091E-05 .399167392177E-05 .412147319496E-05 + .425549321623E-05 .439387123372E-05 .453674895855E-05 .468427270993E-05 .483659356497E-05 + .499386751345E-05 .515625561753E-05 .532392417672E-05 .549704489814E-05 .567579507240E-05 + .586035775516E-05 .605092195456E-05 .624768282482E-05 .645084186605E-05 .666060713066E-05 + .687719343636E-05 .710082258618E-05 .733172359563E-05 .757013292719E-05 .781629473250E-05 + .807046110236E-05 .833289232491E-05 .860385715220E-05 .888363307535E-05 .917250660878E-05 + .947077358361E-05 .977873945059E-05 .100967195929E-04 .104250396492E-04 .107640358469E-04 + .111140553467E-04 .114754565982E-04 .118486097064E-04 .122338968115E-04 .126317124796E-04 + .130424641070E-04 .134665723375E-04 .139044714931E-04 .143566100184E-04 .148234509404E-04 + .153054723424E-04 .158031678534E-04 .163170471539E-04 .168476364977E-04 .173954792507E-04 + .179611364475E-04 .185451873656E-04 .191482301190E-04 .197708822706E-04 .204137814640E-04 + .210775860774E-04 .217629758970E-04 .224706528134E-04 .232013415404E-04 .239557903567E-04 + .247347718727E-04 .255390838211E-04 .263695498740E-04 .272270204861E-04 .281123737658E-04 + .290265163739E-04 .299703844525E-04 .309449445827E-04 .319511947751E-04 .329901654910E-04 + .340629206980E-04 .351705589586E-04 .363142145555E-04 .374950586529E-04 .387143004951E-04 + .399731886447E-04 .412730122609E-04 .426151024191E-04 .440008334734E-04 .454316244639E-04 + .469089405685E-04 .484342946036E-04 .500092485720E-04 .516354152616E-04 .533144598965E-04 + .550481018409E-04 .568381163590E-04 .586863364318E-04 .605946546324E-04 .625650250632E-04 + .645994653551E-04 .667000587319E-04 .688689561416E-04 .711083784571E-04 .734206187480E-04 + .758080446262E-04 .782731006675E-04 .808183109118E-04 .834462814443E-04 .861597030606E-04 + .889613540173E-04 .918541028731E-04 .948409114207E-04 .979248377142E-04 .101109039194E-03 + .104396775914E-03 .107791413872E-03 .111296428448E-03 .114915407952E-03 .118652057294E-03 + .122510201760E-03 .126493790920E-03 .130606902659E-03 .134853747338E-03 .139238672088E-03 + .143766165242E-03 .148440860915E-03 .153267543723E-03 .158251153660E-03 .163396791131E-03 + .168709722144E-03 .174195383669E-03 .179859389171E-03 .185707534319E-03 .191745802874E-03 + .197980372773E-03 .204417622402E-03 .211064137063E-03 .217926715664E-03 .225012377598E-03 + .232328369866E-03 .239882174401E-03 .247681515644E-03 .255734368344E-03 .264048965612E-03 + .272633807228E-03 .281497668203E-03 .290649607612E-03 .300098977705E-03 .309855433294E-03 + .319928941443E-03 .330329791440E-03 .341068605095E-03 .352156347338E-03 .363604337150E-03 + .375424258823E-03 .387628173562E-03 .400228531432E-03 .413238183671E-03 .426670395356E-03 + .440538858462E-03 .454857705282E-03 .469641522262E-03 .484905364210E-03 .500664768938E-03 + .516935772296E-03 .533734923645E-03 .551079301749E-03 .568986531105E-03 .587474798722E-03 + .606562871331E-03 .626270113061E-03 .646616503561E-03 .667622656585E-03 .689309839028E-03 + .711699990427E-03 .734815742920E-03 .758680441650E-03 .783318165627E-03 .808753749025E-03 + .835012802915E-03 .862121737409E-03 .890107784211E-03 .918999019551E-03 .948824387471E-03 + .979613723446E-03 .101139777830E-02 .104420824237E-02 .107807776989E-02 .111304000356E-02 + .114912959911E-02 .118638225005E-02 .122483471218E-02 .126452482815E-02 .130549155155E-02 + .134777497086E-02 .139141633267E-02 .143645806444E-02 .148294379626E-02 .153091838171E-02 + .158042791736E-02 .163151976091E-02 .168424254740E-02 .173864620342E-02 .179478195889E-02 + .185270235589E-02 .191246125433E-02 .197411383369E-02 .203771659049E-02 .210332733071E-02 + .217100515649E-02 .224081044631E-02 .231280482772E-02 .238705114166E-02 .246361339709E-02 + .254255671485E-02 .262394725904E-02 .270785215452E-02 .279433938855E-02 .288347769449E-02 + .297533641527E-02 .306998534399E-02 .316749453861E-02 .326793410732E-02 .337137396094E-02 + .347788352781E-02 .358753142647E-02 .370038509052E-02 .381651033932E-02 .393597088755E-02 + .405882778553E-02 .418513878099E-02 .431495759219E-02 .444833308019E-02 .458530830718E-02 + .472591946529E-02 .487019465868E-02 .501815251889E-02 .516980063105E-02 .532513374505E-02 + .548413174236E-02 .564675732521E-02 .581295338964E-02 .598264003926E-02 .615571118988E-02 + .633203070846E-02 .651142802188E-02 .669369312193E-02 .687857088273E-02 .706575459498E-02 + .725487860842E-02 .744550995872E-02 .763713883827E-02 .782916775105E-02 .802089917058E-02 + .821152149574E-02 .840009307223E-02 .858552401783E-02 .876655555604E-02 .894173652625E-02 + .910939669822E-02 .926761647490E-02 .941419252015E-02 .954659879722E-02 .966194244997E-02 + .975691390319E-02 .982773050077E-02 .987007294359E-02 .987901373415E-02 .984893678510E-02 + .977344730712E-02 .964527106365E-02 .945614207061E-02 .919667783672E-02 .885624129362E-02 + .842278866608E-02 .788270269565E-02 .722061087326E-02 .641918867735E-02 .545894827979E-02 + .431801379800E-02 .297188497289E-02 .139319217287E-02 -.448553094467E-03 -.258720639694E-02 + -.506022962024E-02 -.790891121518E-02 -.111785546697E-01 -.149186192039E-01 -.191827929812E-01 + -.240289749478E-01 -.295191367867E-01 -.357190314954E-01 -.426977099021E-01 -.505268012579E-01 + -.592795092078E-01 -.690292703957E-01 -.798480203107E-01 -.918040104754E-01 -.104959123678E+00 + -.119365640755E+00 -.135052537078E+00 -.152079847668E+00 + ae wavefunction + -.536934453859E-05 -.554283679026E-05 -.572192904881E-05 -.590680169358E-05 -.609764089026E-05 + -.629463877488E-05 -.649799364359E-05 -.670791014832E-05 -.692459949849E-05 -.714827966909E-05 + -.737917561507E-05 -.761751949247E-05 -.786355088640E-05 -.811751704595E-05 -.837967312645E-05 + -.865028243916E-05 -.892961670862E-05 -.921795633789E-05 -.951559068196E-05 -.982281832946E-05 + -.101399473930E-04 -.104672958085E-04 -.108051916432E-04 -.111539734135E-04 -.115139904123E-04 + -.118856030458E-04 -.122691831813E-04 -.126651145043E-04 -.130737928877E-04 -.134956267708E-04 + -.139310375502E-04 -.143804599824E-04 -.148443425977E-04 -.153231481275E-04 -.158173539430E-04 + -.163274525071E-04 -.168539518402E-04 -.173973759985E-04 -.179582655672E-04 -.185371781670E-04 + -.191346889761E-04 -.197513912662E-04 -.203878969549E-04 -.210448371726E-04 -.217228628465E-04 + -.224226453000E-04 -.231448768698E-04 -.238902715395E-04 -.246595655907E-04 -.254535182727E-04 + -.262729124892E-04 -.271185555052E-04 -.279912796712E-04 -.288919431682E-04 -.298214307715E-04 + -.307806546346E-04 -.317705550946E-04 -.327921014965E-04 -.338462930403E-04 -.349341596486E-04 + -.360567628560E-04 -.372151967208E-04 -.384105887585E-04 -.396441008986E-04 -.409169304631E-04 + -.422303111689E-04 -.435855141531E-04 -.449838490212E-04 -.464266649193E-04 -.479153516296E-04 + -.494513406894E-04 -.510361065335E-04 -.526711676611E-04 -.543580878243E-04 -.560984772421E-04 + -.578939938353E-04 -.597463444862E-04 -.616572863188E-04 -.636286280026E-04 -.656622310770E-04 + -.677600112965E-04 -.699239399964E-04 -.721560454777E-04 -.744584144105E-04 -.768331932539E-04 + -.792825896932E-04 -.818088740907E-04 -.844143809508E-04 -.871015103953E-04 -.898727296496E-04 + -.927305745357E-04 -.956776509712E-04 -.987166364702E-04 -.101850281645E-03 -.105081411705E-03 + -.108412927949E-03 -.111847809248E-03 -.115389113513E-03 -.119039979150E-03 -.122803626483E-03 + -.126683359162E-03 -.130682565527E-03 -.134804719940E-03 -.139053384073E-03 -.143432208139E-03 + -.147944932068E-03 -.152595386619E-03 -.157387494410E-03 -.162325270874E-03 -.167412825110E-03 + -.172654360643E-03 -.178054176055E-03 -.183616665503E-03 -.189346319090E-03 -.195247723081E-03 + -.201325559962E-03 -.207584608305E-03 -.214029742439E-03 -.220665931907E-03 -.227498240686E-03 + -.234531826147E-03 -.241771937751E-03 -.249223915435E-03 -.256893187684E-03 -.264785269257E-03 + -.272905758533E-03 -.281260334465E-03 -.289854753099E-03 -.298694843630E-03 -.307786503967E-03 + -.317135695765E-03 -.326748438899E-03 -.336630805319E-03 -.346788912276E-03 -.357228914847E-03 + -.367956997739E-03 -.378979366308E-03 -.390302236747E-03 -.401931825406E-03 -.413874337166E-03 + -.426135952835E-03 -.438722815493E-03 -.451641015734E-03 -.464896575730E-03 -.478495432072E-03 + -.492443417301E-03 -.506746240072E-03 -.521409463873E-03 -.536438484230E-03 -.551838504315E-03 + -.567614508895E-03 -.583771236517E-03 -.600313149877E-03 -.617244404277E-03 -.634568814079E-03 + -.652289817096E-03 -.670410436812E-03 -.688933242371E-03 -.707860306229E-03 -.727193159410E-03 + -.746932744273E-03 -.767079364717E-03 -.787632633752E-03 -.808591418363E-03 -.829953781613E-03 + -.851716921913E-03 -.873877109413E-03 -.896429619485E-03 -.919368663237E-03 -.942687315069E-03 + -.966377437233E-03 -.990429601424E-03 -.101483300741E-02 -.103957539876E-02 -.106464297566E-02 + -.109002030507E-02 -.111569022805E-02 -.114163376471E-02 -.116783001666E-02 -.119425606737E-02 + -.122088688052E-02 -.124769519669E-02 -.127465142868E-02 -.130172355576E-02 -.132887701736E-02 + -.135607460649E-02 -.138327636352E-02 -.141043947082E-02 -.143751814883E-02 -.146446355430E-02 + -.149122368142E-02 -.151774326652E-02 -.154396369741E-02 -.156982292811E-02 -.159525539999E-02 + -.162019197054E-02 -.164455985064E-02 -.166828255181E-02 -.169127984444E-02 -.171346772851E-02 + -.173475841814E-02 -.175506034127E-02 -.177427815611E-02 -.179231278583E-02 -.180906147281E-02 + -.182441785436E-02 -.183827206105E-02 -.185051083943E-02 -.186101770044E-02 -.186967309504E-02 + -.187635461816E-02 -.188093724242E-02 -.188329358242E-02 -.188329419051E-02 -.188080788474E-02 + -.187570210923E-02 -.186784332698E-02 -.185709744495E-02 -.184333027040E-02 -.182640799755E-02 + -.180619772262E-02 -.178256798498E-02 -.175538933148E-02 -.172453490022E-02 -.168988101939E-02 + -.165130781581E-02 -.160869982728E-02 -.156194661142E-02 -.151094334343E-02 -.145559139361E-02 + -.139579887503E-02 -.133148115055E-02 -.126256128768E-02 -.118897044893E-02 -.111064820449E-02 + -.102754275349E-02 -.939611039582E-03 -.846818745856E-03 -.749140153709E-03 -.646557849671E-03 + -.539062263517E-03 -.426651020394E-03 -.309328089220E-03 -.187102709897E-03 -.599880838515E-04 + .720001825600E-04 .208845882540E-03 .350534246572E-03 .497054178393E-03 .648400632914E-03 + .804577064382E-03 .965597871782E-03 .113149078626E-02 .130229918063E-02 .147808432308E-02 + .165892762793E-02 .184493295336E-02 .203622894624E-02 .223297134696E-02 .243534507736E-02 + .264356588222E-02 .285788129106E-02 .307857069465E-02 .330594435780E-02 .354034119917E-02 + .378212515797E-02 .403167994363E-02 .428940193867E-02 .455569100166E-02 .483093890027E-02 + .511551509457E-02 .540974958539E-02 .571391254373E-02 .602819044082E-02 .635265840777E-02 + .668724856637E-02 .703171409088E-02 .738558878481E-02 .774814198662E-02 .811832865644E-02 + .849473454000E-02 .887551635833E-02 .925833702998E-02 .964029599629E-02 .100178547868E-01 + .103867580288E-01 .107419501671E-01 .110774882165E-01 .113864509092E-01 .116608446298E-01 + .118915065430E-01 .120680053329E-01 .121785399967E-01 .122098372057E-01 .121470479066E-01 + .119736441032E-01 .116713171792E-01 .112198796429E-01 .105971727185E-01 .977898257453E-02 + .873896786599E-02 .744860013681E-02 .587711563848E-02 .399147119709E-02 .175628797936E-02 + -.866239019038E-03 -.391647408054E-02 -.743746940754E-02 -.114749637066E-01 -.160771276901E-01 + -.212941062664E-01 -.271776042085E-01 -.337807161610E-01 -.411579574899E-01 -.493653243621E-01 + -.584602786172E-01 -.685016626504E-01 -.795495976261E-01 -.916654172796E-01 -.104911674326E+00 + -.119352243438E+00 -.135052537078E+00 -.152079847668E+00 + pseudo wavefunction + .291401328267E-08 .310660741021E-08 .331193054558E-08 .353082397944E-08 .376418460535E-08 + .401296859474E-08 .427819531469E-08 .456095150469E-08 .486239572944E-08 .518376312600E-08 + .552637046455E-08 .589162154379E-08 .628101294285E-08 .669614015334E-08 .713870411675E-08 + .761051819386E-08 .811351559483E-08 .864975730028E-08 .922144050602E-08 .983090762574E-08 + .104806558889E-07 .111733475729E-07 .119118209112E-07 .126991017233E-07 .135384158119E-07 + .144332021812E-07 .153871271269E-07 .164040992594E-07 .174882855184E-07 .186441282465E-07 + .198763633914E-07 .211900399110E-07 .225905404609E-07 .240836034492E-07 .256753465491E-07 + .273722917656E-07 .291813921584E-07 .311100603318E-07 .331661988066E-07 .353582324001E-07 + .376951427462E-07 .401865050959E-07 .428425275519E-07 .456740928944E-07 .486928031728E-07 + .519110272435E-07 .553419514499E-07 .589996336526E-07 .628990608296E-07 .670562104837E-07 + .714881161091E-07 .762129369843E-07 .812500325772E-07 .866200418695E-07 .923449679216E-07 + .984482680290E-07 .104954949835E-06 .111891673797E-06 .119286862426E-06 .127170816744E-06 + .135575840437E-06 .144536372221E-06 .154089126946E-06 .164273246033E-06 .175130457852E-06 + .186705248698E-06 .199045045072E-06 .212200408000E-06 .226225240208E-06 .241177006976E-06 + .257116971601E-06 .274110446410E-06 .292227060376E-06 .311541044413E-06 .332131535525E-06 + .354082901063E-06 .377485084413E-06 .402433973521E-06 .429031793789E-06 .457387526929E-06 + .487617357500E-06 .519845148962E-06 .554202951188E-06 .590831541524E-06 .629881001606E-06 + .671511332296E-06 .715893109266E-06 .763208181910E-06 .813650418444E-06 .867426500254E-06 + .924756768742E-06 .985876128147E-06 .105103500802E-05 .112050038933E-05 .119455689838E-05 + .127350797300E-05 .135767710584E-05 .144740916984E-05 .154307183128E-05 .164505705620E-05 + .175378271646E-05 .186969430185E-05 .199326674539E-05 .212500636934E-05 .226545295966E-05 + .241518197771E-05 .257480691811E-05 .274498182232E-05 .292640395847E-05 .311981667823E-05 + .332601246248E-05 .354583616833E-05 .378018849066E-05 .403002965244E-05 .429638333898E-05 + .458034089216E-05 .488306578181E-05 .520579837264E-05 .554986100620E-05 .591666341865E-05 + .630770851660E-05 .672459853464E-05 .716904159982E-05 .764285872985E-05 .814799129391E-05 + .868650896637E-05 .926061820619E-05 .987267129663E-05 .105251759823E-04 .112208057432E-04 + .119624107473E-04 .127530295272E-04 .135959014285E-04 .144944798800E-04 .154524465418E-04 + .164737263873E-04 .175625037821E-04 .187232396258E-04 .199606896253E-04 .212799237765E-04 + .226863471325E-04 .241857219440E-04 .257841912628E-04 .274883041044E-04 .293050422725E-04 + .312418489565E-04 .333066592171E-04 .355079324866E-04 .378546872150E-04 .403565378054E-04 + .430237339888E-04 .458672027984E-04 .488985933180E-04 .521303243834E-04 .555756354354E-04 + .592486407301E-04 .631643871285E-04 .673389157022E-04 .717893274054E-04 .765338530833E-04 + .815919281008E-04 .869842718977E-04 .927329727939E-04 .988615783914E-04 .105395191942E-03 + .112360575071E-03 .119786257283E-03 .127702652682E-03 .136142184401E-03 .145139417227E-03 + .154731198977E-03 .164956811193E-03 .175858129767E-03 .187479796156E-03 .199869399874E-03 + .213077673012E-03 .227158697560E-03 .242170126392E-03 .258173418790E-03 .275234091470E-03 + .293421986129E-03 .312811554584E-03 .333482162664E-03 .355518414075E-03 .379010495548E-03 + .404054544654E-03 .430753041771E-03 .459215227769E-03 .489557549103E-03 .521904132075E-03 + .556387288181E-03 .593148052553E-03 .632336757633E-03 .674113644380E-03 .718649513420E-03 + .766126418722E-03 .816738406546E-03 .870692302575E-03 .928208550323E-03 .989522104105E-03 + .105488338007E-02 .112455926899E-02 .119883421475E-02 .127801136268E-02 .136241378226E-02 + .145238576868E-02 .154829422848E-02 .165053015436E-02 .175951019478E-02 .187567832433E-02 + .199950762094E-02 .213150215675E-02 .227219900947E-02 .242217040155E-02 .258202597513E-02 + .275241521072E-02 .293402999840E-02 .312760737056E-02 .333393240565E-02 .355384131315E-02 + .378822470998E-02 .403803109964E-02 .430427056539E-02 .458801868954E-02 .489042071142E-02 + .521269593699E-02 .555614241356E-02 .592214188380E-02 .631216503324E-02 .672777704632E-02 + .717064348614E-02 .764253651345E-02 .814534146086E-02 .868106377808E-02 .925183636437E-02 + .985992730423E-02 .105077480221E-01 .111978618716E-01 .119329931739E-01 .127160367202E-01 + .135500677497E-01 .144383524159E-01 .153843587512E-01 .163917681354E-01 .174644872754E-01 + .186066606954E-01 .198226837362E-01 .211172160564E-01 .224951956216E-01 .239618531636E-01 + .255227270816E-01 .271836787499E-01 .289509081858E-01 .308309700202E-01 .328307896988E-01 + .349576798280E-01 .372193565604E-01 .396239558955E-01 .421800497506E-01 .448966616271E-01 + .477832816749E-01 .508498809210E-01 .541069243959E-01 .575653828518E-01 .612367427231E-01 + .651330139336E-01 .692667351008E-01 .736509756357E-01 .782993341711E-01 .832259326911E-01 + .884454056628E-01 .939728833996E-01 .998239688107E-01 .106014706613E+00 .112561544003E+00 + .119481281715E+00 .126791014304E+00 .134508058440E+00 .142649867935E+00 .151233934173E+00 + .160277670588E+00 .169798279848E+00 .179812602404E+00 .190336945154E+00 .201386889071E+00 + .212977074828E+00 .225120965693E+00 .237830587274E+00 .251116244142E+00 .264986213837E+00 + .279446419435E+00 .294500082568E+00 .310147359718E+00 .326384965564E+00 .343205788327E+00 + .360598503251E+00 .378547191656E+00 .397030974266E+00 .416023668739E+00 .435493482341E+00 + .455402751380E+00 .475707739190E+00 .496358503829E+00 .517298844985E+00 .538466336475E+00 + .559792445834E+00 .581202735295E+00 .602617128586E+00 .623950214870E+00 .645111544538E+00 + .666005851127E+00 .686533109442E+00 .706588312368E+00 .726060818994E+00 .744833096173E+00 + .762778647533E+00 .779758902369E+00 .795618827667E+00 .810181037401E+00 .823238213856E+00 + .834543737580E+00 .843795379495E+00 .850759109048E+00 + ae wavefunction + -.227639975927E-06 -.241553083020E-06 -.256238531448E-06 -.271743785200E-06 -.288119039224E-06 + -.305417391637E-06 -.323695026587E-06 -.343011408299E-06 -.363429487022E-06 -.385015917681E-06 + -.407841292027E-06 -.431980385198E-06 -.457512417605E-06 -.484521333149E-06 -.513096094823E-06 + -.543330998835E-06 -.575326008437E-06 -.609187108752E-06 -.645026683949E-06 -.682963918224E-06 + -.723125222119E-06 -.765644685826E-06 -.810664561235E-06 -.858335774579E-06 -.908818471664E-06 + -.962282597814E-06 -.101890851477E-05 -.107888765696E-05 -.114242322970E-05 -.120973095201E-05 + -.128103984706E-05 -.135659308322E-05 -.143664886909E-05 -.152148140599E-05 -.161138190170E-05 + -.170665964933E-05 -.180764317575E-05 -.191468146391E-05 -.202814525399E-05 -.214842842850E-05 + -.227594948673E-05 -.241115311447E-05 -.255451185510E-05 -.270652788873E-05 -.286773492636E-05 + -.303870022660E-05 -.322002674287E-05 -.341235540958E-05 -.361636757635E-05 -.383278759983E-05 + -.406238560344E-05 -.430598041586E-05 -.456444269986E-05 -.483869828392E-05 -.512973170970E-05 + -.543859000934E-05 -.576638672758E-05 -.611430620447E-05 -.648360813551E-05 -.687563242730E-05 + -.729180436770E-05 -.773364013080E-05 -.820275263846E-05 -.870085780133E-05 -.922978116380E-05 + -.979146497909E-05 -.103879757420E-04 -.110215122090E-04 -.116944139365E-04 -.124091703718E-04 + -.131684305304E-04 -.139750132996E-04 -.148319184057E-04 -.157423380908E-04 -.167096695415E-04 + -.177375281191E-04 -.188297614430E-04 -.199904643804E-04 -.212239950010E-04 -.225349915590E-04 + -.239283905651E-04 -.254094460215E-04 -.269837498904E-04 -.286572538768E-04 -.304362926072E-04 + -.323276082937E-04 -.343383769763E-04 -.364762364443E-04 -.387493159417E-04 -.411662677688E-04 + -.437363009004E-04 -.464692167451E-04 -.493754471826E-04 -.524660950179E-04 -.557529770072E-04 + -.592486696121E-04 -.629665576550E-04 -.669208860529E-04 -.711268148224E-04 -.756004775571E-04 + -.803590435918E-04 -.854207840798E-04 -.908051422247E-04 -.965328079196E-04 -.102625797063E-03 + -.109107535840E-03 -.116002950260E-03 -.123338561283E-03 -.131142585864E-03 -.139445044266E-03 + -.148277874034E-03 -.157675051007E-03 -.167672717809E-03 -.178309320241E-03 -.189625752061E-03 + -.201665508629E-03 -.214474849945E-03 -.228102973627E-03 -.242602198405E-03 -.258028158739E-03 + -.274440011195E-03 -.291900653263E-03 -.310476955313E-03 -.330240006432E-03 -.351265374934E-03 + -.373633384344E-03 -.397429405728E-03 -.422744167254E-03 -.449674081948E-03 -.478321594601E-03 + -.508795548883E-03 -.541211575720E-03 -.575692504072E-03 -.612368795275E-03 -.651379002161E-03 + -.692870254233E-03 -.736998770214E-03 -.783930399325E-03 -.833841192722E-03 -.886918006549E-03 + -.943359138131E-03 -.100337499686E-02 -.106718881141E-02 -.113503737486E-02 -.120717182952E-02 + -.128385849317E-02 -.136537972838E-02 -.145203485685E-02 -.154414112049E-02 -.164203469122E-02 + -.174607173112E-02 -.185662950504E-02 -.197410754735E-02 -.209892888474E-02 -.223154131687E-02 + -.237241875665E-02 -.252206263177E-02 -.268100334926E-02 -.284980182450E-02 -.302905107608E-02 + -.321937788792E-02 -.342144453961E-02 -.363595060592E-02 -.386363482621E-02 -.410527704411E-02 + -.436170021744E-02 -.463377249841E-02 -.492240938313E-02 -.522857592952E-02 -.555328904201E-02 + -.589761982068E-02 -.626269597230E-02 -.664970427950E-02 -.705989312401E-02 -.749457505857E-02 + -.795512942174E-02 -.844300498806E-02 -.895972264571E-02 -.950687809174E-02 -.100861445343E-01 + -.106992753895E-01 -.113481069581E-01 -.120345610684E-01 -.127606476645E-01 -.135284673243E-01 + -.143402136813E-01 -.151981757303E-01 -.161047399864E-01 -.170623924716E-01 -.180737204949E-01 + -.191414141916E-01 -.202682677838E-01 -.214571805211E-01 -.227111572555E-01 -.240333086037E-01 + -.254268506438E-01 -.268951040903E-01 -.284414928881E-01 -.300695421604E-01 -.317828754443E-01 + -.335852111384E-01 -.354803580901E-01 -.374722102372E-01 -.395647402230E-01 -.417619918931E-01 + -.440680715826E-01 -.464871380971E-01 -.490233912878E-01 -.516810591191E-01 -.544643831232E-01 + -.573776021360E-01 -.604249342075E-01 -.636105565785E-01 -.669385836182E-01 -.704130426186E-01 + -.740378473440E-01 -.778167692409E-01 -.817534062181E-01 -.858511489161E-01 -.901131443956E-01 + -.945422571848E-01 -.991410276437E-01 -.103911627616E+00 -.108855813361E+00 -.113974875783E+00 + -.119269587988E+00 -.124740150247E+00 -.130386132443E+00 -.136206414151E+00 -.142199122499E+00 + -.148361568035E+00 -.154690178833E+00 -.161180433171E+00 -.167826791131E+00 -.174622625584E+00 + -.181560153093E+00 -.188630365378E+00 -.195822962130E+00 -.203126286096E+00 -.210527261502E+00 + -.218011337039E+00 -.225562434682E+00 -.233162905552E+00 -.240793493705E+00 -.248433308057E+00 + -.256059801489E+00 -.263648754700E+00 -.271174260698E+00 -.278608704786E+00 -.285922735197E+00 + -.293085222036E+00 -.300063207002E+00 -.306821852678E+00 -.313324406286E+00 -.319532196442E+00 + -.325404680492E+00 -.330899553158E+00 -.335972915728E+00 -.340579493099E+00 -.344672879444E+00 + -.348205795003E+00 -.351130344271E+00 -.353398274261E+00 -.354961236692E+00 -.355771058893E+00 + -.355780026498E+00 -.354941178483E+00 -.353208612980E+00 -.350537801067E+00 -.346885905329E+00 + -.342212100159E+00 -.336477891180E+00 -.329647431712E+00 -.321687834653E+00 -.312569478552E+00 + -.302266306889E+00 -.290756119819E+00 -.278020857663E+00 -.264046875488E+00 -.248825207961E+00 + -.232351823470E+00 -.214627866128E+00 -.195659883790E+00 -.175460039600E+00 -.154046303832E+00 + -.131442622052E+00 -.107679054871E+00 -.827918840025E-01 -.568236791368E-01 -.298233205159E-01 + -.184597323164E-02 .270469885701E-01 .567881062803E-01 .873040050703E-01 .118515596879E+00 + .150338306883E+00 .182682313261E+00 .215452796875E+00 .248550212706E+00 .281870620849E+00 + .315306154149E+00 .348745752676E+00 .382076353569E+00 .415184746117E+00 .447960165155E+00 + .480297179596E+00 .512097397715E+00 .543267510319E+00 .573711993632E+00 .603322782157E+00 + .631972546868E+00 .659516791165E+00 .685802866227E+00 .710679504466E+00 .734002703277E+00 + .755638014234E+00 .775461066058E+00 .793357766636E+00 .809224792331E+00 .822970439701E+00 + .834515700400E+00 .843795379495E+00 .850759109048E+00 + pseudo wavefunction + .188259325656E-09 .200701836025E-09 .213966701744E-09 .228108274249E-09 .243184497194E-09 + .259257143867E-09 .276392070301E-09 .294659485112E-09 .314134237172E-09 .334896122293E-09 + .357030210184E-09 .380627193015E-09 .405783757020E-09 .432602978655E-09 .461194746947E-09 + .491676213752E-09 .524172273773E-09 .558816076302E-09 .595749570786E-09 .635124088452E-09 + .677100962369E-09 .721852188493E-09 .769561130406E-09 .820423270627E-09 .874647011580E-09 + .932454529506E-09 .994082684803E-09 .105978399254E-08 .112982765710E-08 .120450067525E-08 + .128410901202E-08 .136897885444E-08 .145945794800E-08 .155591702150E-08 .165875130612E-08 + .176838215480E-08 .188525876868E-08 .200986003770E-08 .214269650275E-08 .228431244760E-08 + .243528812901E-08 .259624215430E-08 .276783401601E-08 .295076679410E-08 .314579003675E-08 + .335370283154E-08 .357535707967E-08 .381166098646E-08 .406358278269E-08 .433215469178E-08 + .461847715923E-08 .492372336155E-08 .524914401326E-08 .559607249152E-08 .596593029951E-08 + .636023289086E-08 .678059587908E-08 .722874165731E-08 .770650645568E-08 .821584786499E-08 + .875885285776E-08 .933774633931E-08 .995490026410E-08 .106128433544E-07 .113142714617E-07 + .120620586123E-07 .128592687834E-07 .137091684574E-07 .146152400060E-07 .155811959585E-07 + .166109942135E-07 .177088542561E-07 .188792744464E-07 .201270504508E-07 .214572948920E-07 + .228754582969E-07 .243873514295E-07 .259991690995E-07 .277175155448E-07 .295494314911E-07 + .315024230005E-07 .335844922259E-07 .358041701992E-07 .381705517848E-07 .406933329453E-07 + .433828504679E-07 .462501243186E-07 .493069027933E-07 .525657106550E-07 .560399004512E-07 + .597437072231E-07 .636923068306E-07 .679018781323E-07 .723896692744E-07 .771740683610E-07 + .822746787944E-07 .877123995959E-07 .935095110327E-07 .996897659063E-07 .106278486872E-06 + .113302670191E-06 .120791096338E-06 .128774447922E-06 .137285435397E-06 .146358931079E-06 + .156032112024E-06 .166344612347E-06 .177338685603E-06 .189059377909E-06 .201554712490E-06 + .214875886441E-06 .229077480474E-06 .244217682537E-06 .260358526204E-06 .277566144822E-06 + .295911042451E-06 .315468382706E-06 .336318296692E-06 .358546211276E-06 .382243199059E-06 + .407506351473E-06 .434439176528E-06 .463152022837E-06 .493762531665E-06 .526396118840E-06 + .561186488509E-06 .598276180831E-06 .637817155864E-06 .679971416021E-06 .724911669647E-06 + .772822038440E-06 .823898811601E-06 .878351249803E-06 .936402442264E-06 .998290220443E-06 + .106426813207E-05 .113460647955E-05 .120959342687E-05 .128953617969E-05 .137476224337E-05 + .146562076397E-05 .156248395791E-05 .166574863599E-05 .177583782802E-05 .189320251473E-05 + .201832347399E-05 .215171324889E-05 .229391824580E-05 .244552097081E-05 .260714241377E-05 + .277944458969E-05 .296313324782E-05 .315896075937E-05 .336772919581E-05 .359029361017E-05 + .382756553466E-05 .408051670906E-05 .435018305473E-05 .463766891071E-05 .494415154892E-05 + .527088598687E-05 .561921011746E-05 .599055017661E-05 .638642657091E-05 .680846008894E-05 + .725837852142E-05 .773802371682E-05 .824935910117E-05 .879447769232E-05 .937561064095E-05 + .999513633285E-05 .106555900890E-04 .113596745027E-04 .121102704547E-04 .129104488515E-04 + .137634831326E-04 .146728625977E-04 .156423066068E-04 .166757797093E-04 .177775077628E-04 + .189519951060E-04 .202040428520E-04 .215387683771E-04 .229616260786E-04 .244784294863E-04 + .260953748122E-04 .278190660317E-04 .296565415935E-04 .316153028623E-04 .337033444036E-04 + .359291862279E-04 .383019081186E-04 .408311861731E-04 .435273316971E-04 .464013325996E-04 + .494648974426E-04 .527305023115E-04 .562114406801E-04 .599218764523E-04 .638769003772E-04 + .680925900398E-04 .725860736440E-04 .773755978153E-04 .824805996618E-04 .879217833433E-04 + .937212014151E-04 .999023412187E-04 .106490216612E-03 .113511465340E-03 .120994452360E-03 + .128969379448E-03 .137468401441E-03 .146525749442E-03 .156177861381E-03 .166463520291E-03 + .177424000698E-03 .189103223502E-03 .201547919779E-03 .214807803882E-03 .228935756279E-03 + .243988016516E-03 .260024386720E-03 .277108446041E-03 .295307776404E-03 .314694199941E-03 + .335344028437E-03 .357338325072E-03 .380763178723E-03 .405709990999E-03 .432275776138E-03 + .460563473773E-03 .490682274495E-03 .522747957989E-03 .556883243367E-03 .593218151151E-03 + .631890376108E-03 .673045669922E-03 .716838232348E-03 .763431109165E-03 .812996594826E-03 + .865716637226E-03 .921783241464E-03 .981398868826E-03 .104477682649E-02 .111214164262E-02 + .118372942048E-02 .125978816423E-02 .134057806758E-02 .142637175521E-02 .151745446512E-02 + .161412415806E-02 .171669153832E-02 .182547996737E-02 .194082524924E-02 .206307526326E-02 + .219258941639E-02 .232973788293E-02 .247490059520E-02 .262846594337E-02 .279082913687E-02 + .296239017320E-02 .314355135267E-02 .333471426917E-02 .353627619812E-02 .374862579194E-02 + .397213798232E-02 .420716797543E-02 .445404421192E-02 .471306014793E-02 .498446469549E-02 + .526845114184E-02 .556514434534E-02 .587458598281E-02 .619671759756E-02 .653136116924E-02 + .687819689722E-02 .723673785601E-02 .760630114682E-02 .798597513191E-02 .837458229890E-02 + .877063726069E-02 .917229935323E-02 .957731924895E-02 .998297895804E-02 .103860245445E-01 + .107825908400E-01 .111681173956E-01 .115372548753E-01 .118837610617E-01 .122003856210E-01 + .124787427655E-01 .127091709518E-01 .128805787801E-01 .129802763102E-01 .129937910905E-01 + .129046683256E-01 .126942547801E-01 .123414662634E-01 .118225388591E-01 .111107644916E-01 + .101762119689E-01 .898543534943E-02 .750117238625E-02 .568203694441E-02 .348221074715E-02 + .851141640091E-03 -.226674211916E-02 -.593228912367E-02 -.102118375499E-01 -.151773626963E-01 + -.209065329490E-01 -.274826407059E-01 -.349943660481E-01 -.435353202661E-01 -.532033034353E-01 + -.640991948492E-01 -.763253771158E-01 -.899835741667E-01 -.105171960694E+00 -.121981376528E+00 + -.140490455867E+00 -.160752140242E+00 -.182838197398E+00 + ae wavefunction + .329908017899E-08 .350070879538E-08 .371353032623E-08 .393823260492E-08 .417554304096E-08 + .442623111551E-08 .469111103129E-08 .497104452448E-08 .526694384922E-08 .557977494597E-08 + .591056080576E-08 .626038504303E-08 .663039569071E-08 .702180923184E-08 .743591488320E-08 + .787407914718E-08 .833775064943E-08 .882846528060E-08 .934785166202E-08 .989763695626E-08 + .104796530450E-07 .110958430977E-07 .117482685572E-07 .124391165681E-07 .131707078780E-07 + .139455052412E-07 .147661223583E-07 .156353333861E-07 .165560830548E-07 .175314974331E-07 + .185648953814E-07 .196598007399E-07 .208199552982E-07 .220493325979E-07 .233521526224E-07 + .247328974311E-07 .261963278005E-07 .277475009372E-07 .293917893326E-07 .311349008342E-07 + .329829000119E-07 .349422309040E-07 .370197412336E-07 .392227081895E-07 .415588658745E-07 + .440364345292E-07 .466641516475E-07 .494513051048E-07 .524077684326E-07 .555440383768E-07 + .588712748880E-07 .624013437039E-07 .661468616893E-07 .701212451142E-07 .743387610605E-07 + .788145821596E-07 .835648448764E-07 .886067115712E-07 .939584365812E-07 .996394365846E-07 + .105670365522E-06 .112073194371E-06 .118871296086E-06 .126089536039E-06 .133754368318E-06 + .141893938246E-06 .150538191549E-06 .159718990577E-06 .169470238034E-06 .179828008724E-06 + .190830689788E-06 .202519130018E-06 .214936798801E-06 .228129955327E-06 .242147828705E-06 + .257042809702E-06 .272870654832E-06 .289690703594E-06 .307566109690E-06 .326564087128E-06 + .346756172139E-06 .368218501929E-06 .391032111332E-06 .415283248495E-06 .441063710808E-06 + .468471202359E-06 .497609714270E-06 .528589929370E-06 .561529652727E-06 .596554269675E-06 + .633797233063E-06 .673400581564E-06 .715515490979E-06 .760302860615E-06 .807933936922E-06 + .858590976703E-06 .912467952376E-06 .969771301889E-06 .103072072606E-05 .109555003626E-05 + .116450805559E-05 .123785957678E-05 .131588638035E-05 .139888831671E-05 .148718445608E-05 + .158111431043E-05 .168103913172E-05 .178734329115E-05 .190043574433E-05 .202075158739E-05 + .214875370975E-05 .228493454907E-05 .242981795469E-05 .258396116581E-05 .274795691142E-05 + .292243563898E-05 .310806787948E-05 .330556675685E-05 .351569065019E-05 .373924601751E-05 + .397709039049E-05 .423013554987E-05 .449935089198E-05 .478576699710E-05 .509047941113E-05 + .541465265242E-05 .575952445644E-05 .612641027142E-05 .651670801861E-05 .693190313178E-05 + .737357389105E-05 .784339706665E-05 .834315388946E-05 .887473636521E-05 .944015395058E-05 + .100415406097E-04 .106811622710E-04 .113614247036E-04 .120848818358E-04 .128542445362E-04 + .136723898809E-04 .145423709291E-04 .154674270325E-04 .164509947032E-04 .174967190638E-04 + .186084659092E-04 .197903344043E-04 .210466704466E-04 .223820807216E-04 .238014474792E-04 + .253099440608E-04 .269130512058E-04 .286165741680E-04 .304266606703E-04 .323498197291E-04 + .343929413762E-04 .365633173085E-04 .388686624936E-04 .413171377592E-04 .439173733939E-04 + .466784937828E-04 .496101431055E-04 .527225121145E-04 .560263660175E-04 .595330734786E-04 + .632546367534E-04 .672037229692E-04 .713936965562E-04 .758386528320E-04 .805534527382E-04 + .855537587174E-04 .908560717189E-04 .964777693090E-04 .102437144857E-03 .108753447759E-03 + .115446924650E-03 .122538861549E-03 .130051626865E-03 .138008715186E-03 .146434791756E-03 + .155355737528E-03 .164798694679E-03 .174792112435E-03 .185365793069E-03 .196550937879E-03 + .208380192963E-03 .220887694586E-03 .234109113894E-03 .248081700728E-03 .262844326268E-03 + .278437524200E-03 .294903530092E-03 .312286318645E-03 .330631638438E-03 .349987043795E-03 + .370401923370E-03 .391927525004E-03 .414616976437E-03 .438525301396E-03 .463709430588E-03 + .490228207127E-03 .518142385893E-03 .547514626344E-03 .578409478292E-03 .610893360173E-03 + .645034529359E-03 .680903044093E-03 .718570716657E-03 .758111057440E-03 .799599209646E-03 + .843111874437E-03 .888727226421E-03 .936524819495E-03 .986585483195E-03 .103899120984E-02 + .109382503292E-02 .115117089748E-02 .121111352320E-02 .127373826159E-02 .133913094834E-02 + .140737775294E-02 .147856502718E-02 .155277915525E-02 .163010640797E-02 .171063280434E-02 + .179444398399E-02 .188162509437E-02 .197226069717E-02 .206643469870E-02 .216423030948E-02 + .226573003870E-02 .237101572979E-02 .248016864360E-02 .259326959640E-02 .271039916068E-02 + .283163793710E-02 .295706690745E-02 .308676787920E-02 .322082403378E-02 .335932059220E-02 + .350234561239E-02 .364999093291E-02 .380235327479E-02 .395953550720E-02 .412164806889E-02 + .428881051644E-02 .446115314045E-02 .463881855679E-02 .482196315214E-02 .501075825528E-02 + .520539093344E-02 .540606438254E-02 .561299798267E-02 .582642719909E-02 .604660358714E-02 + .627379516452E-02 .650828731395E-02 .675038417942E-02 .700041028844E-02 .725871197647E-02 + .752565817955E-02 .780164027316E-02 .808707077981E-02 .838238086423E-02 .868801655628E-02 + .900443360736E-02 .933209082854E-02 .967144170169E-02 .100229240120E-01 .103869472209E-01 + .107638772809E-01 .111540185848E-01 .115575927342E-01 .119747138083E-01 .124053598104E-01 + .128493399678E-01 .133062575600E-01 .137754679559E-01 .142560315452E-01 .147466612667E-01 + .152456644480E-01 .157508787005E-01 .162596016357E-01 .167685142012E-01 .172735974648E-01 + .177700427009E-01 .182521546525E-01 .187132478523E-01 .191455358726E-01 .195400133505E-01 + .198863305955E-01 .201726605474E-01 .203855578566E-01 .205098099183E-01 .205282799298E-01 + .204217424344E-01 .201687124905E-01 .197452704861E-01 .191248856466E-01 .182782422416E-01 + .171730730409E-01 .157740040676E-01 .140424119477E-01 .119362882257E-01 .941009223694E-02 + .641455956391E-02 .289643672970E-02 -.120182972349E-02 -.594230845433E-02 -.113915061558E-01 + -.176199584845E-01 -.247017208792E-01 -.327140327375E-01 -.417371826148E-01 -.518544026197E-01 + -.631516436073E-01 -.757171941354E-01 -.896411710603E-01 -.105014918512E+00 -.121930338317E+00 + -.140479159189E+00 -.160752140242E+00 -.182838197398E+00 + End of Dataset diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/INCAR b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/INCAR new file mode 100644 index 000000000..1a9f52780 --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/INCAR @@ -0,0 +1,21 @@ +ADDGRID = True +ALGO = Normal +EDIFF = 1e-08 +ENCUT = 700 +IBRION = -1 +ICHARG = 0 +ISIF = 3 +ISMEAR = 0 +ISPIN = 2 +LAECHG = False +LASPH = True +LCHARG = False +LORBIT = 11 +LREAL = False +LVHAR = True +LWAVE = False +MAGMOM = 128*0.6 +NELM = 100 +NSW = 0 +PREC = Accurate +SIGMA = 0.05 diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/KPOINTS b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/KPOINTS new file mode 100644 index 000000000..6677fab59 --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/KPOINTS @@ -0,0 +1,4 @@ +pymatgen v2020.1.28 with grid density = 1239 / atom +0 +Monkhorst +2 2 2 diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POSCAR b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POSCAR new file mode 100644 index 000000000..eb785ce7e --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POSCAR @@ -0,0 +1,136 @@ +Si128 +1.0 +15.360792 0.000000 0.000000 +7.680396 13.302841 0.000000 +0.000000 -8.868554 12.542036 +Si +128 +direct +0.004419 -0.000206 -0.000856 Si +0.001716 -0.001367 0.250994 Si +0.002871 -0.004453 0.496571 Si +0.000199 0.001004 0.750643 Si +-0.000672 0.253464 0.002350 Si +-0.003594 0.251178 0.252602 Si +0.000081 0.250947 0.503137 Si +0.000449 0.249353 0.751900 Si +0.002693 0.497479 -0.004425 Si +0.000960 0.496715 0.245595 Si +-0.000752 0.502784 0.499361 Si +-0.007283 0.500032 0.753217 Si +0.003741 0.749200 -0.000740 Si +-0.001400 0.749737 0.250047 Si +0.000132 0.751798 0.500399 Si +-0.001588 0.750422 0.746906 Si +0.252396 -0.000527 -0.001692 Si +0.247616 0.000719 0.246260 Si +0.251735 -0.000509 0.501759 Si +0.250663 -0.002549 0.746700 Si +0.243529 0.250402 -0.003080 Si +0.248591 0.253497 0.252598 Si +0.251067 0.251146 0.501087 Si +0.253028 0.248259 0.748963 Si +0.252229 0.497433 -0.005447 Si +0.255737 0.495567 0.247760 Si +0.256858 0.498454 0.497979 Si +0.250017 0.494558 0.749618 Si +0.253598 0.748814 -0.002255 Si +0.249361 0.748185 0.249731 Si +0.249074 0.745734 0.495905 Si +0.245320 0.751543 0.750463 Si +0.500627 0.004722 0.006082 Si +0.500585 0.000886 0.248733 Si +0.500080 -0.004574 0.496196 Si +0.500977 0.001687 0.752934 Si +0.500895 0.249757 -0.001718 Si +0.497767 0.250410 0.249989 Si +0.502624 0.252356 0.504582 Si +0.502054 0.251831 0.748284 Si +0.502678 0.496720 -0.003033 Si +0.502103 0.496828 0.249518 Si +0.498530 0.497817 0.499945 Si +0.501845 0.497086 0.747815 Si +0.499688 0.749119 -0.001771 Si +0.498626 0.756874 0.251304 Si +0.495511 0.752555 0.501879 Si +0.501056 0.750903 0.751113 Si +0.751824 -0.001653 0.003010 Si +0.752569 -0.006292 0.250890 Si +0.749700 0.000960 0.501732 Si +0.747081 0.001600 0.753815 Si +0.749716 0.250449 0.002061 Si +0.747165 0.254844 0.249754 Si +0.747741 0.250044 0.499631 Si +0.749158 0.252723 0.750535 Si +0.753785 0.498736 0.000233 Si +0.750250 0.507911 0.255749 Si +0.748354 0.500599 0.498820 Si +0.752714 0.493600 0.743093 Si +0.746217 0.749203 -0.002251 Si +0.755075 0.749992 0.247867 Si +0.749259 0.752119 0.502124 Si +0.747662 0.751824 0.753020 Si +0.186204 0.127200 0.188827 Si +0.188356 0.124138 0.439900 Si +0.185286 0.125426 0.687308 Si +0.189301 0.124669 0.937938 Si +0.189908 0.371564 0.189809 Si +0.186088 0.377527 0.439945 Si +0.185459 0.374256 0.687623 Si +0.187870 0.377619 0.940800 Si +0.183809 0.631022 0.188910 Si +0.189650 0.622139 0.437493 Si +0.188741 0.628350 0.687871 Si +0.186295 0.627701 0.938973 Si +0.185553 0.876714 0.187931 Si +0.188614 0.875100 0.437290 Si +0.190809 0.873341 0.688654 Si +0.187579 0.873076 0.940127 Si +0.438747 0.121582 0.186361 Si +0.435186 0.124894 0.434709 Si +0.436347 0.125254 0.684250 Si +0.440967 0.123474 0.936608 Si +0.439668 0.372737 0.189247 Si +0.430693 0.376971 0.439410 Si +0.437890 0.373999 0.686350 Si +0.436376 0.378937 0.937187 Si +0.436937 0.627062 0.189243 Si +0.437285 0.629181 0.440075 Si +0.439976 0.622246 0.687670 Si +0.431227 0.628216 0.940327 Si +0.434018 0.876606 0.185760 Si +0.438422 0.872462 0.436441 Si +0.436000 0.875639 0.686955 Si +0.434784 0.877715 0.941421 Si +0.687436 0.121554 0.185661 Si +0.685953 0.124306 0.438298 Si +0.689755 0.119176 0.687189 Si +0.686332 0.128397 0.936948 Si +0.686764 0.378560 0.190140 Si +0.689784 0.379171 0.436946 Si +0.686554 0.380682 0.688244 Si +0.686129 0.374762 0.936997 Si +0.687256 0.620816 0.184061 Si +0.686313 0.628028 0.439813 Si +0.687753 0.626497 0.688568 Si +0.685704 0.628037 0.937508 Si +0.686470 0.877937 0.186396 Si +0.686007 0.878400 0.438826 Si +0.687927 0.872425 0.690325 Si +0.685678 0.873399 0.937346 Si +0.939966 0.121715 0.184463 Si +0.938280 0.125985 0.439959 Si +0.935714 0.125861 0.688139 Si +0.941256 0.121740 0.934856 Si +0.940509 0.370740 0.184174 Si +0.934583 0.375952 0.438550 Si +0.933805 0.375006 0.691141 Si +0.939116 0.373552 0.936880 Si +0.938269 0.626982 0.190164 Si +0.944814 0.622757 0.438232 Si +0.935640 0.629382 0.687222 Si +0.933990 0.629804 0.937675 Si +0.935086 0.877005 0.189286 Si +0.938269 0.874576 0.437978 Si +0.939148 0.875524 0.684622 Si +0.935925 0.874399 0.934462 Si diff --git a/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POTCAR b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POTCAR new file mode 100644 index 000000000..ae2291fdf --- /dev/null +++ b/atomate/vasp/test_files/lattice_dynamics_wf/0/outputs/POTCAR @@ -0,0 +1,1768 @@ + PAW_PBE Si 05Jan2001 + 4.00000000000000000 + parameters from PSCTR are: + VRHFIN =Si: s2p2 + LEXCH = PE + EATOM = 103.0669 eV, 7.5752 Ry + + TITEL = PAW_PBE Si 05Jan2001 + LULTRA = F use ultrasoft PP ? + IUNSCR = 1 unscreen: 0-lin 1-nonlin 2-no + RPACOR = 1.500 partial core radius + POMASS = 28.085; ZVAL = 4.000 mass and valenz + RCORE = 1.900 outmost cutoff radius + RWIGS = 2.480; RWIGS = 1.312 wigner-seitz radius (au A) + ENMAX = 245.345; ENMIN = 184.009 eV + ICORE = 2 local potential + LCOR = T correct aug charges + LPAW = T paw PP + EAUG = 322.069 + DEXC = -.007 + RMAX = 2.944 core radius for proj-oper + RAUG = 1.300 factor for augmentation sphere + RDEP = 1.993 radius for radial grids + QCUT = -4.246; QGAM = 8.493 optimization parameters + + Description + l E TYP RCUT TYP RCUT + 0 .000 23 1.900 + 0 .000 23 1.900 + 1 .000 23 1.900 + 1 .000 23 1.900 + 2 .000 7 1.900 + Error from kinetic energy argument (eV) + NDATA = 100 + STEP = 20.000 1.050 + 10.1 9.04 8.56 7.65 7.23 6.44 5.73 5.40 + 4.79 4.25 4.00 3.54 3.13 2.77 2.45 2.16 + 1.91 1.69 1.50 1.24 1.10 .975 .812 .718 + .636 .529 .440 .388 .322 .266 .219 .180 + .148 .121 .986E-01 .804E-01 .614E-01 .504E-01 .392E-01 .328E-01 + .265E-01 .220E-01 .189E-01 .166E-01 .149E-01 .135E-01 .123E-01 .109E-01 + .977E-02 .840E-02 .707E-02 .605E-02 .488E-02 .387E-02 .290E-02 .229E-02 + .185E-02 .152E-02 .134E-02 .125E-02 .121E-02 .117E-02 .112E-02 .102E-02 + .915E-03 .776E-03 .640E-03 .524E-03 .425E-03 .369E-03 .331E-03 .310E-03 + .294E-03 .273E-03 .242E-03 .210E-03 .175E-03 .146E-03 .124E-03 .113E-03 + .105E-03 .973E-04 .879E-04 .755E-04 .633E-04 .539E-04 .478E-04 .438E-04 + .404E-04 .362E-04 .308E-04 .264E-04 .229E-04 .209E-04 .192E-04 .170E-04 + .145E-04 .126E-04 .112E-04 .103E-04 +END of PSCTR-controll parameters + local part + 98.2657514061040160 + .84157696E+01 .84210616E+01 .84276868E+01 .84387430E+01 .84542501E+01 + .84742336E+01 .84987229E+01 .85277486E+01 .85613410E+01 .85995276E+01 + .86423322E+01 .86897735E+01 .87418643E+01 .87986117E+01 .88600162E+01 + .89260725E+01 .89967686E+01 .90720854E+01 .91519966E+01 .92364669E+01 + .93254512E+01 .94188926E+01 .95167214E+01 .96188530E+01 .97251866E+01 + .98356042E+01 .99499691E+01 .10068126E+02 .10189900E+02 .10315095E+02 + .10443498E+02 .10574872E+02 .10708964E+02 .10845497E+02 .10984178E+02 + .11124691E+02 .11266702E+02 .11409858E+02 .11553785E+02 .11698096E+02 + .11842382E+02 .11986223E+02 .12129182E+02 .12270810E+02 .12410650E+02 + .12548232E+02 .12683081E+02 .12814718E+02 .12942658E+02 .13066416E+02 + .13185509E+02 .13299456E+02 .13407780E+02 .13510014E+02 .13605699E+02 + .13694388E+02 .13775652E+02 .13849074E+02 .13914259E+02 .13970835E+02 + .14018449E+02 .14056778E+02 .14085523E+02 .14104415E+02 .14113216E+02 + .14111719E+02 .14099752E+02 .14077176E+02 .14043889E+02 .13999825E+02 + .13944955E+02 .13879288E+02 .13802872E+02 .13715793E+02 .13618173E+02 + .13510175E+02 .13391996E+02 .13263872E+02 .13126073E+02 .12978903E+02 + .12822702E+02 .12657838E+02 .12484712E+02 .12303753E+02 .12115415E+02 + .11920177E+02 .11718543E+02 .11511033E+02 .11298186E+02 .11080557E+02 + .10858712E+02 .10633228E+02 .10404688E+02 .10173679E+02 .99407918E+01 + .97066146E+01 .94717325E+01 .92367246E+01 .90021609E+01 .87686001E+01 + .85365874E+01 .83066514E+01 .80793026E+01 .78550308E+01 .76343035E+01 + .74175636E+01 .72052280E+01 .69976861E+01 .67952984E+01 .65983952E+01 + .64072758E+01 .62222076E+01 .60434252E+01 .58711303E+01 .57054911E+01 + .55466426E+01 .53946862E+01 .52496902E+01 .51116906E+01 .49806911E+01 + .48566645E+01 .47395534E+01 .46292712E+01 .45257038E+01 .44287105E+01 + .43381258E+01 .42537607E+01 .41754049E+01 .41028282E+01 .40357822E+01 + .39740031E+01 .39172124E+01 .38651203E+01 .38174267E+01 .37738238E+01 + .37339979E+01 .36976315E+01 .36644056E+01 .36340010E+01 .36061008E+01 + .35803917E+01 .35565663E+01 .35343243E+01 .35133745E+01 .34934357E+01 + .34742388E+01 .34555274E+01 .34370596E+01 .34186083E+01 .33999627E+01 + .33809285E+01 .33613290E+01 .33410052E+01 .33198164E+01 .32976401E+01 + .32743723E+01 .32499276E+01 .32242387E+01 .31972561E+01 .31689481E+01 + .31393000E+01 .31083133E+01 .30760055E+01 .30424087E+01 .30075693E+01 + .29715463E+01 .29344112E+01 .28962459E+01 .28571426E+01 .28172018E+01 + .27765317E+01 .27352466E+01 .26934662E+01 .26513138E+01 .26089155E+01 + .25663991E+01 .25238927E+01 .24815236E+01 .24394173E+01 .23976966E+01 + .23564804E+01 .23158831E+01 .22760134E+01 .22369739E+01 .21988600E+01 + .21617599E+01 .21257533E+01 .20909116E+01 .20572974E+01 .20249638E+01 + .19939548E+01 .19643045E+01 .19360379E+01 .19091701E+01 .18837069E+01 + .18596450E+01 .18369720E+01 .18156670E+01 .17957010E+01 .17770368E+01 + .17596305E+01 .17434311E+01 .17283816E+01 .17144193E+01 .17014768E+01 + .16894823E+01 .16783607E+01 .16680338E+01 .16584212E+01 .16494415E+01 + .16410120E+01 .16330504E+01 .16254746E+01 .16182040E+01 .16111597E+01 + .16042653E+01 .15974473E+01 .15906355E+01 .15837638E+01 .15767703E+01 + .15695978E+01 .15621941E+01 .15545123E+01 .15465111E+01 .15381544E+01 + .15294125E+01 .15202610E+01 .15106817E+01 .15006619E+01 .14901947E+01 + .14792788E+01 .14679182E+01 .14561221E+01 .14439046E+01 .14312844E+01 + .14182846E+01 .14049321E+01 .13912574E+01 .13772942E+01 .13630791E+01 + .13486509E+01 .13340503E+01 .13193195E+01 .13045019E+01 .12896412E+01 + .12747815E+01 .12599666E+01 .12452397E+01 .12306428E+01 .12162167E+01 + .12020006E+01 .11880314E+01 .11743437E+01 .11609697E+01 .11479386E+01 + .11352766E+01 .11230067E+01 .11111486E+01 .10997186E+01 .10887293E+01 + .10781902E+01 .10681067E+01 .10584813E+01 .10493127E+01 .10405964E+01 + .10323246E+01 .10244865E+01 .10170685E+01 .10100542E+01 .10034245E+01 + .99715846E+00 .99123280E+00 .98562260E+00 .98030145E+00 .97524173E+00 + .97041488E+00 .96579171E+00 .96134265E+00 .95703806E+00 .95284844E+00 + .94874473E+00 .94469858E+00 .94068254E+00 .93667031E+00 .93263696E+00 + .92855909E+00 .92441506E+00 .92018509E+00 .91585142E+00 .91139842E+00 + .90681263E+00 .90208291E+00 .89720039E+00 .89215854E+00 .88695315E+00 + .88158229E+00 .87604630E+00 .87034770E+00 .86449110E+00 .85848313E+00 + .85233229E+00 .84604884E+00 .83964465E+00 .83313300E+00 .82652847E+00 + .81984671E+00 .81310428E+00 .80631845E+00 .79950703E+00 .79268813E+00 + .78588003E+00 .77910097E+00 .77236895E+00 .76570159E+00 .75911593E+00 + .75262828E+00 .74625407E+00 .74000773E+00 .73390251E+00 .72795041E+00 + .72216209E+00 .71654675E+00 .71111209E+00 .70586428E+00 .70080787E+00 + .69594584E+00 .69127954E+00 .68680877E+00 .68253173E+00 .67844513E+00 + .67454418E+00 .67082274E+00 .66727331E+00 .66388721E+00 .66065462E+00 + .65756473E+00 .65460586E+00 .65176555E+00 .64903076E+00 .64638795E+00 + .64382325E+00 .64132257E+00 .63887178E+00 .63645678E+00 .63406371E+00 + .63167900E+00 .62928956E+00 .62688288E+00 .62444710E+00 .62197118E+00 + .61944494E+00 .61685919E+00 .61420575E+00 .61147755E+00 .60866866E+00 + .60577434E+00 .60279104E+00 .59971643E+00 .59654939E+00 .59329003E+00 + .58993961E+00 .58650056E+00 .58297643E+00 .57937181E+00 .57569230E+00 + .57194440E+00 .56813547E+00 .56427363E+00 .56036764E+00 .55642683E+00 + .55246099E+00 .54848026E+00 .54449503E+00 .54051583E+00 .53655322E+00 + .53261771E+00 .52871961E+00 .52486898E+00 .52107551E+00 .51734843E+00 + .51369641E+00 .51012750E+00 .50664907E+00 .50326768E+00 .49998911E+00 + .49681824E+00 .49375908E+00 .49081468E+00 .48798715E+00 .48527763E+00 + .48268632E+00 .48021244E+00 .47785431E+00 .47560930E+00 .47347392E+00 + .47144387E+00 .46951402E+00 .46767855E+00 .46593095E+00 .46426412E+00 + .46267047E+00 .46114194E+00 .45967012E+00 .45824632E+00 .45686169E+00 + .45550723E+00 .45417395E+00 .45285292E+00 .45153535E+00 .45021267E+00 + .44887661E+00 .44751931E+00 .44613331E+00 .44471171E+00 .44324816E+00 + .44173692E+00 .44017295E+00 .43855190E+00 .43687017E+00 .43512491E+00 + .43331405E+00 .43143631E+00 .42949120E+00 .42747899E+00 .42540073E+00 + .42325823E+00 .42105400E+00 .41879126E+00 .41647384E+00 .41410622E+00 + .41169341E+00 .40924089E+00 .40675462E+00 .40424088E+00 .40170629E+00 + .39915769E+00 .39660209E+00 .39404660E+00 .39149835E+00 .38896445E+00 + .38645189E+00 .38396749E+00 .38151784E+00 .37910923E+00 .37674758E+00 + .37443844E+00 .37218685E+00 .36999739E+00 .36787409E+00 .36582039E+00 + .36383915E+00 .36193261E+00 .36010239E+00 .35834945E+00 .35667414E+00 + .35507613E+00 .35355450E+00 .35210772E+00 .35073362E+00 .34942953E+00 + .34819219E+00 .34701788E+00 .34590241E+00 .34484117E+00 .34382921E+00 + .34286125E+00 .34193178E+00 .34103506E+00 .34016522E+00 .33931629E+00 + .33848229E+00 .33765725E+00 .33683525E+00 .33601054E+00 .33517754E+00 + .33433091E+00 .33346559E+00 .33257683E+00 .33166028E+00 .33071198E+00 + .32972841E+00 .32870651E+00 .32764370E+00 .32653791E+00 .32538758E+00 + .32419168E+00 .32294968E+00 .32166161E+00 .32032797E+00 .31894980E+00 + .31752862E+00 .31606640E+00 .31456556E+00 .31302895E+00 .31145977E+00 + .30986158E+00 .30823823E+00 .30659385E+00 .30493275E+00 .30325946E+00 + .30157859E+00 .29989486E+00 .29821301E+00 .29653778E+00 .29487386E+00 + .29322581E+00 .29159807E+00 .28999490E+00 .28842031E+00 .28687807E+00 + .28537164E+00 .28390415E+00 .28247839E+00 .28109677E+00 .27976132E+00 + .27847363E+00 .27723491E+00 .27604592E+00 .27490700E+00 .27381809E+00 + .27277867E+00 .27178784E+00 .27084428E+00 .26994630E+00 .26909186E+00 + .26827855E+00 .26750369E+00 .26676430E+00 .26605715E+00 .26537882E+00 + .26472568E+00 .26409398E+00 .26347988E+00 .26287945E+00 .26228874E+00 + .26170381E+00 .26112076E+00 .26053579E+00 .25994520E+00 .25934545E+00 + .25873320E+00 .25810531E+00 .25745888E+00 .25679129E+00 .25610022E+00 + .25538363E+00 .25463983E+00 .25386744E+00 .25306545E+00 .25223318E+00 + .25137030E+00 .25047684E+00 .24955316E+00 .24859996E+00 .24761829E+00 + .24660949E+00 .24557519E+00 .24451731E+00 .24343801E+00 .24233971E+00 + .24122498E+00 .24009659E+00 .23895746E+00 .23781060E+00 .23665912E+00 + .23550617E+00 .23435492E+00 .23320855E+00 .23207016E+00 .23094281E+00 + .22982945E+00 .22873289E+00 .22765579E+00 .22660063E+00 .22556967E+00 + .22456498E+00 .22358834E+00 .22264131E+00 .22172517E+00 .22084092E+00 + .21998928E+00 .21917068E+00 .21838526E+00 .21763287E+00 .21691308E+00 + .21622517E+00 .21556818E+00 .21494086E+00 .21434175E+00 .21376913E+00 + .21322111E+00 .21269560E+00 .21219035E+00 .21170297E+00 .21123098E+00 + .21077179E+00 .21032276E+00 .20988120E+00 .20944443E+00 .20900979E+00 + .20857462E+00 .20813639E+00 .20769262E+00 .20724095E+00 .20677916E+00 + .20630522E+00 .20581722E+00 .20531350E+00 .20479256E+00 .20425315E+00 + .20369424E+00 .20311502E+00 .20251496E+00 .20189372E+00 .20125124E+00 + .20058769E+00 .19990349E+00 .19919926E+00 .19847589E+00 .19773443E+00 + .19697618E+00 .19620258E+00 .19541527E+00 .19461602E+00 .19380673E+00 + .19298941E+00 .19216618E+00 .19133918E+00 .19051063E+00 .18968276E+00 + .18885780E+00 .18803797E+00 .18722542E+00 .18642227E+00 .18563052E+00 + .18485209E+00 .18408877E+00 .18334220E+00 .18261388E+00 .18190512E+00 + .18121707E+00 .18055068E+00 .17990670E+00 .17928569E+00 .17868800E+00 + .17811376E+00 .17756291E+00 .17703518E+00 .17653009E+00 .17604697E+00 + .17558497E+00 .17514306E+00 .17472002E+00 .17431452E+00 .17392507E+00 + .17355005E+00 .17318776E+00 .17283640E+00 .17249410E+00 .17215895E+00 + .17182901E+00 .17150232E+00 .17117693E+00 .17085094E+00 .17052245E+00 + .17018966E+00 .16985084E+00 .16950435E+00 .16914867E+00 .16878242E+00 + .16840433E+00 .16801331E+00 .16760841E+00 .16718886E+00 .16675406E+00 + .16630358E+00 .16583717E+00 .16535477E+00 .16485650E+00 .16434264E+00 + .16381366E+00 .16327018E+00 .16271301E+00 .16214308E+00 .16156147E+00 + .16096939E+00 .16036817E+00 .15975923E+00 .15914407E+00 .15852427E+00 + .15790145E+00 .15727728E+00 .15665345E+00 .15603163E+00 .15541350E+00 + .15480071E+00 .15419486E+00 .15359747E+00 .15301002E+00 .15243388E+00 + .15187030E+00 .15132044E+00 .15078533E+00 .15026585E+00 .14976275E+00 + .14927662E+00 .14880791E+00 .14835691E+00 .14792374E+00 .14750838E+00 + .14711065E+00 .14673019E+00 .14636653E+00 .14601903E+00 .14568691E+00 + .14536927E+00 .14506509E+00 .14477325E+00 .14449251E+00 .14422157E+00 + .14395905E+00 .14370352E+00 .14345350E+00 .14320750E+00 .14296399E+00 + .14272149E+00 .14247848E+00 .14223350E+00 .14198515E+00 .14173206E+00 + .14147294E+00 .14120659E+00 .14093190E+00 .14064788E+00 .14035363E+00 + .14004840E+00 .13973155E+00 .13940258E+00 .13906112E+00 .13870694E+00 + .13833997E+00 .13796025E+00 .13756799E+00 .13716350E+00 .13674725E+00 + .13631982E+00 .13588193E+00 .13543440E+00 .13497814E+00 .13451417E+00 + .13404360E+00 .13356759E+00 .13308736E+00 .13260419E+00 .13211937E+00 + .13163425E+00 .13115013E+00 .13066836E+00 .13019023E+00 .12971703E+00 + .12924998E+00 .12879027E+00 .12833900E+00 .12789721E+00 .12746584E+00 + .12704575E+00 .12663767E+00 .12624224E+00 .12585999E+00 .12549130E+00 + .12513646E+00 .12479563E+00 .12446883E+00 .12415596E+00 .12385682E+00 + .12357106E+00 .12329824E+00 .12303778E+00 .12278902E+00 .12255119E+00 + .12232344E+00 .12210482E+00 .12189434E+00 .12169092E+00 .12149346E+00 + .12130080E+00 .12111176E+00 .12092515E+00 .12073978E+00 .12055446E+00 + .12036801E+00 .12017930E+00 .11998723E+00 .11979076E+00 .11958890E+00 + .11938073E+00 .11916544E+00 .11894226E+00 .11871055E+00 .11846975E+00 + .11821943E+00 .11795923E+00 .11768892E+00 .11740838E+00 .11711760E+00 + .11681667E+00 .11650581E+00 .11618532E+00 .11585561E+00 .11551720E+00 + .11517070E+00 .11481679E+00 .11445623E+00 .11408986E+00 .11371858E+00 + .11334333E+00 .11296511E+00 .11258491E+00 .11220379E+00 .11182279E+00 + .11144296E+00 .11106534E+00 .11069096E+00 .11032079E+00 .10995580E+00 + .10959689E+00 .10924491E+00 .10890064E+00 .10856478E+00 .10823798E+00 + .10792077E+00 .10761362E+00 .10731688E+00 .10703084E+00 .10675565E+00 + .10649140E+00 .10623807E+00 .10599552E+00 .10576356E+00 .10554186E+00 + .10533004E+00 .10512760E+00 .10493399E+00 .10474857E+00 .10457063E+00 + .10439942E+00 .10423412E+00 .10407387E+00 .10391779E+00 .10376497E+00 + .10361446E+00 .10346535E+00 .10331669E+00 .10316756E+00 .10301705E+00 + .10286430E+00 .10270846E+00 .10254874E+00 .10238439E+00 .10221475E+00 + .10203918E+00 .10185715E+00 .10166820E+00 .10147193E+00 .10126804E+00 + .10105631E+00 .10083661E+00 .10060889E+00 .10037320E+00 .10012965E+00 + .99878467E-01 .99619932E-01 .99354416E-01 .99082363E-01 .98804288E-01 + .98520765E-01 .98232428E-01 .97939960E-01 .97644087E-01 .97345569E-01 + .97045195E-01 .96743772E-01 .96442116E-01 .96141050E-01 .95841391E-01 + .95543942E-01 .95249488E-01 .94958785E-01 .94672554E-01 .94391474E-01 + .94116174E-01 .93847229E-01 .93585152E-01 .93330392E-01 .93083329E-01 + .92844268E-01 .92613442E-01 .92391008E-01 .92177045E-01 .91971556E-01 + .91774467E-01 .91585628E-01 .91404815E-01 .91231735E-01 .91066024E-01 + .90907255E-01 .90754941E-01 .90608543E-01 .90467470E-01 .90331093E-01 + .90198744E-01 .90069732E-01 .89943339E-01 .89818838E-01 .89695492E-01 + .89572566E-01 .89449332E-01 .89325075E-01 .89199102E-01 .89070749E-01 + .88939383E-01 .88804416E-01 .88665301E-01 .88521548E-01 .88372720E-01 + .88218440E-01 .88058396E-01 .87892342E-01 .87720097E-01 .87541550E-01 + .87356660E-01 .87165453E-01 .86968025E-01 .86764537E-01 .86555218E-01 + .86340357E-01 .86120303E-01 .85895462E-01 .85666290E-01 .85433289E-01 + .85197004E-01 .84958012E-01 .84716921E-01 .84474359E-01 .84230970E-01 + .83987410E-01 .83744335E-01 .83502399E-01 .83262247E-01 .83024506E-01 + .82789784E-01 .82558658E-01 .82331673E-01 .82109336E-01 .81892108E-01 + .81680401E-01 .81474576E-01 .81274938E-01 .81081732E-01 .80895145E-01 + .80715299E-01 .80542258E-01 .80376020E-01 .80216523E-01 .80063643E-01 + .79917196E-01 .79776941E-01 .79642582E-01 .79513768E-01 .79390103E-01 + .79271145E-01 .79156412E-01 .79045389E-01 .78937532E-01 .78832272E-01 + .78729025E-01 .78627196E-01 .78526182E-01 .78425382E-01 .78324201E-01 + .78222055E-01 .78118379E-01 .78012628E-01 .77904287E-01 .77792874E-01 + .77677943E-01 .77559095E-01 .77435971E-01 .77308267E-01 .77175728E-01 + .77038154E-01 .76895403E-01 .76747386E-01 .76594073E-01 .76435492E-01 + .76271726E-01 .76102913E-01 .75929245E-01 .75750968E-01 .75568374E-01 + gradient corrections used for XC + 5 + core charge-density (partial) + .13681950E+01 .13676960E+01 .13662001E+01 .13637105E+01 .13602325E+01 + .13557734E+01 .13503429E+01 .13439524E+01 .13366153E+01 .13283473E+01 + .13191655E+01 .13090892E+01 .12981393E+01 .12863384E+01 .12737107E+01 + .12602820E+01 .12460794E+01 .12311314E+01 .12154677E+01 .11991194E+01 + .11821181E+01 .11644970E+01 .11462895E+01 .11275301E+01 .11082538E+01 + .10884962E+01 .10682931E+01 .10476808E+01 .10266957E+01 .10053741E+01 + .98375267E+00 .96186759E+00 .93975503E+00 .91745077E+00 .89499021E+00 + .87240826E+00 .84973926E+00 .82701690E+00 .80427415E+00 .78154320E+00 + .75885536E+00 .73624104E+00 .71372967E+00 .69134969E+00 .66912843E+00 + .64709213E+00 .62526592E+00 .60367371E+00 .58233824E+00 .56128104E+00 + .54052238E+00 .52008130E+00 .49997559E+00 .48022178E+00 .46083513E+00 + .44182968E+00 .42321820E+00 .40501225E+00 .38722216E+00 .36985707E+00 + .35292495E+00 .33643262E+00 .32038578E+00 .30478902E+00 .28964588E+00 + .27495886E+00 .26072949E+00 .24695832E+00 .23364498E+00 .22078822E+00 + .20838596E+00 .19643530E+00 .18493258E+00 .17387344E+00 .16325283E+00 + .15306507E+00 .14330386E+00 .13396240E+00 .12503332E+00 .11650883E+00 + .10838067E+00 .10064023E+00 .93278522E-01 .86286250E-01 .79653846E-01 + .73371505E-01 .67429216E-01 .61816797E-01 .56523934E-01 .51540202E-01 + .46855108E-01 .42458109E-01 .38338647E-01 .34486174E-01 .30890174E-01 + .27540191E-01 .24425850E-01 .21536879E-01 .18863125E-01 .16394577E-01 + .14121382E-01 .12033860E-01 .10122516E-01 .83780589E-02 .67914092E-02 + .53537108E-02 .40563408E-02 .28909177E-02 .18493086E-02 .92363545E-03 + .10628041E-03 -.61011044E-03 -.12326237E-02 -.17680763E-02 -.22230146E-02 + -.26037134E-02 -.29161762E-02 -.31661368E-02 -.33590603E-02 -.35001462E-02 + -.35943310E-02 -.36462916E-02 -.36604501E-02 -.36409780E-02 -.35918012E-02 + -.35166058E-02 -.34188439E-02 -.33017396E-02 -.31682957E-02 -.30213004E-02 + -.28633344E-02 -.26967780E-02 -.25238182E-02 -.23464568E-02 -.21665171E-02 + -.19856525E-02 -.18053531E-02 -.16269545E-02 -.14516446E-02 -.12804716E-02 + -.11143516E-02 -.95407590E-03 -.80031868E-03 -.65364406E-03 -.51451335E-03 + -.38329201E-03 -.26025656E-03 -.14560117E-03 -.39444206E-04 .58165516E-04 + .14724263E-03 .22785937E-03 .30013989E-03 .36425487E-03 .42041630E-03 + .46887251E-03 .50990347E-03 .54381628E-03 .57094091E-03 .59162620E-03 + .60623608E-03 .61514601E-03 .61873968E-03 .61740593E-03 .61153588E-03 + .60152031E-03 .58774722E-03 .57059965E-03 .55045362E-03 .52767640E-03 + .50262485E-03 .47564400E-03 .44706580E-03 .41720805E-03 .38637350E-03 + .35484906E-03 .32290522E-03 .29079555E-03 .25875641E-03 .22700669E-03 + .19574775E-03 .16516340E-03 .13542004E-03 .10666685E-03 .79036088E-04 + .52643451E-04 .27588517E-04 .39552464E-05 -.18187465E-04 -.38785178E-04 + -.57797264E-04 -.75196221E-04 -.90966959E-04 -.10510606E-03 -.11762104E-03 + -.12852953E-03 -.13785858E-03 -.14564378E-03 -.15192858E-03 -.15676343E-03 + -.16020507E-03 -.16231575E-03 -.16316249E-03 -.16281641E-03 -.16135195E-03 + -.15884628E-03 -.15537859E-03 -.15102952E-03 -.14588056E-03 -.14001345E-03 + -.13350974E-03 -.12645021E-03 -.11891448E-03 -.11098056E-03 -.10272445E-03 + -.94219808E-04 -.85537643E-04 -.76746000E-04 -.67909727E-04 -.59090263E-04 + -.50345446E-04 -.41729367E-04 -.33292247E-04 -.25080349E-04 -.17135911E-04 + -.94971159E-05 -.21980781E-05 .47311376E-05 .11264479E-04 .17379846E-04 + .23059012E-04 .28287521E-04 .33054577E-04 .37352910E-04 .41178632E-04 + .44531079E-04 .47412645E-04 .49828605E-04 .51786930E-04 .53298094E-04 + .54374884E-04 .55032195E-04 .55286832E-04 .55157309E-04 .54663646E-04 + .53827166E-04 .52670302E-04 .51216402E-04 .49489534E-04 .47514310E-04 + .45315700E-04 .42918863E-04 .40348986E-04 .37631124E-04 .34790051E-04 + .31850126E-04 .28835162E-04 .25768303E-04 .22671916E-04 .19567494E-04 + .16475560E-04 .13415592E-04 .10405948E-04 .74638126E-05 .46051404E-05 + .18446197E-05 -.80436009E-06 -.33297302E-05 -.57207550E-05 -.79680369E-05 + -.10063512E-04 -.12000439E-04 -.13773381E-04 -.15378177E-04 -.16811912E-04 + -.18072880E-04 -.19160536E-04 -.20075451E-04 -.20819258E-04 -.21394593E-04 + -.21805038E-04 -.22055054E-04 -.22149917E-04 -.22095649E-04 -.21898951E-04 + -.21567128E-04 -.21108022E-04 -.20529940E-04 -.19841582E-04 -.19051971E-04 + -.18170387E-04 -.17206293E-04 -.16169276E-04 -.15068980E-04 -.13915042E-04 + -.12717039E-04 -.11484427E-04 -.10226489E-04 -.89522887E-05 -.76706186E-05 + -.63899617E-05 -.51184500E-05 -.38638299E-05 -.26334298E-05 -.14341327E-05 + -.27235171E-06 .84599016E-06 .19154768E-05 .29312118E-05 .38888277E-05 + .47844919E-05 .56149089E-05 .63773192E-05 .70694955E-05 .76897350E-05 + .82368500E-05 .87101545E-05 .91094496E-05 .94350052E-05 .96875413E-05 + .98682052E-05 .99785491E-05 .10020505E-04 .99963570E-05 .99087173E-05 + .97604944E-05 .95548661E-05 .92952495E-05 .89852710E-05 .86287366E-05 + .82296019E-05 .77919423E-05 .73199237E-05 .68177739E-05 .62897539E-05 + .57401315E-05 .51731543E-05 .45930247E-05 .40038758E-05 .34097487E-05 + .28145712E-05 .22221377E-05 .16360907E-05 .10599042E-05 .49686829E-06 + -.49924253E-07 -.57759018E-06 -.10834658E-05 -.15651156E-05 -.20203391E-05 + -.24471763E-05 -.28439110E-05 -.32090729E-05 -.35414382E-05 -.38400286E-05 + -.41041086E-05 -.43331819E-05 -.45269862E-05 -.46854867E-05 -.48088688E-05 + -.48975294E-05 -.49520671E-05 -.49732722E-05 -.49621152E-05 -.49197348E-05 + -.48474253E-05 -.47466238E-05 -.46188963E-05 -.44659241E-05 -.42894897E-05 + -.40914626E-05 -.38737848E-05 -.36384571E-05 -.33875243E-05 -.31230618E-05 + -.28471617E-05 -.25619196E-05 -.22694215E-05 -.19717316E-05 -.16708804E-05 + -.13688530E-05 -.10675792E-05 -.76892250E-06 -.47467171E-06 -.18653188E-06 + .93883276E-07 .36505838E-06 .62558254E-06 .87415472E-06 .11095882E-05 + .13308143E-05 .15368851E-05 .17269757E-05 .19003854E-05 .20565379E-05 + .21949813E-05 .23153868E-05 .24175471E-05 .25013741E-05 .25668952E-05 + .26142503E-05 .26436874E-05 .26555573E-05 .26503093E-05 .26284844E-05 + .25907101E-05 .25376938E-05 .24702158E-05 .23891225E-05 .22953197E-05 + .21897645E-05 .20734587E-05 .19474411E-05 .18127798E-05 .16705653E-05 + .15219029E-05 .13679056E-05 .12096872E-05 .10483551E-05 .88500422E-06 + .72071043E-06 .55652452E-06 .39346658E-06 .23252066E-06 .74629737E-07 + -.79308789E-07 -.22844732E-06 -.37199180E-06 -.50920504E-06 -.63940961E-06 + -.76199029E-06 -.87639606E-06 -.98214167E-06 -.10788088E-05 -.11660466E-05 + -.12435721E-05 -.13111700E-05 -.13686922E-05 -.14160567E-05 -.14532461E-05 + -.14803064E-05 -.14973448E-05 -.15045271E-05 -.15020754E-05 -.14902650E-05 + -.14694216E-05 -.14399174E-05 -.14021681E-05 -.13566289E-05 -.13037909E-05 + -.12441768E-05 -.11783371E-05 -.11068459E-05 -.10302970E-05 -.94929926E-06 + -.86447308E-06 -.77644588E-06 -.68584828E-06 -.59331011E-06 -.49945662E-06 + -.40490476E-06 -.31025967E-06 -.21611128E-06 -.12303110E-06 -.31569232E-07 + .57748417E-07 .14442274E-06 .22798375E-06 .30799272E-06 .38404404E-06 + .45576684E-06 .52282633E-06 .58492498E-06 .64180332E-06 .69324058E-06 + .73905504E-06 .77910418E-06 .81328449E-06 .84153118E-06 .86381756E-06 + .88015426E-06 .89058820E-06 .89520145E-06 .89410978E-06 .88746118E-06 + .87543410E-06 .85823565E-06 .83609958E-06 .80928424E-06 .77807038E-06 + .74275888E-06 .70366841E-06 .66113309E-06 .61550004E-06 .56712696E-06 + .51637968E-06 .46362976E-06 .40925205E-06 .35362235E-06 .29711509E-06 + .24010107E-06 .18294532E-06 .12600496E-06 .69627264E-07 .14147759E-07 + -.40111547E-07 -.92843792E-07 -.14375878E-06 -.19258433E-06 -.23906756E-06 + -.28297591E-06 -.32409812E-06 -.36224500E-06 -.39725006E-06 -.42897001E-06 + -.45728507E-06 -.48209916E-06 -.50333994E-06 -.52095868E-06 -.53493001E-06 + -.54525155E-06 -.55194338E-06 -.55504739E-06 -.55462656E-06 -.55076402E-06 + -.54356216E-06 -.53314150E-06 -.51963959E-06 -.50320973E-06 -.48401975E-06 + -.46225056E-06 -.43809484E-06 -.41175555E-06 -.38344448E-06 -.35338073E-06 + -.32178926E-06 -.28889934E-06 -.25494308E-06 -.22015395E-06 -.18476531E-06 + -.14900903E-06 -.11311405E-06 -.77305110E-07 -.41801433E-07 -.68155287E-08 + .27447957E-07 .60793314E-07 .93034769E-07 .12399739E-06 .15351793E-06 + .18144553E-06 .20764243E-06 .23198447E-06 .25436154E-06 .27467801E-06 + .29285294E-06 .30882027E-06 .32252892E-06 .33394275E-06 .34304049E-06 + .34981549E-06 .35427554E-06 .35644241E-06 .35635150E-06 .35405130E-06 + .34960280E-06 .34307888E-06 .33456359E-06 .32415143E-06 .31194653E-06 + .29806180E-06 .28261809E-06 .26574327E-06 .24757131E-06 .22824130E-06 + .20789655E-06 .18668360E-06 .16475125E-06 .14224962E-06 .11932921E-06 + .96139976E-07 .72830407E-07 .49546673E-07 .26431773E-07 .36247299E-08 + -.18740176E-07 -.40534125E-07 -.61634436E-07 -.81925182E-07 -.10129776E-06 + -.11965142E-06 -.13689368E-06 -.15294077E-06 -.16771791E-06 -.18115966E-06 + -.19321005E-06 -.20382276E-06 -.21296125E-06 -.22059870E-06 -.22671807E-06 + -.23131193E-06 -.23438237E-06 -.23594076E-06 -.23600750E-06 -.23461175E-06 + -.23179103E-06 -.22759086E-06 -.22206431E-06 -.21527152E-06 -.20727921E-06 + -.19816014E-06 -.18799253E-06 -.17685950E-06 -.16484845E-06 -.15205045E-06 + -.13855963E-06 -.12447250E-06 -.10988738E-06 -.94903693E-07 -.79621403E-07 + -.64140357E-07 -.48559691E-07 -.32977235E-07 -.17488949E-07 -.21883673E-08 + .12833922E-07 .27490772E-07 .41698943E-07 .55379535E-07 .68458384E-07 + .80866426E-07 .92540020E-07 .10342123E-06 .11345807E-06 .12260472E-06 + .13082167E-06 .13807584E-06 .14434069E-06 .14959622E-06 .15382900E-06 + .15703211E-06 .15920506E-06 .16035369E-06 .16048999E-06 .15963194E-06 + .15780325E-06 .15503317E-06 .15135615E-06 .14681154E-06 .14144331E-06 + .13529963E-06 .12843256E-06 .12089759E-06 .11275333E-06 .10406100E-06 + .94884087E-07 .85287862E-07 .75338981E-07 .65105041E-07 .54654154E-07 + .44054522E-07 .33374019E-07 .22679784E-07 .12037823E-07 .15126319E-08 + -.88331734E-08 -.18939204E-07 -.28747623E-07 -.38203459E-07 -.47254879E-07 + -.55853459E-07 -.63954411E-07 -.71516793E-07 -.78503690E-07 -.84882368E-07 + -.90624396E-07 -.95705746E-07 -.10010686E-06 -.10381269E-06 -.10681271E-06 + -.10910090E-06 -.11067571E-06 -.11153996E-06 -.11170080E-06 -.11116954E-06 + -.10996154E-06 -.10809603E-06 -.10559591E-06 -.10248761E-06 -.98800764E-07 + -.94568078E-07 -.89825012E-07 -.84609535E-07 -.78961853E-07 -.72924121E-07 + -.66540155E-07 -.59855131E-07 -.52915295E-07 -.45767653E-07 -.38459679E-07 + -.31039013E-07 -.23553171E-07 -.16049254E-07 -.85736709E-08 -.11718662E-08 + .61119401E-08 .13235002E-07 .20156282E-07 .26836672E-07 .33239202E-07 + .39329224E-07 .45074589E-07 .50445798E-07 .55416137E-07 .59961796E-07 + .64061959E-07 .67698890E-07 .70857979E-07 .73527788E-07 .75700062E-07 + .77369726E-07 .78534869E-07 .79196695E-07 .79359469E-07 .79030439E-07 + .78219742E-07 .76940295E-07 .75207668E-07 .73039951E-07 .70457594E-07 + .67483252E-07 .64141602E-07 .60459169E-07 .56464125E-07 .52186096E-07 + .47655955E-07 .42905616E-07 .37967819E-07 .32875920E-07 .27663675E-07 + .22365030E-07 .17013912E-07 .11644017E-07 .62886154E-08 .98035002E-09 + -.42489487E-08 -.93684454E-08 -.14348472E-07 -.19160688E-07 -.23778234E-07 + -.28175873E-07 -.32330112E-07 -.36219324E-07 -.39823850E-07 -.43126080E-07 + -.46110537E-07 -.48763931E-07 -.51075210E-07 -.53035587E-07 -.54638563E-07 + -.55879925E-07 -.56757740E-07 -.57272329E-07 -.57426230E-07 -.57224146E-07 + -.56672886E-07 -.55781287E-07 -.54560129E-07 -.53022041E-07 -.51181392E-07 + -.49054178E-07 -.46657901E-07 -.44011436E-07 -.41134893E-07 -.38049481E-07 + -.34777357E-07 -.31341477E-07 -.27765446E-07 -.24073361E-07 -.20289659E-07 + -.16438960E-07 -.12545917E-07 -.86350647E-08 -.47306693E-08 -.85658746E-09 + .29638742E-08 .67080927E-08 .10354256E-07 .13881483E-07 .17269938E-07 + .20500935E-07 .23557035E-07 .26422131E-07 .29081528E-07 .31522012E-07 + .33731907E-07 .35701122E-07 .37421190E-07 .38885296E-07 .40088291E-07 + .41026702E-07 .41698723E-07 .42104208E-07 .42244640E-07 .42123103E-07 + .41744235E-07 .41114181E-07 .40240528E-07 .39132243E-07 .37799593E-07 + .36254067E-07 .34508283E-07 .32575899E-07 .30471515E-07 .28210563E-07 + .25809209E-07 .23284239E-07 .20652949E-07 .17933030E-07 .15142458E-07 + .12299377E-07 .94219886E-08 .65284367E-08 .36367011E-08 .76448864E-09 + -.20708706E-08 -.48525235E-08 -.75641896E-08 -.10190252E-07 -.12715843E-07 + -.15126924E-07 -.17410360E-07 -.19553985E-07 -.21546662E-07 -.23378338E-07 + -.25040091E-07 -.26524161E-07 -.27823991E-07 -.28934240E-07 -.29850805E-07 + -.30570824E-07 -.31092681E-07 -.31415990E-07 -.31541587E-07 -.31471506E-07 + -.31208947E-07 -.30758242E-07 -.30124811E-07 -.29315117E-07 -.28336607E-07 + -.27197656E-07 -.25907504E-07 -.24476182E-07 -.22914446E-07 -.21233696E-07 + -.19445902E-07 -.17563519E-07 -.15599409E-07 -.13566750E-07 -.11478958E-07 + -.93495989E-08 -.71923027E-08 -.50206814E-08 -.28482455E-08 -.68832285E-09 + .14460198E-08 .35420528E-08 .55874571E-08 .75703930E-08 .94795661E-08 + .11304289E-07 .13034536E-07 .14660999E-07 .16175132E-07 .17569192E-07 + .18836275E-07 .19970351E-07 .20966282E-07 .21819848E-07 .22527755E-07 + .23087645E-07 .23498096E-07 .23758620E-07 .23869653E-07 .23832536E-07 + .23649501E-07 .23323639E-07 .22858875E-07 .22259928E-07 .21532276E-07 + .20682107E-07 .19716277E-07 .18642256E-07 .17468077E-07 .16202275E-07 + .14853832E-07 .13432115E-07 .11946814E-07 .10407878E-07 .88254519E-08 + .72098100E-08 .55712944E-08 .39202488E-08 .22669566E-08 .62157842E-09 + -.10059081E-08 -.26057666E-08 -.41685584E-08 -.56851958E-08 -.71469932E-08 + -.85457147E-08 -.98736182E-08 -.11123496E-07 -.12288713E-07 -.13363238E-07 + -.14341672E-07 -.15219277E-07 -.15991990E-07 -.16656444E-07 -.17209978E-07 + -.17650643E-07 -.17977205E-07 -.18189145E-07 -.18286649E-07 -.18270602E-07 + -.18142572E-07 -.17904790E-07 -.17560130E-07 -.17112081E-07 -.16564719E-07 + -.15922676E-07 -.15191103E-07 -.14375631E-07 -.13482331E-07 -.12517674E-07 + -.11488483E-07 -.10401887E-07 -.92652762E-08 -.80862521E-08 -.68725780E-08 + -.56321299E-08 -.43728474E-08 -.31026842E-08 -.18295592E-08 -.56130924E-09 + .69435835E-09 .19299107E-08 .31380331E-08 .43116711E-08 .54440703E-08 + .65288132E-08 .75598547E-08 .85315540E-08 .94387041E-08 .10276558E-07 + .11040851E-07 .11727823E-07 .12334232E-07 .12857371E-07 .13295074E-07 + .13645724E-07 .13908258E-07 .14082165E-07 .14167479E-07 .14164778E-07 + .14075170E-07 .13900281E-07 .13642236E-07 .13303645E-07 .12887576E-07 + .12397533E-07 .11837429E-07 .11211558E-07 .10524561E-07 .97813978E-08 + .89873084E-08 .81477813E-08 .72685147E-08 .63553801E-08 .54143841E-08 + .44516300E-08 .34732798E-08 .24855153E-08 .14945008E-08 .50634509E-09 + -.47293461E-09 -.14374486E-08 -.23814688E-08 -.32994621E-08 -.41861213E-08 + -.50363950E-08 -.58455154E-08 -.66090238E-08 -.73227938E-08 -.79830533E-08 + -.85864022E-08 -.91298293E-08 -.96107260E-08 -.10026897E-07 -.10376569E-07 + atomic pseudo charge-density + .40000000E+01 .39865777E+01 .39466377E+01 .38811433E+01 .37916420E+01 + .36801845E+01 .35492225E+01 .34014950E+01 .32399100E+01 .30674335E+01 + .28869885E+01 .27013712E+01 .25131849E+01 .23247937E+01 .21382919E+01 + .19554911E+01 .17779180E+01 .16068237E+01 .14431992E+01 .12877965E+01 + .11411517E+01 .10036103E+01 .87535141E+00 .75641220E+00 .64671001E+00 + .54606321E+00 .45420994E+00 .37082490E+00 .29553413E+00 .22792793E+00 + .16757210E+00 .11401744E+00 .66807913E-01 .25487409E-01 -.10394612E-01 + -.41278562E-01 -.67591071E-01 -.89742138E-01 -.10812299E+00 -.12310456E+00 + -.13503646E+00 -.14424640E+00 -.15104001E+00 -.15570097E+00 -.15849133E+00 + -.15965211E+00 -.15940402E+00 -.15794831E+00 -.15546772E+00 -.15212749E+00 + -.14807638E+00 -.14344771E+00 -.13836047E+00 -.13292033E+00 -.12722065E+00 + -.12134348E+00 -.11536052E+00 -.10933401E+00 -.10331756E+00 -.97357004E-01 + -.91491144E-01 -.85752437E-01 -.80167666E-01 -.74758549E-01 -.69542302E-01 + -.64532148E-01 -.59737801E-01 -.55165888E-01 -.50820352E-01 -.46702805E-01 + -.42812854E-01 -.39148390E-01 -.35705858E-01 -.32480486E-01 -.29466501E-01 + -.26657315E-01 -.24045694E-01 -.21623904E-01 -.19383841E-01 -.17317148E-01 + -.15415313E-01 -.13669756E-01 -.12071903E-01 -.10613252E-01 -.92854249E-02 + -.80802150E-02 -.69896243E-02 -.60058943E-02 -.51215314E-02 -.43293260E-02 + -.36223673E-02 -.29940535E-02 -.24380983E-02 -.19485349E-02 -.15197159E-02 + -.11463120E-02 -.82330764E-03 -.54599586E-03 -.30997081E-03 -.11111957E-03 + .54387194E-04 .19010535E-03 .29932800E-03 .38509665E-03 .45021268E-03 + .49724900E-03 .52856177E-03 .54630216E-03 .55242795E-03 .54871497E-03 + .53676839E-03 .51803365E-03 .49380712E-03 .46524642E-03 .43338037E-03 + .39911853E-03 .36326031E-03 .32650377E-03 .28945387E-03 .25263036E-03 + .21647525E-03 .18135985E-03 .14759141E-03 .11541928E-03 .85040816E-04 + .56606764E-04 .30226352E-04 .59719919E-05 -.16116354E-04 -.36027141E-04 + -.53773520E-04 -.69389928E-04 -.82928949E-04 -.94458459E-04 -.10405902E-03 + -.11182151E-03 -.11784499E-03 -.12223478E-03 -.12510073E-03 -.12655567E-03 + -.12671407E-03 -.12569076E-03 -.12359997E-03 -.12055430E-03 -.11666399E-03 + -.11203621E-03 -.10677448E-03 -.10097820E-03 -.94742231E-04 -.88156609E-04 + -.81306283E-04 -.74270942E-04 -.67124899E-04 -.59937023E-04 -.52770714E-04 + -.45683928E-04 -.38729233E-04 -.31953896E-04 -.25400000E-04 -.19104585E-04 + -.13099806E-04 -.74131135E-05 -.20674438E-05 .29185776E-05 .75304221E-05 + .11757438E-04 .15592625E-04 .19032404E-04 .22076388E-04 .24727147E-04 + .26989979E-04 .28872677E-04 .30385308E-04 .31539981E-04 .32350635E-04 + .32832821E-04 .33003493E-04 .32880805E-04 .32483918E-04 .31832808E-04 + .30948085E-04 .29850818E-04 .28562372E-04 .27104248E-04 .25497933E-04 + .23764761E-04 .21925781E-04 .20001631E-04 .18012428E-04 .15977661E-04 + .13916095E-04 .11845684E-04 .97834913E-05 .77456253E-05 .57471751E-05 + .38021614E-05 .19234941E-05 .12293798E-06 -.15889121E-05 -.32026485E-05 + -.47100596E-05 -.61041317E-05 -.73790420E-05 -.85301460E-05 -.95539569E-05 + -.10448119E-04 -.11211374E-04 -.11843524E-04 -.12345387E-04 -.12718747E-04 + -.12966301E-04 -.13091602E-04 -.13099000E-04 -.12993572E-04 -.12781064E-04 + -.12467816E-04 -.12060693E-04 -.11567014E-04 -.10994484E-04 -.10351114E-04 + -.96451558E-05 -.88850290E-05 -.80792508E-05 -.72363684E-05 -.63648931E-05 + -.54732369E-05 -.45696518E-05 -.36621723E-05 -.27585615E-05 -.18662606E-05 + -.99234299E-06 -.14347216E-06 .67413606E-06 .14547465E-05 .21931331E-05 + .28846026E-05 .35250133E-05 .41107897E-05 .46389311E-05 .51070171E-05 + .55132071E-05 .58562363E-05 .61354066E-05 .63505743E-05 .65021328E-05 + .65909923E-05 .66185560E-05 .65866927E-05 .64977074E-05 .63543081E-05 + .61595714E-05 .59169057E-05 .56300130E-05 .53028493E-05 .49395841E-05 + .45445596E-05 .41222492E-05 .36772171E-05 .32140765E-05 .27374510E-05 + .22519347E-05 .17620554E-05 .12722380E-05 .78677129E-06 .30977508E-06 + -.15482897E-06 -.60334483E-06 -.10323267E-05 -.14386008E-05 -.18192846E-05 + -.21718029E-05 -.24939006E-05 -.27836530E-05 -.30394730E-05 -.32601147E-05 + -.34446746E-05 -.35925898E-05 -.37036332E-05 -.37779061E-05 -.38158282E-05 + -.38181253E-05 -.37858143E-05 -.37201867E-05 -.36227899E-05 -.34954069E-05 + -.33400340E-05 -.31588583E-05 -.29542334E-05 -.27286543E-05 -.24847319E-05 + -.22251674E-05 -.19527264E-05 -.16702126E-05 -.13804427E-05 -.10862214E-05 + -.79031713E-06 -.49543860E-06 -.20421280E-06 .80835994E-07 .35730573E-06 + .62293455E-06 .87561703E-06 .11134188E-05 .13345890E-05 .15375714E-05 + .17210128E-05 .18837700E-05 .20249147E-05 .21437361E-05 .22397418E-05 + .23126566E-05 .23624198E-05 .23891799E-05 .23932885E-05 .23752919E-05 + .23359216E-05 .22760829E-05 .21968428E-05 .20994165E-05 .19851530E-05 + .18555195E-05 .17120855E-05 .15565066E-05 .13905072E-05 .12158635E-05 + .10343865E-05 .84790465E-06 .65824737E-06 .46722828E-06 .27662940E-06 + .88185931E-07 -.96428306E-07 -.27561447E-06 -.44786132E-06 -.61175681E-06 + -.76599844E-06 -.90940250E-06 -.10409120E-05 -.11596031E-05 -.12646906E-05 + -.13555318E-05 -.14316288E-05 -.14926300E-05 -.15383297E-05 -.15686666E-05 + -.15837213E-05 -.15837121E-05 -.15689899E-05 -.15400323E-05 -.14974360E-05 + -.14419091E-05 -.13742618E-05 -.12953968E-05 -.12062995E-05 -.11080263E-05 + -.10016944E-05 -.88846949E-06 -.76955446E-06 -.64617751E-06 -.51958041E-06 + -.39100686E-06 -.26169110E-06 -.13284687E-06 -.56567587E-08 .11873791E-06 + .23924662E-06 .35483853E-06 .46455060E-06 .56749495E-06 .66286537E-06 + .74994293E-06 .82810073E-06 .89680762E-06 .95563110E-06 .10042391E-05 + .10424010E-05 .10699876E-05 .10869699E-05 .10934176E-05 .10894963E-05 + .10754638E-05 .10516660E-05 .10185318E-05 .97656733E-06 .92634993E-06 + .86852113E-06 .80377954E-06 .73287323E-06 .65659178E-06 .57575821E-06 + .49122066E-06 .40384412E-06 .31450207E-06 .22406824E-06 .13340862E-06 + .43373545E-07 -.45209782E-07 -.13154447E-06 -.21487070E-06 -.29447198E-06 + -.36968088E-06 -.43988425E-06 -.50452780E-06 -.56312000E-06 -.61523545E-06 + -.66051743E-06 -.69867990E-06 -.72950871E-06 -.75286218E-06 -.76867098E-06 + -.77693736E-06 -.77773372E-06 -.77120057E-06 -.75754389E-06 -.73703197E-06 + -.70999169E-06 -.67680437E-06 -.63790116E-06 -.59375810E-06 -.54489085E-06 + -.49184910E-06 -.43521085E-06 -.37557652E-06 -.31356289E-06 -.24979711E-06 + -.18491069E-06 -.11953347E-06 -.54287909E-07 .10216647E-07 .73389332E-07 + .13466292E-06 .19349867E-06 .24939075E-06 .30187039E-06 .35050951E-06 + .39492395E-06 .43477623E-06 .46977785E-06 .49969099E-06 .52432989E-06 + .54356153E-06 .55730595E-06 .56553599E-06 .56827660E-06 .56560363E-06 + .55764217E-06 .54456455E-06 .52658783E-06 .50397094E-06 .47701156E-06 + .44604260E-06 .41142848E-06 .37356115E-06 .33285592E-06 .28974721E-06 + .24468411E-06 .19812594E-06 .15053779E-06 .10238605E-06 .54134036E-07 + .62377485E-08 -.40858297E-07 -.86724999E-07 -.13095241E-06 -.17315324E-06 + -.21296604E-06 -.25005819E-06 -.28412845E-06 -.31490922E-06 -.34216852E-06 + -.36571146E-06 -.38538147E-06 -.40106106E-06 -.41267227E-06 -.42017671E-06 + -.42357521E-06 -.42290716E-06 -.41824948E-06 -.40971522E-06 -.39745192E-06 + -.38163962E-06 -.36248861E-06 -.34023695E-06 -.31514777E-06 -.28750638E-06 + -.25761720E-06 -.22580063E-06 -.19238970E-06 -.15772682E-06 -.12216035E-06 + -.86041260E-07 -.49719795E-07 -.13542196E-07 .22152473E-07 .57035389E-07 + .90790880E-07 .12311917E-06 .15373892E-06 .18238958E-06 .20883345E-06 + .23285758E-06 .25427531E-06 .27292764E-06 .28868422E-06 .30144412E-06 + .31113631E-06 .31771980E-06 .32118358E-06 .32154617E-06 .31885504E-06 + .31318563E-06 .30464021E-06 .29334649E-06 .27945601E-06 .26314228E-06 + .24459889E-06 .22403726E-06 .20168446E-06 .17778076E-06 .15257718E-06 + .12633296E-06 .99313001E-07 .71785264E-07 .44018215E-07 .16278288E-07 + -.11172588E-07 -.38079379E-07 -.64196236E-07 -.89288663E-07 -.11313554E-06 + -.13553101E-06 -.15628613E-06 -.17523044E-06 -.19221325E-06 -.20710472E-06 + -.21979681E-06 -.23020392E-06 -.23826335E-06 -.24393555E-06 -.24720411E-06 + -.24807556E-06 -.24657898E-06 -.24276534E-06 -.23670668E-06 -.22849515E-06 + -.21824179E-06 -.20607522E-06 -.19214012E-06 -.17659568E-06 -.15961382E-06 + -.14137741E-06 -.12207837E-06 -.10191572E-06 -.81093609E-07 -.59819294E-07 + -.38301156E-07 -.16746712E-07 .46393247E-08 .25656936E-07 .46112607E-07 + .65821059E-07 .84606867E-07 .10230597E-06 .11876703E-06 .13385271E-06 + .14744070E-06 .15942470E-06 .16971515E-06 .17823984E-06 .18494433E-06 + .18979218E-06 .19276508E-06 .19386268E-06 .19310238E-06 .19051891E-06 + .18616370E-06 .18010418E-06 .17242290E-06 .16321656E-06 .15259483E-06 + .14067917E-06 .12760150E-06 .11350279E-06 .98531640E-07 .82842700E-07 + .66595175E-07 .49951237E-07 .33074453E-07 .16128219E-07 -.72577625E-09 + -.17329056E-07 -.33527803E-07 -.49174248E-07 -.64127974E-07 -.78257139E-07 + -.91439597E-07 -.10356391E-06 -.11453026E-06 -.12425121E-06 -.13265235E-06 + -.13967283E-06 -.14526574E-06 -.14939835E-06 -.15205219E-06 -.15322310E-06 + -.15292097E-06 -.15116952E-06 -.14800585E-06 -.14347989E-06 -.13765379E-06 + -.13060111E-06 -.12240601E-06 -.11316226E-06 -.10297228E-06 -.91945972E-07 + -.80199652E-07 -.67854818E-07 -.55036943E-07 -.41874230E-07 -.28496367E-07 + -.15033277E-07 -.16138861E-08 .11635077E-07 .24590251E-07 .37132763E-07 + .49149288E-07 .60533043E-07 .71184711E-07 .81013270E-07 .89936746E-07 + .97882862E-07 .10478959E-06 .11060558E-06 .11529055E-06 .11881544E-06 + .12116261E-06 .12232579E-06 .12231003E-06 .12113146E-06 .11881704E-06 + .11540410E-06 .11093987E-06 .10548093E-06 .99092491E-07 .91847710E-07 + .83826869E-07 .75116526E-07 .65808610E-07 .55999479E-07 .45788955E-07 + .35279324E-07 .24574344E-07 .13778238E-07 .29947066E-08 -.76740497E-08 + -.18128276E-07 -.28271574E-07 -.38011770E-07 -.47261731E-07 -.55940124E-07 + -.63972103E-07 -.71289941E-07 -.77833567E-07 -.83551041E-07 -.88398935E-07 + -.92342635E-07 -.95356547E-07 -.97424227E-07 -.98538416E-07 -.98700985E-07 + -.97922800E-07 -.96223506E-07 -.93631217E-07 -.90182152E-07 -.85920176E-07 + -.80896292E-07 -.75168063E-07 -.68798986E-07 -.61857809E-07 -.54417817E-07 + -.46556076E-07 -.38352659E-07 -.29889847E-07 -.21251322E-07 -.12521359E-07 + -.37840174E-08 .48776497E-08 .13382368E-07 .21651391E-07 .29609210E-07 + .37184230E-07 .44309397E-07 .50922773E-07 .56968061E-07 .62395062E-07 + .67160077E-07 .71226235E-07 .74563758E-07 .77150151E-07 .78970324E-07 + .80016644E-07 .80288910E-07 .79794261E-07 .78547019E-07 .76568461E-07 + .73886532E-07 .70535495E-07 .66555530E-07 .61992277E-07 .56896336E-07 + .51322727E-07 .45330316E-07 .38981204E-07 .32340106E-07 .25473698E-07 + .18449969E-07 .11337555E-07 .42050839E-08 -.28794736E-08 -.98494415E-08 + -.16640052E-07 -.23189038E-07 -.29437186E-07 -.35328866E-07 -.40812512E-07 + -.45841055E-07 -.50372323E-07 -.54369371E-07 -.57800775E-07 -.60640853E-07 + -.62869847E-07 -.64474033E-07 -.65445776E-07 -.65783533E-07 -.65491787E-07 + -.64580939E-07 -.63067132E-07 -.60972029E-07 -.58322543E-07 -.55150519E-07 + -.51492371E-07 -.47388682E-07 -.42883771E-07 -.38025227E-07 -.32863421E-07 + -.27450993E-07 -.21842328E-07 -.16093019E-07 -.10259328E-07 -.43976434E-08 + .14360549E-08 .71867203E-08 .12800750E-07 .18226475E-07 .23414627E-07 + .28318775E-07 .32895734E-07 .37105930E-07 .40913739E-07 .44287771E-07 + .47201122E-07 .49631572E-07 .51561743E-07 .52979202E-07 .53876527E-07 + .54251311E-07 .54106131E-07 .53448462E-07 .52290552E-07 .50649243E-07 + .48545767E-07 .46005485E-07 .43057604E-07 .39734853E-07 .36073132E-07 + .32111137E-07 .27889957E-07 .23452663E-07 .18843870E-07 .14109304E-07 + .92953505E-08 .44486096E-08 -.38454644E-09 -.51584109E-08 -.98283672E-08 + -.14351299E-07 -.18685979E-07 -.22793441E-07 -.26637321E-07 -.30184169E-07 + -.33403735E-07 -.36269219E-07 -.38757483E-07 -.40849228E-07 -.42529135E-07 + -.43785962E-07 -.44612604E-07 -.45006116E-07 -.44967688E-07 -.44502592E-07 + -.43620082E-07 -.42333262E-07 -.40658921E-07 -.38617326E-07 -.36231996E-07 + -.33529441E-07 -.30538878E-07 -.27291922E-07 -.23822258E-07 -.20165306E-07 + -.16357859E-07 -.12437720E-07 -.84433384E-08 -.44134316E-08 -.38662064E-09 + .35989364E-08 .75059000E-08 .11298093E-07 .14940832E-07 .18401234E-07 + .21648514E-07 .24654246E-07 .27392612E-07 .29840613E-07 .31978257E-07 + .33788713E-07 .35258437E-07 .36377263E-07 .37138462E-07 .37538764E-07 + .37578356E-07 .37260840E-07 .36593157E-07 .35585490E-07 .34251130E-07 + .32606315E-07 .30670044E-07 .28463867E-07 .26011653E-07 .23339341E-07 + .20474668E-07 .17446888E-07 .14286482E-07 .11024851E-07 .76940136E-08 + .43262926E-08 .95400876E-09 -.23908262E-08 -.56768089E-08 -.88734341E-08 + -.11951374E-07 -.14882742E-07 -.17641344E-07 -.20202900E-07 -.22545264E-07 + -.24648601E-07 -.26495553E-07 -.28071378E-07 -.29364057E-07 -.30364384E-07 + -.31066017E-07 -.31465510E-07 -.31562315E-07 -.31358754E-07 -.30859967E-07 + -.30073833E-07 -.29010868E-07 -.27684093E-07 -.26108889E-07 -.24302823E-07 + -.22285459E-07 -.20078151E-07 -.17703825E-07 -.15186743E-07 -.12552259E-07 + -.98265679E-08 -.70364516E-08 -.42090155E-08 -.13714314E-08 .14493211E-08 + .42267068E-08 .69348812E-08 .95489280E-08 .12045084E-07 .14400953E-07 + .16595700E-07 .18610236E-07 .20427375E-07 .22031979E-07 .23411080E-07 + .24553978E-07 .25452321E-07 .26100155E-07 .26493958E-07 .26632648E-07 + .26517566E-07 .26152438E-07 .25543316E-07 .24698497E-07 .23628420E-07 + .22345546E-07 .20864215E-07 .19200499E-07 .17372025E-07 .15397796E-07 + .13297997E-07 .11093789E-07 .88071036E-08 .64604261E-08 .40765756E-08 + .16784879E-08 -.71100283E-09 -.30693782E-08 -.53746454E-08 -.76055391E-08 + -.97417153E-08 -.11763934E-07 -.13654229E-07 -.15396065E-07 -.16974480E-07 + -.18376205E-07 -.19589781E-07 -.20605640E-07 -.21416183E-07 -.22015826E-07 + -.22401035E-07 -.22570340E-07 -.22524323E-07 -.22265595E-07 -.21798749E-07 + -.21130301E-07 -.20268601E-07 -.19223743E-07 -.18007448E-07 -.16632937E-07 + -.15114794E-07 -.13468809E-07 -.11711822E-07 -.98615529E-08 -.79364227E-08 + -.59553751E-08 -.39376911E-08 -.19028042E-08 .12988462E-09 .21411892E-08 + .41123172E-08 .60250428E-08 .78618736E-08 .96062079E-08 .11242483E-07 + .12756310E-07 .14134601E-07 .15365675E-07 .16439358E-07 .17347061E-07 + .18081847E-07 .18638478E-07 .19013451E-07 .19205011E-07 .19213151E-07 + .19039596E-07 .18687766E-07 .18162730E-07 .17471142E-07 .16621162E-07 + .15622363E-07 .14485631E-07 .13223043E-07 .11847748E-07 .10373827E-07 + .88161544E-08 .71902497E-08 .55121243E-08 .37981263E-08 .20647829E-08 + .32864295E-09 -.13938797E-08 -.30866595E-08 -.47340081E-08 -.63208176E-08 + -.78326971E-08 -.92561016E-08 -.10578451E-07 -.11788240E-07 -.12875136E-07 + -.13830065E-07 -.14645284E-07 -.15314441E-07 -.15832624E-07 -.16196389E-07 + -.16403779E-07 -.16454334E-07 -.16349071E-07 -.16090471E-07 -.15682433E-07 + -.15130227E-07 -.14440433E-07 -.13620859E-07 -.12680467E-07 -.11629267E-07 + 19.8421228800786942 T + Non local Part + 0 2 1.55770284366884382 + 8.48191151414740752 -0.636078516188222226E-01 -0.636078516188222226E-01 0.376965742998787998E-02 + Reciprocal Space Part + .87079657E+01 .86905268E+01 .86383852E+01 .85520639E+01 .84324261E+01 + .82806628E+01 .80982759E+01 .78870568E+01 .76490608E+01 .73865785E+01 + .71021037E+01 .67982989E+01 .64779593E+01 .61439752E+01 .57992933E+01 + .54468791E+01 .50896789E+01 .47305835E+01 .43723936E+01 .40177873E+01 + .36692907E+01 .33292513E+01 .29998152E+01 .26829081E+01 .23802200E+01 + .20931942E+01 .18230205E+01 .15706325E+01 .13367087E+01 .11216776E+01 + .92572621E+00 .74881221E+00 .59067848E+00 .45087066E+00 .32875652E+00 + .22354716E+00 .13431939E+00 .60038835E-01 -.41655140E-03 -.48233192E-01 + -.84639053E-01 -.11088174E+00 -.12820783E+00 -.13784377E+00 -.14097860E+00 + -.13874855E+00 -.13222400E+00 -.12239850E+00 -.11018019E+00 -.96385516E-01 + -.81735140E-01 -.66852083E-01 -.52261834E-01 -.38394355E-01 -.25587745E-01 + -.14093369E-01 -.40822094E-02 .43477954E-02 .11163663E-01 .16388781E-01 + .20094049E-01 .22388976E-01 .23412932E-01 .23326746E-01 .22304805E-01 + .20527794E-01 .18176188E-01 .15424571E-01 .12436845E-01 .93623490E-02 + .63329000E-02 .34607215E-02 .83723118E-03 -.14673812E-02 -.34038583E-02 + -.49429505E-02 -.60739569E-02 -.68028370E-02 -.71499932E-02 -.71478312E-02 + -.68381952E-02 -.62697733E-02 -.54955578E-02 -.45704368E-02 -.35489799E-02 + -.24834728E-02 -.14222372E-02 -.40826592E-03 .52181480E-03 .13384515E-02 + .20195476E-02 .25505425E-02 .29242131E-02 .31402290E-02 .32045017E-02 + .31283679E-02 .29276511E-02 .26216452E-02 .22320639E-02 .17819939E-02 + Real Space Part + .10679849E+02 .10674516E+02 .10658521E+02 .10631882E+02 .10594629E+02 + .10546798E+02 .10488435E+02 .10419590E+02 .10340316E+02 .10250666E+02 + .10150691E+02 .10040442E+02 .99199643E+01 .97892993E+01 .96484877E+01 + .94975699E+01 .93365905E+01 .91656025E+01 .89846735E+01 .87938923E+01 + .85933769E+01 .83832826E+01 .81638104E+01 .79352160E+01 .76978177E+01 + .74520045E+01 .71982421E+01 .69370789E+01 .66691491E+01 .63951751E+01 + .61159665E+01 .58324186E+01 .55455066E+01 .52562794E+01 .49658496E+01 + .46753825E+01 .43860825E+01 .40991787E+01 .38159080E+01 .35374987E+01 + .32651527E+01 .30000279E+01 .27432213E+01 .24957525E+01 .22585487E+01 + .20324314E+01 .18181051E+01 .16161478E+01 .14270049E+01 .12509847E+01 + .10882570E+01 .93885502E+00 .80267855E+00 .67950082E+00 .56897697E+00 + .47065459E+00 .38398603E+00 .30834185E+00 .24302540E+00 .18728774E+00 + .14034296E+00 .10138309E+00 .69592617E-01 .44162070E-01 .24300516E-01 + .92466753E-02 -.17214853E-02 -.92788061E-02 -.14046714E-01 -.16588732E-01 + -.17407693E-01 -.16944568E-01 -.15578795E-01 -.13629958E-01 -.11360623E-01 + -.89801560E-02 -.66492956E-02 -.44852808E-02 -.25673264E-02 -.94224811E-03 + .36993817E-03 .13706046E-02 .20774200E-02 .25196886E-02 .27342003E-02 + .27616467E-02 .26436316E-02 .24202815E-02 .21284366E-02 .18003892E-02 + .14631174E-02 .11379537E-02 .84061912E-03 .58155029E-03 .36644718E-03 + .19697068E-03 .71525435E-04 -.13929925E-04 -.65094077E-04 -.88595362E-04 + Reciprocal Space Part + -.33459269E+02 -.32885812E+02 -.31175324E+02 -.28357261E+02 -.24480084E+02 + -.19610327E+02 -.13831310E+02 -.72415472E+01 .47142272E-01 .79117577E+01 + .16220445E+02 .24834975E+02 .33613317E+02 .42412261E+02 .51090027E+02 + .59508819E+02 .67537255E+02 .75052646E+02 .81943063E+02 .88109160E+02 + .93465720E+02 .97942900E+02 .10148714E+03 .10406175E+03 .10564715E+03 + .10624077E+03 .10585660E+03 .10452449E+03 .10228909E+03 .99208571E+02 + .95353099E+02 .90803154E+02 .85647663E+02 .79982052E+02 .73906232E+02 + .67522572E+02 .60933898E+02 .54241560E+02 .47543611E+02 .40933123E+02 + .34496680E+02 .28313063E+02 .22452162E+02 .16974111E+02 .11928669E+02 + .73548473E+01 .32807727E+01 -.27621319E+00 -.33092347E+01 -.58213610E+01 + -.78249039E+01 -.93405595E+01 -.10396421E+02 -.11026891E+02 -.11271526E+02 + -.11173833E+02 -.10780072E+02 -.10138054E+02 -.92960043E+01 -.83014828E+01 + -.72003946E+01 -.60361114E+01 -.48487123E+01 -.36743572E+01 -.25447982E+01 + -.14870336E+01 -.52310141E+00 .32999049E+00 .10602053E+01 .16603003E+01 + .21275436E+01 .24633402E+01 .26727834E+01 .27641476E+01 .27483410E+01 + .26383351E+01 .24485880E+01 .21944773E+01 .18917574E+01 .15560536E+01 + .12024051E+01 .84486462E+00 .49616263E+00 .16743966E+00 -.13195032E+00 + -.39456569E+00 -.61493394E+00 -.78954326E+00 -.91677435E+00 -.99677914E+00 + -.10313144E+01 -.10235387E+01 -.97778206E+00 -.89929746E+00 -.79400304E+00 + -.66822444E+00 -.52844495E+00 -.38107084E+00 -.23221848E+00 -.87528095E-01 + Real Space Part + .47043595E+03 .47061811E+03 .47114518E+03 .47195957E+03 .47296738E+03 + .47404142E+03 .47502541E+03 .47573899E+03 .47598368E+03 .47554935E+03 + .47422109E+03 .47178640E+03 .46804221E+03 .46280172E+03 .45590085E+03 + .44720395E+03 .43660875E+03 .42405037E+03 .40950423E+03 .39298784E+03 + .37456135E+03 .35432699E+03 .33242725E+03 .30904200E+03 .28438464E+03 + .25869730E+03 .23224536E+03 .20531141E+03 .17818879E+03 .15117498E+03 + .12456500E+03 .98644898E+02 .73685748E+02 .49938027E+02 .27626718E+02 + .69471588E+01 -.11938243E+02 -.28902388E+02 -.43854906E+02 -.56742633E+02 + -.67549163E+02 -.76293525E+02 -.83028062E+02 -.87835614E+02 -.90826098E+02 + -.92132623E+02 -.91907271E+02 -.90316654E+02 -.87537414E+02 -.83751758E+02 + -.79143172E+02 -.73892400E+02 -.68173791E+02 -.62152082E+02 -.55979677E+02 + -.49794451E+02 -.43718116E+02 -.37855127E+02 -.32292132E+02 -.27097928E+02 + -.22323878E+02 -.18004740E+02 -.14159842E+02 -.10794541E+02 -.79018948E+01 + -.54644709E+01 -.34562340E+01 -.18444414E+01 -.59149265E+00 .34331959E+00 + .10021984E+01 .14274044E+01 .16600147E+01 .17388937E+01 .16998820E+01 + .15752010E+01 .13930648E+01 .11774834E+01 .94823819E+00 .72100557E+00 + .50760296E+00 .31633056E+00 .15238184E+00 .18296902E-01 -.85564833E-01 + -.16055420E+00 -.20928196E+00 -.23520343E+00 -.24224903E+00 -.23450846E+00 + -.21597247E+00 -.19033347E+00 -.16084311E+00 -.13022316E+00 -.10062372E+00 + -.73622006E-01 -.50254001E-01 -.31070866E-01 -.16212387E-01 -.54900275E-02 + Non local Part + 1 2 1.55770284366884382 + 2.65859659160385764 -0.504801881867953453E-01 -0.504801881867953453E-01 0.892956271679604986E-02 + Reciprocal Space Part + .00000000E+00 .55360975E+00 .11020032E+01 .16400357E+01 .21627048E+01 + .26652186E+01 .31430596E+01 .35920450E+01 .40083810E+01 .43887098E+01 + .47301505E+01 .50303314E+01 .52874138E+01 .55001078E+01 .56676786E+01 + .57899444E+01 .58672657E+01 .59005262E+01 .58911063E+01 .58408488E+01 + .57520191E+01 .56272596E+01 .54695387E+01 .52820975E+01 .50683934E+01 + .48320418E+01 .45767578E+01 .43062991E+01 .40244089E+01 .37347632E+01 + .34409202E+01 .31462743E+01 .28540152E+01 .25670915E+01 .22881811E+01 + .20196669E+01 .17636193E+01 .15217840E+01 .12955770E+01 .10860853E+01 + .89407229E+00 .71998985E+00 .56399389E+00 .42596477E+00 .30553088E+00 + .20209532E+00 .11486458E+00 .42878783E-01 -.14957234E-01 -.59842780E-01 + -.93050595E-01 -.11589722E+00 -.12971495E+00 -.13582584E+00 -.13551809E+00 + -.13002523E+00 -.12050824E+00 -.10804072E+00 -.93597327E-01 -.78045331E-01 + -.62139262E-01 -.46518532E-01 -.31707803E-01 -.18119864E-01 -.60607310E-02 + .42633380E-02 .12737265E-01 .19327344E-01 .24070560E-01 .27063374E-01 + .28450306E-01 .28412605E-01 .27157313E-01 .24906934E-01 .21889935E-01 + .18332245E-01 .14449871E-01 .10442718E-01 .64896733E-02 .27449375E-02 + -.66440255E-03 -.36396321E-02 -.61105795E-02 -.80348118E-02 -.93959825E-02 + -.10201473E-01 -.10479476E-01 -.10275671E-01 -.96496464E-02 -.86712031E-02 + -.74166865E-02 -.59654538E-02 -.43965915E-02 -.27859668E-02 -.12036827E-02 + .28801366E-03 .16363396E-02 .27990903E-02 .37452630E-02 .44552150E-02 + Real Space Part + .00000000E+00 .64359942E+00 .12860893E+01 .19263130E+01 .25630221E+01 + .31948350E+01 .38202017E+01 .44373750E+01 .50443910E+01 .56390587E+01 + .62189597E+01 .67814592E+01 .73237268E+01 .78427678E+01 .83354645E+01 + .87986250E+01 .92290406E+01 .96235469E+01 .99790905E+01 .10292796E+02 + .10562036E+02 .10784491E+02 .10958218E+02 .11081699E+02 .11153897E+02 + .11174283E+02 .11142876E+02 .11060254E+02 .10927558E+02 .10746490E+02 + .10519290E+02 .10248709E+02 .99379673E+01 .95907014E+01 .92109083E+01 + .88028781E+01 .83711229E+01 .79203026E+01 .74551481E+01 .69803858E+01 + .65006629E+01 .60204776E+01 .55441132E+01 .50755794E+01 .46185613E+01 + .41763765E+01 .37519415E+01 .33477477E+01 .29658468E+01 .26078460E+01 + .22749116E+01 .19677819E+01 .16867871E+01 .14318761E+01 .12026495E+01 + .99839626E+00 .81813432E+00 .66065330E+00 .52455802E+00 .40831211E+00 + .31028032E+00 .22876897E+00 .16206345E+00 .10846228E+00 .66307278E-01 + .34009364E-01 .10069850E-01 -.69027801E-02 -.18180606E-01 -.24908286E-01 + -.28099078E-01 -.28634490E-01 -.27267117E-01 -.24626205E-01 -.21225416E-01 + -.17472311E-01 -.13679034E-01 -.10073742E-01 -.68123372E-02 -.39901212E-02 + -.16530358E-02 .19178102E-03 .15663369E-02 .25131785E-02 .30879320E-02 + .33530317E-02 .33726336E-02 .32086679E-02 .29179506E-02 .25502513E-02 + .21471944E-02 .17418610E-02 .13589554E-02 .10154019E-02 .72124547E-03 + .48074009E-03 .29352474E-03 .15580136E-03 .61447592E-04 .30138377E-05 + Reciprocal Space Part + .00000000E+00 -.26932227E+01 -.52971472E+01 -.77244363E+01 -.98916316E+01 + -.11720983E+02 -.13142152E+02 -.14093748E+02 -.14524661E+02 -.14395175E+02 + -.13677819E+02 -.12357950E+02 -.10434056E+02 -.79177661E+01 -.48335806E+01 + -.12183197E+01 .28796906E+01 .74016747E+01 .12279682E+02 .17438045E+02 + .22794994E+02 .28264383E+02 .33757491E+02 .39184855E+02 .44458102E+02 + .49491724E+02 .54204777E+02 .58522445E+02 .62377462E+02 .65711339E+02 + .68475389E+02 .70631527E+02 .72152827E+02 .73023834E+02 .73240630E+02 + .72810652E+02 .71752282E+02 .70094218E+02 .67874635E+02 .65140188E+02 + .61944855E+02 .58348663E+02 .54416332E+02 .50215862E+02 .45817101E+02 + .41290320E+02 .36704841E+02 .32127729E+02 .27622587E+02 .23248472E+02 + .19058953E+02 .15101330E+02 .11416015E+02 .80360965E+01 .49870782E+01 + .22867940E+01 -.54504994E-01 -.20339040E+01 -.36554301E+01 -.49295269E+01 + -.58724172E+01 -.65053728E+01 -.68539157E+01 -.69469702E+01 -.68159914E+01 + -.64940905E+01 -.60151778E+01 -.54131449E+01 -.47211011E+01 -.39706812E+01 + -.31914370E+01 -.24103219E+01 -.16512754E+01 -.93491359E+00 -.27832313E+00 + .30503924E+00 .80534852E+00 .12163201E+01 .15350341E+01 .17616860E+01 + .18992752E+01 .19532440E+01 .19310803E+01 .18418981E+01 .16960073E+01 + .15044873E+01 .12787746E+01 .10302757E+01 .77001425E+00 .50831954E+00 + .25456290E+00 .16945576E-01 -.19765940E+00 -.38381089E+00 -.53754978E+00 + -.65639825E+00 -.73931205E+00 -.78659086E+00 -.79975259E+00 -.78137851E+00 + Real Space Part + .00000000E+00 .32174412E+02 .64081200E+02 .95454901E+02 .12603438E+03 + .15556504E+03 .18380101E+03 .21050740E+03 .23546257E+03 .25846040E+03 + .27931254E+03 .29785062E+03 .31392841E+03 .32742382E+03 .33824076E+03 + .34631080E+03 .35159451E+03 .35408254E+03 .35379625E+03 .35078802E+03 + .34514103E+03 .33696853E+03 .32641275E+03 .31364309E+03 .29885400E+03 + .28226227E+03 .26410388E+03 .24463049E+03 .22410561E+03 .20280043E+03 + .18098955E+03 .15894661E+03 .13693992E+03 .11522816E+03 .94056367E+02 + .73652166E+02 .54222369E+02 .35950069E+02 .18992243E+02 .34779240E+01 + -.10493014E+02 -.22850445E+02 -.33553946E+02 -.42592145E+02 -.49981475E+02 + -.55764394E+02 -.60007127E+02 -.62796996E+02 -.64239417E+02 -.64454665E+02 + -.63574472E+02 -.61738574E+02 -.59091275E+02 -.55778129E+02 -.51942809E+02 + -.47724232E+02 -.43254004E+02 -.38654223E+02 -.34035686E+02 -.29496509E+02 + -.25121167E+02 -.20979967E+02 -.17128906E+02 -.13609921E+02 -.10451462E+02 + -.76693710E+01 -.52679941E+01 -.32414933E+01 -.15752887E+01 -.24758462E+00 + .76907715E+00 .15062828E+01 .19982770E+01 .22805946E+01 .23888267E+01 + .23575419E+01 .22193827E+01 .20043426E+01 .17392288E+01 .14473034E+01 + .11480951E+01 .85736431E+00 .58720519E+00 .34626103E+00 .14003133E+00 + -.28753785E-01 -.15971487E+00 -.25438251E+00 -.31575466E+00 -.34786993E+00 + -.35541133E+00 -.34335220E+00 -.31665261E+00 -.28001124E+00 -.23767485E+00 + -.19330460E+00 -.14989599E+00 -.10974754E+00 -.74471444E-01 -.45038872E-01 + PAW radial sets + 323 0.989218471734281124 +(5E20.12) + augmentation charges (non sperical) + -.118612867153E+00 -.756362247412E-03 -.532145531503E-01 -.130926919871E-02 -.756362247412E-03 + -.210856503823E-04 -.122603249007E-03 .363423839020E-05 -.532145531503E-01 -.122603249007E-03 + -.179689875812E-01 -.555432069872E-03 -.130926919871E-02 .363423839020E-05 -.555432069872E-03 + .498671741032E-04 + uccopancies in atom + .200000000162E+01 .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 + .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 + .666666667141E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 .000000000000E+00 + .000000000000E+00 + grid + .353278105438E-04 .364765828105E-04 .376627102856E-04 .388874076671E-04 .401519291522E-04 + .414575697215E-04 .428056664648E-04 .441975999512E-04 .456347956421E-04 .471187253514E-04 + .486509087530E-04 .502329149365E-04 .518663640144E-04 .535529287814E-04 .552943364272E-04 + .570923703053E-04 .589488717596E-04 .608657420098E-04 .628449440985E-04 .648885049016E-04 + .669985172040E-04 .691771418426E-04 .714266099194E-04 .737492250864E-04 .761473659044E-04 + .786234882792E-04 .811801279764E-04 .838199032186E-04 .865455173661E-04 .893597616862E-04 + .922655182109E-04 .952657626888E-04 .983635676325E-04 .101562105465E-03 .104864651768E-03 + .108274588638E-03 .111795408149E-03 .115430715926E-03 .119184234844E-03 .123059808833E-03 + .127061406819E-03 .131193126789E-03 .135459199986E-03 .139863995240E-03 .144412023447E-03 + .149107942186E-03 .153956560487E-03 .158962843759E-03 .164131918874E-03 .169469079417E-03 + .174979791106E-03 .180669697392E-03 .186544625235E-03 .192610591076E-03 .198873806993E-03 + .205340687067E-03 .212017853948E-03 .218912145639E-03 .226030622496E-03 .233380574462E-03 + .240969528530E-03 .248805256452E-03 .256895782699E-03 .265249392676E-03 .273874641209E-03 + .282780361308E-03 .291975673207E-03 .301469993709E-03 .311273045829E-03 .321394868748E-03 + .331845828098E-03 .342636626573E-03 .353778314896E-03 .365282303127E-03 .377160372357E-03 + .389424686766E-03 .402087806084E-03 .415162698451E-03 .428662753701E-03 .442601797068E-03 + .456994103352E-03 .471854411533E-03 .487197939863E-03 .503040401457E-03 .519398020380E-03 + .536287548263E-03 .553726281459E-03 .571732078754E-03 .590323379658E-03 .609519223288E-03 + .629339267864E-03 .649803810846E-03 .670933809712E-03 .692750903429E-03 .715277434606E-03 + .738536472381E-03 .762551836040E-03 .787348119413E-03 .812950716063E-03 .839385845286E-03 + .866680578963E-03 .894862869287E-03 .923961577387E-03 .954006502881E-03 .985028414399E-03 + .101705908109E-02 .105013130516E-02 .108427895544E-02 .111953700213E-02 .115594155253E-02 + .119352988810E-02 .123234050257E-02 .127241314140E-02 .131378884247E-02 .135650997813E-02 + .140062029854E-02 .144616497653E-02 .149319065382E-02 .154174548883E-02 .159187920594E-02 + .164364314647E-02 .169709032120E-02 .175227546473E-02 .180925509145E-02 .186808755348E-02 + .192883310041E-02 .199155394099E-02 .205631430683E-02 .212318051821E-02 .219222105197E-02 + .226350661166E-02 .233711019991E-02 .241310719324E-02 .249157541920E-02 .257259523611E-02 + .265624961535E-02 .274262422631E-02 .283180752413E-02 .292389084032E-02 .301896847624E-02 + .311713779968E-02 .321849934462E-02 .332315691413E-02 .343121768671E-02 .354279232604E-02 + .365799509430E-02 .377694396919E-02 .389976076474E-02 .402657125610E-02 .415750530828E-02 + .429269700920E-02 .443228480697E-02 .457641165169E-02 .472522514185E-02 .487887767547E-02 + .503752660617E-02 .520133440431E-02 .537046882339E-02 .554510307185E-02 .572541599040E-02 + .591159223525E-02 .610382246712E-02 .630230354657E-02 .650723873558E-02 .671883790569E-02 + .693731775293E-02 .716290201977E-02 .739582172419E-02 .763631539635E-02 .788462932276E-02 + .814101779859E-02 .840574338805E-02 .867907719326E-02 .896129913194E-02 .925269822400E-02 + .955357288758E-02 .986423124464E-02 .101849914365E-01 .105161819495E-01 .108581419519E-01 + .112112216404E-01 .115757825996E-01 .119521981717E-01 .123408538391E-01 .127421476193E-01 + .131564904721E-01 .135843067208E-01 .140260344867E-01 .144821261375E-01 .149530487510E-01 + .154392845931E-01 .159413316118E-01 .164597039470E-01 .169949324574E-01 .175475652638E-01 + .181181683104E-01 .187073259445E-01 .193156415151E-01 .199437379906E-01 .205922585965E-01 + .212618674747E-01 .219532503631E-01 .226671152982E-01 .234041933402E-01 .241652393213E-01 + .249510326191E-01 .257623779547E-01 .266001062165E-01 .274650753115E-01 .283581710436E-01 + .292803080210E-01 .302324305924E-01 .312155138146E-01 .322305644506E-01 .332786220011E-01 + .343607597686E-01 .354780859567E-01 .366317448050E-01 .378229177610E-01 .390528246900E-01 + .403227251240E-01 .416339195521E-01 .429877507520E-01 .443856051652E-01 .458289143166E-01 + .473191562810E-01 .488578571964E-01 .504465928270E-01 .520869901769E-01 .537807291563E-01 + .555295443019E-01 .573352265534E-01 .591996250870E-01 .611246492098E-01 .631122703148E-01 + .651645238996E-01 .672835116512E-01 .694714035982E-01 .717304403333E-01 .740629353074E-01 + .764712771991E-01 .789579323611E-01 .815254473456E-01 .841764515121E-01 .869136597208E-01 + .897398751118E-01 .926579919768E-01 .956709987225E-01 .987819809310E-01 .101994124520E+00 + .105310719005E+00 .108735160869E+00 .112270957040E+00 .115921728481E+00 .119691213902E+00 + .123583273585E+00 .127601893339E+00 .131751188583E+00 .136035408556E+00 .140458940676E+00 + .145026315024E+00 .149742208992E+00 .154611452068E+00 .159639030781E+00 .164830093811E+00 + .170189957261E+00 .175724110099E+00 .181438219781E+00 .187338138056E+00 .193429906954E+00 + .199719764979E+00 .206214153496E+00 .212919723327E+00 .219843341560E+00 .226992098585E+00 + .234373315355E+00 .241994550880E+00 .249863609972E+00 .257988551235E+00 .266377695319E+00 + .275039633439E+00 .283983236179E+00 .293217662568E+00 .302752369466E+00 .312597121246E+00 + .322761999795E+00 .333257414835E+00 .344094114590E+00 .355283196787E+00 .366836120023E+00 + .378764715502E+00 .391081199148E+00 .403798184116E+00 .416928693710E+00 .430486174720E+00 + .444484511190E+00 .458938038641E+00 .473861558747E+00 .489270354497E+00 .505180205845E+00 + .521607405869E+00 .538568777456E+00 .556081690535E+00 .574164079857E+00 .592834463369E+00 + .612111961177E+00 .632016315122E+00 .652567909002E+00 .673787789445E+00 .695697687463E+00 + .718320040705E+00 .741678016440E+00 .765795535274E+00 .790697295655E+00 .816408799161E+00 + .842956376619E+00 .870367215068E+00 .898669385601E+00 .927891872115E+00 .958064600989E+00 + .989218471734E+00 .102138538864E+01 .105459829343E+01 + aepotential + .249296618412E+05 .247076583257E+05 .244443255599E+05 .241414371172E+05 .238011681064E+05 + .234259054160E+05 .230182276498E+05 .225808680933E+05 .221166790321E+05 .216285959644E+05 + .211196020425E+05 .205926935296E+05 .200508469868E+05 .194969885786E+05 .189339660140E+05 + .183645234482E+05 .177912796436E+05 .172167095020E+05 .166431291099E+05 .160726841798E+05 + .155073419145E+05 .149488860093E+05 .143989147023E+05 .138588415092E+05 .133298984061E+05 + .128131411287E+05 .123094562646E+05 .118195698156E+05 .113440569063E+05 .108833523432E+05 + .104377617399E+05 .100074729506E+05 .959256758265E+04 .919303239296E+04 .880877039590E+04 + .843961154725E+04 .808532289425E+04 .774561810756E+04 .742016634235E+04 .710860038888E+04 + .681052409519E+04 .652551907131E+04 .625315067621E+04 .599297332353E+04 .574453513086E+04 + .550738195528E+04 .528106086162E+04 .506512306412E+04 .485912638819E+04 .466263730249E+04 + .447523256840E+04 .429650053920E+04 .412604216570E+04 .396347173509E+04 .380841738005E+04 + .366052140119E+04 .351944041296E+04 .338484535875E+04 .325642140535E+04 .313386774487E+04 + .301689731751E+04 .290523647712E+04 .279862460324E+04 .269681368551E+04 .259956787532E+04 + .250666302499E+04 .241788621528E+04 .233303528113E+04 .225191833487E+04 .217435329790E+04 + .210016743837E+04 .202919692087E+04 .196128636819E+04 .189628843674E+04 .183406340726E+04 + .177447879164E+04 .171740895648E+04 .166273476188E+04 .161034321676E+04 .156012715054E+04 + .151198490272E+04 .146582002337E+04 .142154099431E+04 .137906095998E+04 .133829747604E+04 + .129917226882E+04 .126161100972E+04 .122554310047E+04 .119090147066E+04 .115762238690E+04 + .112564527212E+04 .109491253468E+04 .106536940758E+04 .103696379654E+04 .100964613669E+04 + .983369256582E+03 .958088251357E+03 .933760361363E+03 .910344858922E+03 .887802940737E+03 + .866097626532E+03 .845193663442E+03 .825057435693E+03 .805656879371E+03 .786961401872E+03 + .768941805860E+03 .751570217559E+03 .734820018832E+03 .718665782978E+03 .703083214326E+03 + .688049090980E+03 .673541210507E+03 .659538338921E+03 .646020162215E+03 .632967240499E+03 + .620360964749E+03 .608183515718E+03 .596417825223E+03 .585047539244E+03 .574056983177E+03 + .563431128839E+03 .553155563184E+03 .543216458754E+03 .533600545498E+03 .524295084194E+03 + .515287841173E+03 .506567064354E+03 .498121460542E+03 .489940173731E+03 .482012764716E+03 + .474329191586E+03 .466879791201E+03 .459655261667E+03 .452646645612E+03 .445845314309E+03 + .439242952579E+03 .432831544450E+03 .426603359477E+03 .420550939758E+03 .414667087568E+03 + .408944853585E+03 .403377525679E+03 .397958618253E+03 .392681862072E+03 .387541194587E+03 + .382530750726E+03 .377644854114E+03 .372878008707E+03 .368224890830E+03 .363680341587E+03 + .359239359657E+03 .354897094389E+03 .350648839276E+03 .346490025719E+03 .342416217091E+03 + .338423103118E+03 .334506494502E+03 .330662317854E+03 .326886610852E+03 .323175517677E+03 + .319525284662E+03 .315932256206E+03 .312392870893E+03 .308903657842E+03 .305461233272E+03 + .302062297267E+03 .298703630762E+03 .295382092719E+03 .292094617500E+03 .288838212437E+03 + .285609955593E+03 .282406993707E+03 .279226540330E+03 .276065874141E+03 .272922337452E+03 + .269793334886E+03 .266676332242E+03 .263568855544E+03 .260468490264E+03 .257372880728E+03 + .254279729706E+03 .251186798183E+03 .248091905310E+03 .244992928548E+03 .241887803987E+03 + .238774526866E+03 .235651152274E+03 .232515796051E+03 .229366635883E+03 .226201912602E+03 + .223019931688E+03 .219819064985E+03 .216597752635E+03 .213354505238E+03 .210087906247E+03 + .206796614606E+03 .203479367655E+03 .200134984304E+03 .196762368500E+03 .193360513013E+03 + .189928503567E+03 .186465523338E+03 .182970857876E+03 .179443900479E+03 .175884158076E+03 + .172291257693E+03 .168664953559E+03 .165005134953E+03 .161311834879E+03 .157585239680E+03 + .153825699735E+03 .150033741355E+03 .146210080040E+03 .142355635261E+03 .138471546918E+03 + .134559193631E+03 .130620212984E+03 .126656523815E+03 .122670350542E+03 .118664249404E+03 + .114641136335E+03 .110604315898E+03 .106557510391E+03 .102504887754E+03 .984510863142E+02 + .944012336261E+02 .903609557846E+02 .863363724670E+02 .823340718078E+02 .783610579892E+02 + .744246633582E+02 .705324162159E+02 .666918555610E+02 .629102856287E+02 .591944669183E+02 + .555502477826E+02 .519821532120E+02 .484929672536E+02 .450833747318E+02 .417517679306E+02 + .384943726247E+02 .353058986338E+02 .321809414460E+02 .291163276325E+02 .261144334538E+02 + .231871492547E+02 .203596538297E+02 .176726025177E+02 .151810751243E+02 .129490421749E+02 + .110393419236E+02 .950085943829E+01 .835601596774E+01 .759220035195E+01 .716026979128E+01 + .698171586735E+01 .696337537316E+01 .701521042419E+01 .706481632887E+01 .706399956522E+01 + .698712622280E+01 .682461424434E+01 .657568967629E+01 .624298209986E+01 .582958804938E+01 + .533805380599E+01 .477041519949E+01 .412860165824E+01 .341481131402E+01 .263171136544E+01 + .178246368857E+01 .870634878579E+00 -.999438728779E-01 -.112531868169E+01 -.220152969452E+01 + -.332469269108E+01 -.449104609659E+01 -.569696875391E+01 -.693897492955E+01 -.821369210611E+01 + -.951782536530E+01 -.108481102767E+02 -.122012545007E+02 -.135738669876E+02 -.149623728146E+02 + -.163629115444E+02 -.177712178383E+02 -.191824854283E+02 -.205912200739E+02 -.219910944781E+02 + -.233748284178E+02 -.247341312735E+02 -.260597521130E+02 -.273417019240E+02 -.285696929862E+02 + -.297338408481E+02 -.308256300402E+02 -.318391145291E+02 -.327722934381E+02 -.336286096960E+02 + -.344184453032E+02 -.351602594335E+02 -.358801411316E+02 -.366068307978E+02 -.373574862777E+02 + -.381118849160E+02 -.387867273418E+02 -.392441857634E+02 -.393634904186E+02 -.391349287009E+02 + -.386756216504E+02 -.381417407639E+02 -.376357898778E+02 -.371876084285E+02 -.367857308718E+02 + -.364089017521E+02 -.360404072746E+02 -.356705440643E+02 -.352947736909E+02 -.349113812250E+02 + -.345198086599E+02 -.341197549222E+02 -.337108274651E+02 + core charge-density + .566100405752E-04 .603274790726E-04 .642889041986E-04 .685103164325E-04 .730087642691E-04 + .778024127357E-04 .829106163764E-04 .883539969928E-04 .941545264508E-04 .100335614880E-03 + .106922204616E-03 .113940870262E-03 .121419925256E-03 .129389535376E-03 .137881839620E-03 + .146931078955E-03 .156573733420E-03 .166848668143E-03 .177797288839E-03 .189463707397E-03 + .201894918215E-03 .215140985966E-03 .229255245539E-03 .244294514933E-03 .260319321939E-03 + .277394145493E-03 .295587672651E-03 .314973072166E-03 .335628285763E-03 .357636338214E-03 + .381085667437E-03 .406070475885E-03 .432691104597E-03 .461054431344E-03 .491274294413E-03 + .523471943665E-03 .557776520581E-03 .594325569167E-03 .633265579655E-03 .674752567074E-03 + .718952686923E-03 .766042890258E-03 .816211620710E-03 .869659556058E-03 .926600397160E-03 + .987261707239E-03 .105188580466E-02 .112073071253E-02 .119407116880E-02 .127219970037E-02 + .135542776555E-02 .144408696885E-02 .153853035261E-02 .163913377046E-02 .174629734739E-02 + .186044703187E-02 .198203624583E-02 .211154763822E-02 .224949494879E-02 .239642498860E-02 + .255291974450E-02 .271959861504E-02 .289712078585E-02 .308618775280E-02 .328754600198E-02 + .350198985578E-02 .373036449505E-02 .397356916791E-02 .423256059621E-02 .450835659128E-02 + .480203989148E-02 .511476223442E-02 .544774867755E-02 .580230218169E-02 .617980847259E-02 + .658174119662E-02 .700966738736E-02 .746525326090E-02 .795027035842E-02 .846660205552E-02 + .901625045908E-02 .960134371288E-02 .102241437348E-01 .108870544090E-01 .115926302582E-01 + .123435856218E-01 .131428043661E-01 .139933501568E-01 .148984773211E-01 .158616423311E-01 + .168865159410E-01 .179769960102E-01 .191372210475E-01 .203715845116E-01 .216847499059E-01 + .230816667048E-01 .245675871519E-01 .261480839698E-01 .278290690246E-01 .296168129868E-01 + .315179660337E-01 .335395796374E-01 .356891294839E-01 .379745395704E-01 .404042075275E-01 + .429870312127E-01 .457324366235E-01 .486504071769E-01 .517515144015E-01 .550469500898E-01 + .585485599535E-01 .622688788272E-01 .662211674610E-01 .704194509412E-01 .748785587749E-01 + .796141666712E-01 .846428400460E-01 .899820792747E-01 .956503667062E-01 .101667215451E+00 + .108053219945E+00 .114830108271E+00 .122020796239E+00 .129649443177E+00 .137741509388E+00 + .146323815234E+00 .155424601742E+00 .165073592657E+00 .175302057823E+00 .186142877738E+00 + .197630609132E+00 .209801551371E+00 .222693813452E+00 .236347381338E+00 .250804185329E+00 + .266108167138E+00 .282305346272E+00 .299443885308E+00 .317574153560E+00 .336748788604E+00 + .357022755061E+00 .378453399961E+00 .401100503966E+00 .425026327615E+00 .450295651730E+00 + .476975810973E+00 .505136719518E+00 .534850887654E+00 .566193428081E+00 .599242050517E+00 + .634077043169E+00 .670781239474E+00 .709439968420E+00 .750140986642E+00 .792974390370E+00 + .838032505174E+00 .885409751349E+00 .935202482669E+00 .987508796104E+00 .104242831002E+01 + .110006190827E+01 .116051144745E+01 .122387942461E+01 .129026860260E+01 .135978159017E+01 + .143252037390E+01 .150858579919E+01 .158807699749E+01 .167109075688E+01 .175772083353E+01 + .184805720162E+01 .194218523933E+01 .204018484914E+01 .214212951079E+01 .224808526583E+01 + .235810963304E+01 .247225045485E+01 .259054467535E+01 .271301705146E+01 .283967879975E+01 + .297052618226E+01 .310553903613E+01 .324467925296E+01 .338788921520E+01 .353509019870E+01 + .368618075190E+01 .384103506433E+01 .399950133877E+01 .416140018359E+01 .432652304404E+01 + .449463069343E+01 .466545180749E+01 .483868164752E+01 .501398088047E+01 .519097456619E+01 + .536925134438E+01 .554836285615E+01 .572782343649E+01 .590711011606E+01 .608566297177E+01 + .626288586635E+01 .643814761788E+01 .661078363938E+01 .678009808823E+01 .694536656274E+01 + .710583938103E+01 .726074547323E+01 .740929691345E+01 .755069411170E+01 .768413167876E+01 + .780880496809E+01 .792391728912E+01 .802868777438E+01 .812235987040E+01 .820421040778E+01 + .827355919064E+01 .832977902881E+01 .837230611874E+01 .840065066096E+01 .841440758325E+01 + .841326722016E+01 .839702578152E+01 .836559542526E+01 .831901373419E+01 .825745238298E+01 + .818122477058E+01 .809079238605E+01 .798676967249E+01 .786992715557E+01 .774119261011E+01 + .760165005169E+01 .745253636003E+01 .729523536819E+01 .713126928576E+01 .696228736593E+01 + .679005177517E+01 .661642067944E+01 .644332862203E+01 .627276433335E+01 .610674618159E+01 + .594729554133E+01 .579640842184E+01 .565602576681E+01 .552800287068E+01 .541407839925E+01 + .531584353892E+01 .523471177953E+01 .517188984282E+01 .512835026211E+01 .510480613184E+01 + .510168858572E+01 .511912762968E+01 .515693703459E+01 .521460405617E+01 .529128475754E+01 + .538580562001E+01 .549667189770E+01 .562208280769E+01 .575995323743E+01 .590794134470E+01 + .606348131935E+01 .622382063669E+01 .638606123530E+01 .654720408632E+01 .670419655739E+01 + .685398184633E+01 .699354961718E+01 .711998685544E+01 .723052788809E+01 .732260249172E+01 + .739388103439E+01 .744231565540E+01 .746617657427E+01 .746408272963E+01 .743502607482E+01 + .737838899666E+01 .729395447390E+01 .718190874815E+01 .704283644131E+01 .687770821462E+01 + .668786122365E+01 .647497277612E+01 .624102774402E+01 .598828041327E+01 .571921157222E+01 + .543648174187E+01 .514288153425E+01 .484128019032E+01 .453457339482E+01 .422563149315E+01 + .391724924503E+01 .361209824281E+01 .331268309860E+01 .302130245731E+01 .274001582420E+01 + .247061708263E+01 .221461541805E+01 .197322413413E+01 .174735759662E+01 .153763606876E+01 + .134439807766E+01 .116771931577E+01 .100743688382E+01 .863177180939E+00 .734385201328E+00 + .620352489207E+00 .520241312105E+00 .433105012361E+00 .357908953755E+00 .293558971531E+00 + .238939332961E+00 .192952602310E+00 .154550561105E+00 .122752025089E+00 .966509456742E-01 + .754197389551E-01 .583105713293E-01 .446553155083E-01 .338641489723E-01 .254227504169E-01 + .188882123217E-01 .138839144900E-01 .100936595806E-01 + kinetic energy-density + .667223264162E+01 .673711797765E+01 .680446051695E+01 .687434851945E+01 .694687595542E+01 + .702214224715E+01 .710025264340E+01 .718131851959E+01 .726545770326E+01 .735279480889E+01 + .744346157547E+01 .753759722098E+01 .763534880551E+01 .773687160651E+01 .784232950769E+01 + .795189540556E+01 .806575163262E+01 .818409040251E+01 .830711427710E+01 .843503666033E+01 + .856808232008E+01 .870648794174E+01 .885050271727E+01 .900038897044E+01 .915642282528E+01 + .931889491632E+01 .948811114834E+01 .966439350589E+01 .984808091773E+01 .100395301784E+02 + .102391169326E+02 .104472367229E+02 .106643061077E+02 .108907638526E+02 .111270721976E+02 + .113737182071E+02 .116312152061E+02 .119001043069E+02 .121809560330E+02 .124743720445E+02 + .127809869719E+02 .131014703626E+02 .134365287498E+02 .137869078483E+02 .141533948854E+02 + .145368210760E+02 .149380642484E+02 .153580516325E+02 .157977628176E+02 .162582328917E+02 + .167405557713E+02 .172458877376E+02 .177754511847E+02 .183305385986E+02 .189125167802E+02 + .195228313211E+02 .201630113570E+02 .208346746071E+02 .215395327218E+02 .222793969540E+02 + .230561841768E+02 .238719232645E+02 .247287618625E+02 .256289735654E+02 .265749655308E+02 + .275692865534E+02 .286146356255E+02 .297138710144E+02 .308700198863E+02 .320862885081E+02 + .333660730613E+02 .347129711045E+02 .361307937197E+02 .376235783832E+02 .391956026049E+02 + .408513983733E+02 .425957674600E+02 .444337976250E+02 .463708797814E+02 .484127261615E+02 + .505653895529E+02 .528352836548E+02 .552292046175E+02 .577543538336E+02 .604183620400E+02 + .632293148117E+02 .661957795124E+02 .693268337816E+02 .726320956402E+02 .761217552952E+02 + .798066087313E+02 .836980931813E+02 .878083245648E+02 .921501369964E+02 .967371244646E+02 + .101583684778E+03 .106705065895E+03 .112117414743E+03 .117837828637E+03 .123884409424E+03 + .130276320461E+03 .137033846552E+03 .144178456977E+03 .151732871716E+03 .159721131020E+03 + .168168668441E+03 .177102387447E+03 .186550741762E+03 .196543819548E+03 .207113431542E+03 + .218293203301E+03 .230118671632E+03 .242627385346E+03 .255859010429E+03 .269855439723E+03 + .284660907211E+03 .300322106967E+03 .316888316840E+03 .334411526903E+03 .352946572698E+03 + .372551273268E+03 .393286573957E+03 .415216693909E+03 .438409278191E+03 .462935554406E+03 + .488870493624E+03 .516292975418E+03 .545285956739E+03 .575936644299E+03 .608336670067E+03 + .642582269425E+03 .678774461430E+03 .717019230563E+03 .757427709234E+03 .800116360219E+03 + .845207158092E+03 .892827768584E+03 .943111724662E+03 .996198598018E+03 .105223416443E+04 + .111137056136E+04 .117376643592E+04 .123958708122E+04 .130900455875E+04 .138219780446E+04 + .145935271573E+04 .154066221641E+04 .162632629657E+04 .171655202365E+04 .181155352120E+04 + .191155191114E+04 .201677521519E+04 .212745821087E+04 .224384223707E+04 .236617494387E+04 + .249470998100E+04 .262970661903E+04 .277142929698E+04 .292014708990E+04 .307613308942E+04 + .323966369031E+04 .341101777559E+04 .359047579274E+04 .377831871320E+04 .397482686744E+04 + .418027864771E+04 .439494907065E+04 .461910819220E+04 .485301936717E+04 .509693734651E+04 + .535110620572E+04 .561575709823E+04 .589110582872E+04 .617735024215E+04 .647466742549E+04 + .678321072048E+04 .710310654759E+04 .743445104313E+04 .777730651347E+04 .813169771335E+04 + .849760795736E+04 .887497507731E+04 .926368724144E+04 .966357865505E+04 .100744251666E+05 + .104959398071E+05 .109277682965E+05 .113694845538E+05 .118205862555E+05 .122804904900E+05 + .127485295625E+05 .132239470112E+05 .137058938992E+05 .141934254546E+05 .146854981352E+05 + .151809671997E+05 .156785848725E+05 .161769991918E+05 .166747536369E+05 .171702876279E+05 + .176619379985E+05 .181479415367E+05 .186264386884E+05 .190954785183E+05 .195530250094E+05 + .199969647834E+05 .204251163067E+05 .208352406373E+05 .212250537526E+05 .215922404774E+05 + .219344700116E+05 .222494130342E+05 .225347603288E+05 .227882428528E+05 .230076531342E+05 + .231908678498E+05 .233358714016E+05 .234407802719E+05 .235038678982E+05 .235235897755E+05 + .234986084530E+05 .234278180618E+05 .233103679754E+05 .231456851799E+05 .229334949056E+05 + .226738390590E+05 .223670919806E+05 .220139730591E+05 .216155557379E+05 .211732724746E+05 + .206889152456E+05 .201646312393E+05 .196029134408E+05 .190065858947E+05 .183787835298E+05 + .177229265428E+05 .170426894747E+05 .163419652635E+05 .156248247191E+05 .148954720435E+05 + .141581971857E+05 .134173261542E+05 .126771693102E+05 .119419713654E+05 .112158605938E+05 + .105028007380E+05 .980654499989E+04 .913059236999E+04 .847814611827E+04 .785207438837E+04 + .725487344929E+04 .668863511301E+04 .615502069364E+04 .565524417361E+04 .519006672766E+04 + .475980357784E+04 .436434266402E+04 .400317320563E+04 .367542131406E+04 .337988973053E+04 + .311509948092E+04 .287933226802E+04 .267067318949E+04 .248705363715E+04 .232629412847E+04 + .218614659385E+04 .206433545994E+04 .195859678351E+04 .186671469198E+04 .178655445016E+04 + .171609157853E+04 .165343658116E+04 .159685499112E+04 .154478259599E+04 .149583585719E+04 + .144881767535E+04 .140271877451E+04 .135671507596E+04 .131016150708E+04 .126258274155E+04 + .121366139499E+04 .116322420862E+04 .111122674356E+04 .105773708455E+04 .100291901627E+04 + .947015091482E+03 .890329959869E+03 .833214272270E+03 .776049418457E+03 .719233299337E+03 + .663167278558E+03 .608244406410E+03 .554838966220E+03 .503297358442E+03 .453930336633E+03 + .407006601755E+03 .362747806752E+03 .321325033168E+03 .282856907413E+03 .247409252478E+03 + .214996590257E+03 .185585245619E+03 .159098177908E+03 .135421633456E+03 .114413857777E+03 + .959157099433E+02 .797613979036E+02 .657850515169E+02 .538188522131E+02 .436847873034E+02 + .351899916323E+02 .281331203679E+02 .223174729841E+02 .175614967879E+02 .137029357329E+02 + .105987319431E+02 .812353742881E+01 .616817860109E+01 .463832203023E+01 .345324816958E+01 + .254463542651E+01 .185531926861E+01 .133803588607E+01 + pspotential + -.284668580974E+02 -.284683169301E+02 -.284697298194E+02 -.284710982122E+02 -.284724235102E+02 + -.284737070698E+02 -.284749502063E+02 -.284761541924E+02 -.284773202611E+02 -.284784496066E+02 + -.284795433857E+02 -.284806027180E+02 -.284816286891E+02 -.284826223489E+02 -.284835847157E+02 + -.284845167748E+02 -.284854194805E+02 -.284862937574E+02 -.284871405012E+02 -.284879605786E+02 + -.284887548297E+02 -.284895240675E+02 -.284902690805E+02 -.284909906311E+02 -.284916894586E+02 + -.284923662782E+02 -.284930217837E+02 -.284936566461E+02 -.284942715156E+02 -.284948670220E+02 + -.284954437749E+02 -.284960023654E+02 -.284965433652E+02 -.284970673288E+02 -.284975747926E+02 + -.284980662764E+02 -.284985422834E+02 -.284990033014E+02 -.284994498023E+02 -.284998822437E+02 + -.285003010685E+02 -.285007067055E+02 -.285010995703E+02 -.285014800653E+02 -.285018485803E+02 + -.285022054928E+02 -.285025511684E+02 -.285028859612E+02 -.285032102143E+02 -.285035242597E+02 + -.285038284193E+02 -.285041230047E+02 -.285044083177E+02 -.285046846506E+02 -.285049522867E+02 + -.285052115003E+02 -.285054625570E+02 -.285057057141E+02 -.285059412208E+02 -.285061693187E+02 + -.285063902416E+02 -.285066042160E+02 -.285068114613E+02 -.285070121901E+02 -.285072066083E+02 + -.285073949154E+02 -.285075773047E+02 -.285077539632E+02 -.285079250725E+02 -.285080908082E+02 + -.285082513405E+02 -.285084068344E+02 -.285085574497E+02 -.285087033412E+02 -.285088446592E+02 + -.285089815489E+02 -.285091141512E+02 -.285092426028E+02 -.285093670362E+02 -.285094875796E+02 + -.285096043574E+02 -.285097174903E+02 -.285098270953E+02 -.285099332857E+02 -.285100361716E+02 + -.285101358596E+02 -.285102324533E+02 -.285103260530E+02 -.285104167563E+02 -.285105046579E+02 + -.285105898494E+02 -.285106724202E+02 -.285107524569E+02 -.285108300437E+02 -.285109052623E+02 + -.285109781925E+02 -.285110489115E+02 -.285111174947E+02 -.285111840153E+02 -.285112485448E+02 + -.285113111527E+02 -.285113719068E+02 -.285114308734E+02 -.285114881171E+02 -.285115437009E+02 + -.285115976866E+02 -.285116501346E+02 -.285117011040E+02 -.285117506529E+02 -.285117988383E+02 + -.285118457160E+02 -.285118913411E+02 -.285119357679E+02 -.285119790499E+02 -.285120212399E+02 + -.285120623903E+02 -.285121025528E+02 -.285121417791E+02 -.285121801201E+02 -.285122176271E+02 + -.285122543509E+02 -.285122903425E+02 -.285123256531E+02 -.285123603339E+02 -.285123944366E+02 + -.285124280136E+02 -.285124611175E+02 -.285124938019E+02 -.285125261211E+02 -.285125581306E+02 + -.285125898869E+02 -.285126214480E+02 -.285126528730E+02 -.285126842231E+02 -.285127155610E+02 + -.285127469515E+02 -.285127784618E+02 -.285128101613E+02 -.285128421220E+02 -.285128744192E+02 + -.285129071308E+02 -.285129403386E+02 -.285129741276E+02 -.285130085872E+02 -.285130438109E+02 + -.285130798969E+02 -.285131169482E+02 -.285131550734E+02 -.285131943868E+02 -.285132350088E+02 + -.285132770666E+02 -.285133206943E+02 -.285133660339E+02 -.285134132352E+02 -.285134624572E+02 + -.285135138679E+02 -.285135676456E+02 -.285136239791E+02 -.285136830688E+02 -.285137451272E+02 + -.285138103801E+02 -.285138790671E+02 -.285139514428E+02 -.285140277778E+02 -.285141083597E+02 + -.285141934943E+02 -.285142835068E+02 -.285143787430E+02 -.285144795711E+02 -.285145863826E+02 + -.285146995943E+02 -.285148196500E+02 -.285149470220E+02 -.285150822131E+02 -.285152257590E+02 + -.285153782298E+02 -.285155402330E+02 -.285157124155E+02 -.285158954666E+02 -.285160901204E+02 + -.285162971590E+02 -.285165174159E+02 -.285167517787E+02 -.285170011938E+02 -.285172666691E+02 + -.285175492789E+02 -.285178501680E+02 -.285181705563E+02 -.285185117440E+02 -.285188751165E+02 + -.285192621507E+02 -.285196744202E+02 -.285201136023E+02 -.285205814849E+02 -.285210799732E+02 + -.285216110981E+02 -.285221770239E+02 -.285227800576E+02 -.285234226581E+02 -.285241074462E+02 + -.285248372152E+02 -.285256149423E+02 -.285264438010E+02 -.285273271733E+02 -.285282686643E+02 + -.285292721163E+02 -.285303416243E+02 -.285314815531E+02 -.285326965547E+02 -.285339915870E+02 + -.285353719343E+02 -.285368432283E+02 -.285384114710E+02 -.285400830591E+02 -.285418648095E+02 + -.285437639871E+02 -.285457883340E+02 -.285479461006E+02 -.285502460786E+02 -.285526976368E+02 + -.285553107581E+02 -.285580960799E+02 -.285610649366E+02 -.285642294047E+02 -.285676023510E+02 + -.285711974839E+02 -.285750294079E+02 -.285791136815E+02 -.285834668789E+02 -.285881066552E+02 + -.285930518163E+02 -.285983223931E+02 -.286039397193E+02 -.286099265159E+02 -.286163069793E+02 + -.286231068758E+02 -.286303536416E+02 -.286380764889E+02 -.286463065191E+02 -.286550768420E+02 + -.286644227033E+02 -.286743816188E+02 -.286849935181E+02 -.286963008955E+02 -.287083489715E+02 + -.287211858626E+02 -.287348627628E+02 -.287494341353E+02 -.287649579152E+02 -.287814957256E+02 + -.287991131063E+02 -.288178797557E+02 -.288378697884E+02 -.288591620081E+02 -.288818401970E+02 + -.289059934240E+02 -.289317163713E+02 -.289591096822E+02 -.289882803316E+02 -.290193420199E+02 + -.290524155945E+02 -.290876294986E+02 -.291251202524E+02 -.291650329680E+02 -.292075219026E+02 + -.292527510523E+02 -.293008947930E+02 -.293521385709E+02 -.294066796496E+02 -.294647279184E+02 + -.295265067689E+02 -.295922540467E+02 -.296622230833E+02 -.297366838166E+02 -.298159240051E+02 + -.299002505394E+02 -.299899908538E+02 -.300854944348E+02 -.301871344177E+02 -.302953092527E+02 + -.304104444074E+02 -.305329940542E+02 -.306634426595E+02 -.308023063576E+02 -.309501339324E+02 + -.311075071620E+02 -.312750401800E+02 -.314533773784E+02 -.316431892087E+02 -.318451650241E+02 + -.320600018433E+02 -.322883876156E+02 -.325309772422E+02 -.327883593234E+02 -.330610114486E+02 + -.333492420108E+02 -.336531172581E+02 -.339723739182E+02 -.343063205135E+02 -.346537343042E+02 + -.350127645096E+02 -.353808527148E+02 -.357546711895E+02 -.361300477034E+02 -.365017781319E+02 + -.368631244736E+02 -.372047033483E+02 -.375125520335E+02 -.377657440182E+02 -.379353182676E+02 + -.379879388728E+02 -.378969924352E+02 -.376572675510E+02 -.372895576252E+02 -.368609887562E+02 + -.364580390768E+02 -.360705398248E+02 -.356893343561E+02 -.353112759338E+02 -.349371692255E+02 + -.345669009212E+02 -.341257373489E+02 -.337108274651E+02 + core charge-density (pseudized) + .158850907132E-07 .169349744559E-07 .180542475326E-07 .192474960507E-07 .205196092244E-07 + .218757994079E-07 .233216234522E-07 .248630054739E-07 .265062611287E-07 .282581234892E-07 + .301257706327E-07 .321168550529E-07 .342395350151E-07 .365025079838E-07 .389150462599E-07 + .414870349726E-07 .442290125832E-07 .471522140648E-07 .502686169368E-07 .535909903417E-07 + .571329473648E-07 .609090008129E-07 .649346226787E-07 .692263075359E-07 .738016401239E-07 + .786793673994E-07 .838794753501E-07 .894232708855E-07 .953334691390E-07 .101634286542E-06 + .108351540046E-06 .115512752907E-06 .123147267460E-06 .131286365342E-06 .139963395669E-06 + .149213911678E-06 .159075816404E-06 .169589517985E-06 .180798095227E-06 .192747474115E-06 + .205486615992E-06 .219067718171E-06 .233546427810E-06 .248982069915E-06 .265437890425E-06 + .282981315349E-06 .301684227038E-06 .321623258718E-06 .342880108482E-06 .365541874040E-06 + .389701409594E-06 .415457706293E-06 .442916297843E-06 .472189692914E-06 .503397836133E-06 + .536668599544E-06 .572138306547E-06 .609952290465E-06 .650265490033E-06 .693243084236E-06 + .739061169114E-06 .787907479286E-06 .839982157176E-06 .895498573063E-06 .954684199344E-06 + .101778154256E-05 .108504913706E-05 .115676260427E-05 .123321578204E-05 .131472192859E-05 + .140161500606E-05 .149425104883E-05 .159300962235E-05 .169829537834E-05 .181053971277E-05 + .193020253346E-05 .205777414445E-05 .219377725496E-05 .233876912105E-05 .249334382893E-05 + .265813472909E-05 .283381703132E-05 .302111057124E-05 .322078275972E-05 .343365172714E-05 + .366058967549E-05 .390252645204E-05 .416045335916E-05 .443542721593E-05 .472857468816E-05 + .504109690465E-05 .537427437842E-05 .572947225328E-05 .610814589706E-05 .651184686453E-05 + .694222925437E-05 .740105648627E-05 .789020852588E-05 .841168958728E-05 .896763634441E-05 + .956032668519E-05 .101921890442E-04 .108658123520E-04 .115839566421E-04 .123495643585E-04 + .131657724114E-04 .140359250280E-04 .149635874541E-04 .159525605604E-04 .170068964137E-04 + .181309148776E-04 .193292213099E-04 .206067254291E-04 .219686614285E-04 .234206094181E-04 + .249685182840E-04 .266187300582E-04 .283780058984E-04 .302535537841E-04 .322530580431E-04 + .343847108279E-04 .366572456728E-04 .390799732669E-04 .416628195906E-04 .444163665717E-04 + .473518954273E-04 .504814328676E-04 .538178003533E-04 .573746666051E-04 .611666035821E-04 + .652091461570E-04 .695188557326E-04 .741133880594E-04 .790115655314E-04 .842334542561E-04 + .898004462130E-04 .957353468361E-04 .102062468380E-03 .108807729446E-03 .115998761083E-03 + .123665019889E-03 .131837908571E-03 .140550904475E-03 .149839696579E-03 .159742331544E-03 + .170299369380E-03 .181554049396E-03 .193552467086E-03 .206343762684E-03 .219980322147E-03 + .234517991391E-03 .250016304646E-03 .266538727861E-03 .284152918146E-03 .302931000300E-03 + .322949861560E-03 .344291465748E-03 .367043188107E-03 .391298172159E-03 .417155710061E-03 + .444721647953E-03 .474108817981E-03 .505437498701E-03 .538835905735E-03 .574440714657E-03 + .612397618202E-03 .652861920041E-03 .695999167499E-03 .741985825749E-03 .791009996188E-03 + .843272181843E-03 .898986102869E-03 .958379565380E-03 .102169538706E-02 .108919238320E-02 + .116114641712E-02 .123785151900E-02 .131962107766E-02 .140678910979E-02 .149971161181E-02 + .159876799938E-02 .170436264031E-02 .181692648675E-02 .193691881296E-02 .206482906523E-02 + .220117883122E-02 .234652393586E-02 .250145667215E-02 .266660817484E-02 .284265094610E-02 + .303030154244E-02 .323032343282E-02 .344353003832E-02 .367078796445E-02 .391302043770E-02 + .417121095843E-02 .444640718317E-02 .473972504961E-02 .505235315859E-02 .538555742793E-02 + .574068603353E-02 .611917465425E-02 .652255203717E-02 .695244590122E-02 .741058919732E-02 + .789882674413E-02 .841912225897E-02 .897356580441E-02 .956438167099E-02 .101939367177E-01 + .108647491919E-01 .115794980501E-01 .123410328028E-01 .131523839044E-01 .140167737110E-01 + .149376280269E-01 .159185882611E-01 .169635242136E-01 .180765475092E-01 .192620256957E-01 + .205245970213E-01 .218691859007E-01 .233010190786E-01 .248256424935E-01 .264489388384E-01 + .281771458098E-01 .300168750282E-01 .319751316050E-01 .340593343169E-01 .362773363404E-01 + .386374464823E-01 .411484508237E-01 .438196346781E-01 .466608047400E-01 .496823112734E-01 + .528950701615E-01 .563105846042E-01 .599409662088E-01 .637989551781E-01 .678979392487E-01 + .722519709725E-01 .768757828747E-01 .817847999463E-01 .869951488479E-01 .925236631107E-01 + .983878835213E-01 .104606052760E+00 .111197103239E+00 .118180636950E+00 .125576895976E+00 + .133406722150E+00 .141691504177E+00 .150453110317E+00 .159713804529E+00 .169496143740E+00 + .179822853659E+00 .190716680317E+00 .202200214208E+00 .214295683694E+00 .227024713996E+00 + .240408047883E+00 .254465223863E+00 .269214207487E+00 .284670971153E+00 .300849017672E+00 + .317758842779E+00 .335407331821E+00 .353797086014E+00 .372925673998E+00 .392784804976E+00 + .413359420546E+00 .434626703479E+00 .456555003242E+00 .479102680107E+00 .502216872244E+00 + .525832193516E+00 .549869373680E+00 .574233857642E+00 .598814386387E+00 .623481589187E+00 + .648086625061E+00 .672459920978E+00 .696410065316E+00 .719722927378E+00 .742161087375E+00 + .763463676005E+00 .783346738217E+00 .801504251502E+00 .817609944243E+00 .831320073323E+00 + .842277330789E+00 .850116055018E+00 .854468920152E+00 .854975265373E+00 .851291199249E+00 + .843101569433E+00 .830133819226E+00 .812173654295E+00 .789082308931E+00 .760815025548E+00 + .727440137991E+00 .689157874534E+00 .646317668655E+00 .599432387566E+00 .549187469489E+00 + .496442519212E+00 .442222478719E+00 .387695112852E+00 .334131296257E+00 .282844548501E+00 + .235106556397E+00 .192036190812E+00 .154460937507E+00 .122751901168E+00 .966509456742E-01 + .754197389551E-01 .583105713293E-01 .446553155083E-01 .338641489723E-01 .254227504169E-01 + .188882123217E-01 .138839144900E-01 .100936595806E-01 + pseudo wavefunction + .575355356415E-04 .594064477253E-04 .613381972024E-04 .633327623533E-04 .653921857868E-04 + .675185765325E-04 .697141122004E-04 .719810412106E-04 .743216850967E-04 .767384408824E-04 + .792337835369E-04 .818102685089E-04 .844705343442E-04 .872173053874E-04 .900533945721E-04 + .929817063013E-04 .960052394220E-04 .991270902962E-04 .102350455972E-03 .105678637457E-03 + .109115043101E-03 .112663192082E-03 .116326718016E-03 .120109372672E-03 .124015029819E-03 + .128047689192E-03 .132211480586E-03 .136510668086E-03 .140949654437E-03 .145532985548E-03 + .150265355149E-03 .155151609602E-03 .160196752857E-03 .165405951581E-03 .170784540448E-03 + .176338027603E-03 .182072100302E-03 .187992630735E-03 .194105682043E-03 .200417514522E-03 + .206934592042E-03 .213663588656E-03 .220611395446E-03 .227785127571E-03 .235192131559E-03 + .242839992828E-03 .250736543454E-03 .258889870194E-03 .267308322765E-03 .276000522397E-03 + .284975370659E-03 .294242058578E-03 .303810076049E-03 .313689221556E-03 .323889612204E-03 + .334421694082E-03 .345296252956E-03 .356524425323E-03 .368117709807E-03 .380087978939E-03 + .392447491317E-03 .405208904153E-03 .418385286245E-03 .431990131351E-03 .446037372013E-03 + .460541393824E-03 .475517050162E-03 .490979677395E-03 .506945110594E-03 .523429699744E-03 + .540450326492E-03 .558024421429E-03 .576169981949E-03 .594905590672E-03 .614250434477E-03 + .634224324152E-03 .654847714681E-03 .676141726189E-03 .698128165574E-03 .720829548839E-03 + .744269124145E-03 .768470895626E-03 .793459647966E-03 .819260971781E-03 .845901289826E-03 + .873407884057E-03 .901808923562E-03 .931133493415E-03 .961411624459E-03 .992674324057E-03 + .102495360785E-02 .105828253254E-02 .109269522973E-02 .112822694092E-02 .116491405352E-02 + .120279413821E-02 .124190598731E-02 .128228965460E-02 .132398649626E-02 .136703921328E-02 + .141149189515E-02 .145739006503E-02 .150478072633E-02 .155371241090E-02 .160423522870E-02 + .165640091909E-02 .171026290385E-02 .176587634186E-02 .182329818560E-02 .188258723945E-02 + .194380421993E-02 .200701181784E-02 .207227476250E-02 .213965988796E-02 .220923620153E-02 + .228107495436E-02 .235524971443E-02 .243183644189E-02 .251091356682E-02 .259256206952E-02 + .267686556349E-02 .276391038097E-02 .285378566135E-02 .294658344250E-02 .304239875489E-02 + .314132971901E-02 .324347764574E-02 .334894714010E-02 .345784620834E-02 .357028636854E-02 + .368638276474E-02 .380625428484E-02 .393002368229E-02 .405781770175E-02 .418976720886E-02 + .432600732415E-02 .446667756139E-02 .461192197039E-02 .476188928438E-02 .491673307231E-02 + .507661189599E-02 .524168947234E-02 .541213484098E-02 .558812253715E-02 .576983277035E-02 + .595745160873E-02 .615117116944E-02 .635118981518E-02 .655771235717E-02 .677095026461E-02 + .699112188101E-02 .721845264752E-02 .745317533347E-02 .769553027439E-02 .794576561781E-02 + .820413757691E-02 .847091069247E-02 .874635810329E-02 .903076182533E-02 .932441303995E-02 + .962761239135E-02 .994067029381E-02 .102639072487E-01 .105976541719E-01 .109422527315E-01 + .112980556968E-01 .116654272983E-01 .120447435995E-01 .124363928804E-01 .128407760336E-01 + .132583069731E-01 .136894130563E-01 .141345355194E-01 .145941299272E-01 .150686666365E-01 + .155586312758E-01 .160645252384E-01 .165868661936E-01 .171261886122E-01 .176830443099E-01 + .182580030081E-01 .188516529119E-01 .194646013071E-01 .200974751761E-01 .207509218330E-01 + .214256095793E-01 .221222283799E-01 .228414905610E-01 .235841315294E-01 .243509105150E-01 + .251426113360E-01 .259600431889E-01 .268040414619E-01 .276754685752E-01 .285752148462E-01 + .295041993818E-01 .304633709985E-01 .314537091706E-01 .324762250072E-01 .335319622594E-01 + .346219983579E-01 .357474454814E-01 .369094516585E-01 .381092019006E-01 .393479193701E-01 + .406268665822E-01 .419473466418E-01 .433107045170E-01 .447183283484E-01 .461716507967E-01 + .476721504277E-01 .492213531363E-01 .508208336098E-01 .524722168313E-01 .541771796234E-01 + .559374522328E-01 .577548199563E-01 .596311248087E-01 .615682672319E-01 .635682078464E-01 + .656329692451E-01 .677646378278E-01 .699653656785E-01 .722373724825E-01 .745829474842E-01 + .770044514849E-01 .795043188773E-01 .820850597180E-01 .847492618341E-01 .874995929625E-01 + .903388029198E-01 .932697257982E-01 .962952821862E-01 .994184814074E-01 .102642423774E+00 + .105970302852E+00 .109405407722E+00 .112951125248E+00 .116610942317E+00 .120388448077E+00 + .124287336121E+00 .128311406648E+00 .132464568547E+00 .136750841429E+00 .141174357551E+00 + .145739363643E+00 .150450222608E+00 .155311415056E+00 .160327540676E+00 .165503319382E+00 + .170843592230E+00 .176353322051E+00 .182037593757E+00 .187901614291E+00 .193950712150E+00 + .200190336440E+00 .206626055381E+00 .213263554212E+00 .220108632399E+00 .227167200068E+00 + .234445273557E+00 .241948969987E+00 .249684500724E+00 .257658163593E+00 .265876333703E+00 + .274345452710E+00 .283072016330E+00 .292062559898E+00 .301323641738E+00 .310861824101E+00 + .320683651362E+00 .330795625188E+00 .341204176307E+00 .351915632491E+00 .362936182330E+00 + .374271834305E+00 .385928370642E+00 .397911295339E+00 .410225775742E+00 .422876576925E+00 + .435867988095E+00 .449203740138E+00 .462886913351E+00 .476919834292E+00 .491303960597E+00 + .506039752485E+00 .521126529587E+00 .536562311577E+00 .552343640997E+00 .568465386534E+00 + .584920524858E+00 .601699899070E+00 .618791951638E+00 .636182429658E+00 .653854060191E+00 + .671786193400E+00 .689954411226E+00 .708330099434E+00 .726879981021E+00 .745565609229E+00 + .764342818847E+00 .783161135014E+00 .801963139531E+00 .820683795679E+00 .839249733873E+00 + .857578502086E+00 .875577787069E+00 .893144614848E+00 .910164542018E+00 .926510852941E+00 + .942043782108E+00 .956609785792E+00 .970040892551E+00 .982154168203E+00 .992751337468E+00 + .100161861137E+01 .100852677652E+01 .101323160906E+01 .101547468225E+01 .101498464091E+01 + .101147901878E+01 .100466111560E+01 .994375951175E+00 + ae wavefunction + .723210491674E-03 .746578583504E-03 .770700951777E-03 .795601892046E-03 .821306479222E-03 + .847840592364E-03 .875230940233E-03 .903505087646E-03 .932691482648E-03 .962819484530E-03 + .993919392710E-03 .102602247652E-02 .105916100589E-02 .109336828301E-02 .112867867496E-02 + .116512764731E-02 .120275179882E-02 .124158889712E-02 .128167791559E-02 .132305907123E-02 + .136577386383E-02 .140986511623E-02 .145537701585E-02 .150235515746E-02 .155084658728E-02 + .160089984836E-02 .165256502735E-02 .170589380272E-02 .176093949434E-02 .181775711461E-02 + .187640342107E-02 .193693697064E-02 .199941817539E-02 .206390935997E-02 .213047482081E-02 + .219918088694E-02 .227009598271E-02 .234329069219E-02 .241883782559E-02 .249681248751E-02 + .257729214718E-02 .266035671067E-02 .274608859525E-02 .283457280576E-02 .292589701322E-02 + .302015163557E-02 .311742992074E-02 .321782803195E-02 .332144513543E-02 .342838349055E-02 + .353874854230E-02 .365264901643E-02 .377019701702E-02 .389150812670E-02 .401670150953E-02 + .414590001658E-02 .427923029422E-02 .441682289522E-02 .455881239271E-02 .470533749697E-02 + .485654117518E-02 .501257077409E-02 .517357814572E-02 .533971977604E-02 .551115691676E-02 + .568805572017E-02 .587058737709E-02 .605892825797E-02 .625326005711E-02 .645376994004E-02 + .666065069409E-02 .687410088207E-02 .709432499912E-02 .732153363272E-02 .755594362580E-02 + .779777824289E-02 .804726733939E-02 .830464753379E-02 .857016238277E-02 .884406255928E-02 + .912660603329E-02 .941805825521E-02 .971869234197E-02 .100287892654E-01 .103486380429E-01 + .106785359304E-01 .110187886169E-01 .113697104211E-01 .117316244893E-01 .121048629944E-01 + .124897673360E-01 .128866883414E-01 .132959864662E-01 .137180319953E-01 .141532052432E-01 + .146018967537E-01 .150645074973E-01 .155414490675E-01 .160331438739E-01 .165400253324E-01 + .170625380517E-01 .176011380142E-01 .181562927528E-01 .187284815203E-01 .193181954522E-01 + .199259377210E-01 .205522236809E-01 .211975810029E-01 .218625497970E-01 .225476827224E-01 + .232535450820E-01 .239807149024E-01 .247297829946E-01 .255013529962E-01 .262960413920E-01 + .271144775113E-01 .279573034995E-01 .288251742619E-01 .297187573775E-01 .306387329797E-01 + .315857936016E-01 .325606439823E-01 .335640008323E-01 .345965925527E-01 .356591589072E-01 + .367524506409E-01 .378772290432E-01 .390342654498E-01 .402243406813E-01 .414482444099E-01 + .427067744540E-01 .440007359916E-01 .453309406888E-01 .466982057375E-01 .481033527959E-01 + .495472068255E-01 .510305948176E-01 .525543444026E-01 .541192823346E-01 .557262328435E-01 + .573760158460E-01 .590694450081E-01 .608073256492E-01 .625904524789E-01 .644196071575E-01 + .662955556690E-01 .682190454976E-01 .701908025956E-01 .722115281337E-01 .742818950192E-01 + .764025441734E-01 .785740805545E-01 .807970689137E-01 .830720292724E-01 .853994321068E-01 + .877796932277E-01 .902131683422E-01 .927001472824E-01 .952408478902E-01 .978354095427E-01 + .100483886305E+00 .103186239701E+00 .105942331082E+00 .108751913586E+00 .111614623678E+00 + .114529972255E+00 .117497335304E+00 .120515944107E+00 .123584874990E+00 .126703038594E+00 + .129869168677E+00 .133081810436E+00 .136339308348E+00 .139639793532E+00 .142981170636E+00 + .146361104253E+00 .149777004875E+00 .153226014404E+00 .156704991228E+00 .160210494897E+00 + .163738770409E+00 .167285732154E+00 .170846947546E+00 .174417620387E+00 .177992574025E+00 + .181566234348E+00 .185132612703E+00 .188685288794E+00 .192217393669E+00 .195721592871E+00 + .199190069873E+00 .202614509914E+00 .205986084362E+00 .209295435754E+00 .212532663666E+00 + .215687311579E+00 .218748354949E+00 .221704190648E+00 .224542628026E+00 .227250881804E+00 + .229815567059E+00 .232222696565E+00 .234457680772E+00 .236505330719E+00 .238349864209E+00 + .239974915563E+00 .241363549317E+00 .242498278209E+00 .243361085852E+00 .243933454457E+00 + .244196398032E+00 .244130501447E+00 .243715965781E+00 .242932660377E+00 .241760182005E+00 + .240177921559E+00 .238165138679E+00 .235701044686E+00 .232764894196E+00 .229336085751E+00 + .225394271769E+00 .220919478069E+00 .215892233186E+00 .210293707615E+00 .204105863065E+00 + .197311611722E+00 .189894985412E+00 .181841314484E+00 .173137416083E+00 .163771791405E+00 + .153734831344E+00 .143019029848E+00 .131619204110E+00 .119532720583E+00 .106759725623E+00 + .933033793783E-01 .791700913290E-01 .643697556467E-01 .489159842705E-01 .328263352823E-01 + .161225338086E-01 -.116931769311E-02 -.190185432589E-01 -.373897150652E-01 -.562424965567E-01 + -.755315101746E-01 -.952062316141E-01 -.115210910670E+00 -.135484516518E+00 -.155960703517E+00 + -.176567793429E+00 -.197228772403E+00 -.217861306439E+00 -.238377786432E+00 -.258685421094E+00 + -.278686400098E+00 -.298278147634E+00 -.317353677390E+00 -.335802046575E+00 -.353508895291E+00 + -.370357053514E+00 -.386227201622E+00 -.400998577469E+00 -.414549728634E+00 -.426759310469E+00 + -.437506929404E+00 -.446674028239E+00 -.454144807390E+00 -.459807173979E+00 -.463553709570E+00 + -.465282646961E+00 -.464898846615E+00 -.462314763759E+00 -.457451397642E+00 -.450239215005E+00 + -.440619040214E+00 -.428542904958E+00 -.413974850650E+00 -.396891676910E+00 -.377283629551E+00 + -.355155021405E+00 -.330524779042E+00 -.303426907952E+00 -.273910868147E+00 -.242041851308E+00 + -.207900949827E+00 -.171585207413E+00 -.133207540559E+00 -.928965205479E-01 -.507960069887E-01 + -.706462660247E-02 .381249046254E-01 .845866118155E-01 .132122232827E+00 .180522312943E+00 + .229567399836E+00 .279029316983E+00 .328672503777E+00 .378255433412E+00 .427532158406E+00 + .476254091096E+00 .524172202057E+00 .571039898221E+00 .616616860053E+00 .660673895312E+00 + .702998092998E+00 .743396069181E+00 .781691750831E+00 .817716502043E+00 .851295258407E+00 + .882238299672E+00 .910345743397E+00 .935421491735E+00 .957287299205E+00 .975791213531E+00 + .990810701652E+00 .100225314042E+01 .101005569012E+01 .101418535258E+01 .101463927777E+01 + .101144510801E+01 .100466111560E+01 .994375951175E+00 + pseudo wavefunction + .138848147713E-05 .143363143073E-05 .148024954817E-05 .152838357046E-05 .157808279106E-05 + .162939810629E-05 .168238206754E-05 .173708893499E-05 .179357473326E-05 .185189730873E-05 + .191211638882E-05 .197429364312E-05 .203849274656E-05 .210477944463E-05 .217322162069E-05 + .224388936550E-05 .231685504901E-05 .239219339443E-05 .246998155480E-05 .255029919199E-05 + .263322855826E-05 .271885458052E-05 .280726494727E-05 .289855019843E-05 .299280381807E-05 + .309012233011E-05 .319060539717E-05 .329435592268E-05 .340148015621E-05 .351208780231E-05 + .362629213282E-05 .374421010294E-05 .386596247091E-05 .399167392177E-05 .412147319496E-05 + .425549321623E-05 .439387123372E-05 .453674895855E-05 .468427270993E-05 .483659356497E-05 + .499386751345E-05 .515625561753E-05 .532392417672E-05 .549704489814E-05 .567579507240E-05 + .586035775516E-05 .605092195456E-05 .624768282482E-05 .645084186605E-05 .666060713066E-05 + .687719343636E-05 .710082258618E-05 .733172359563E-05 .757013292719E-05 .781629473250E-05 + .807046110236E-05 .833289232491E-05 .860385715220E-05 .888363307535E-05 .917250660878E-05 + .947077358361E-05 .977873945059E-05 .100967195929E-04 .104250396492E-04 .107640358469E-04 + .111140553467E-04 .114754565982E-04 .118486097064E-04 .122338968115E-04 .126317124796E-04 + .130424641070E-04 .134665723375E-04 .139044714931E-04 .143566100184E-04 .148234509404E-04 + .153054723424E-04 .158031678534E-04 .163170471539E-04 .168476364977E-04 .173954792507E-04 + .179611364475E-04 .185451873656E-04 .191482301190E-04 .197708822706E-04 .204137814640E-04 + .210775860774E-04 .217629758970E-04 .224706528134E-04 .232013415404E-04 .239557903567E-04 + .247347718727E-04 .255390838211E-04 .263695498740E-04 .272270204861E-04 .281123737658E-04 + .290265163739E-04 .299703844525E-04 .309449445827E-04 .319511947751E-04 .329901654910E-04 + .340629206980E-04 .351705589586E-04 .363142145555E-04 .374950586529E-04 .387143004951E-04 + .399731886447E-04 .412730122609E-04 .426151024191E-04 .440008334734E-04 .454316244639E-04 + .469089405685E-04 .484342946036E-04 .500092485720E-04 .516354152616E-04 .533144598965E-04 + .550481018409E-04 .568381163590E-04 .586863364318E-04 .605946546324E-04 .625650250632E-04 + .645994653551E-04 .667000587319E-04 .688689561416E-04 .711083784571E-04 .734206187480E-04 + .758080446262E-04 .782731006675E-04 .808183109118E-04 .834462814443E-04 .861597030606E-04 + .889613540173E-04 .918541028731E-04 .948409114207E-04 .979248377142E-04 .101109039194E-03 + .104396775914E-03 .107791413872E-03 .111296428448E-03 .114915407952E-03 .118652057294E-03 + .122510201760E-03 .126493790920E-03 .130606902659E-03 .134853747338E-03 .139238672088E-03 + .143766165242E-03 .148440860915E-03 .153267543723E-03 .158251153660E-03 .163396791131E-03 + .168709722144E-03 .174195383669E-03 .179859389171E-03 .185707534319E-03 .191745802874E-03 + .197980372773E-03 .204417622402E-03 .211064137063E-03 .217926715664E-03 .225012377598E-03 + .232328369866E-03 .239882174401E-03 .247681515644E-03 .255734368344E-03 .264048965612E-03 + .272633807228E-03 .281497668203E-03 .290649607612E-03 .300098977705E-03 .309855433294E-03 + .319928941443E-03 .330329791440E-03 .341068605095E-03 .352156347338E-03 .363604337150E-03 + .375424258823E-03 .387628173562E-03 .400228531432E-03 .413238183671E-03 .426670395356E-03 + .440538858462E-03 .454857705282E-03 .469641522262E-03 .484905364210E-03 .500664768938E-03 + .516935772296E-03 .533734923645E-03 .551079301749E-03 .568986531105E-03 .587474798722E-03 + .606562871331E-03 .626270113061E-03 .646616503561E-03 .667622656585E-03 .689309839028E-03 + .711699990427E-03 .734815742920E-03 .758680441650E-03 .783318165627E-03 .808753749025E-03 + .835012802915E-03 .862121737409E-03 .890107784211E-03 .918999019551E-03 .948824387471E-03 + .979613723446E-03 .101139777830E-02 .104420824237E-02 .107807776989E-02 .111304000356E-02 + .114912959911E-02 .118638225005E-02 .122483471218E-02 .126452482815E-02 .130549155155E-02 + .134777497086E-02 .139141633267E-02 .143645806444E-02 .148294379626E-02 .153091838171E-02 + .158042791736E-02 .163151976091E-02 .168424254740E-02 .173864620342E-02 .179478195889E-02 + .185270235589E-02 .191246125433E-02 .197411383369E-02 .203771659049E-02 .210332733071E-02 + .217100515649E-02 .224081044631E-02 .231280482772E-02 .238705114166E-02 .246361339709E-02 + .254255671485E-02 .262394725904E-02 .270785215452E-02 .279433938855E-02 .288347769449E-02 + .297533641527E-02 .306998534399E-02 .316749453861E-02 .326793410732E-02 .337137396094E-02 + .347788352781E-02 .358753142647E-02 .370038509052E-02 .381651033932E-02 .393597088755E-02 + .405882778553E-02 .418513878099E-02 .431495759219E-02 .444833308019E-02 .458530830718E-02 + .472591946529E-02 .487019465868E-02 .501815251889E-02 .516980063105E-02 .532513374505E-02 + .548413174236E-02 .564675732521E-02 .581295338964E-02 .598264003926E-02 .615571118988E-02 + .633203070846E-02 .651142802188E-02 .669369312193E-02 .687857088273E-02 .706575459498E-02 + .725487860842E-02 .744550995872E-02 .763713883827E-02 .782916775105E-02 .802089917058E-02 + .821152149574E-02 .840009307223E-02 .858552401783E-02 .876655555604E-02 .894173652625E-02 + .910939669822E-02 .926761647490E-02 .941419252015E-02 .954659879722E-02 .966194244997E-02 + .975691390319E-02 .982773050077E-02 .987007294359E-02 .987901373415E-02 .984893678510E-02 + .977344730712E-02 .964527106365E-02 .945614207061E-02 .919667783672E-02 .885624129362E-02 + .842278866608E-02 .788270269565E-02 .722061087326E-02 .641918867735E-02 .545894827979E-02 + .431801379800E-02 .297188497289E-02 .139319217287E-02 -.448553094467E-03 -.258720639694E-02 + -.506022962024E-02 -.790891121518E-02 -.111785546697E-01 -.149186192039E-01 -.191827929812E-01 + -.240289749478E-01 -.295191367867E-01 -.357190314954E-01 -.426977099021E-01 -.505268012579E-01 + -.592795092078E-01 -.690292703957E-01 -.798480203107E-01 -.918040104754E-01 -.104959123678E+00 + -.119365640755E+00 -.135052537078E+00 -.152079847668E+00 + ae wavefunction + -.536934453859E-05 -.554283679026E-05 -.572192904881E-05 -.590680169358E-05 -.609764089026E-05 + -.629463877488E-05 -.649799364359E-05 -.670791014832E-05 -.692459949849E-05 -.714827966909E-05 + -.737917561507E-05 -.761751949247E-05 -.786355088640E-05 -.811751704595E-05 -.837967312645E-05 + -.865028243916E-05 -.892961670862E-05 -.921795633789E-05 -.951559068196E-05 -.982281832946E-05 + -.101399473930E-04 -.104672958085E-04 -.108051916432E-04 -.111539734135E-04 -.115139904123E-04 + -.118856030458E-04 -.122691831813E-04 -.126651145043E-04 -.130737928877E-04 -.134956267708E-04 + -.139310375502E-04 -.143804599824E-04 -.148443425977E-04 -.153231481275E-04 -.158173539430E-04 + -.163274525071E-04 -.168539518402E-04 -.173973759985E-04 -.179582655672E-04 -.185371781670E-04 + -.191346889761E-04 -.197513912662E-04 -.203878969549E-04 -.210448371726E-04 -.217228628465E-04 + -.224226453000E-04 -.231448768698E-04 -.238902715395E-04 -.246595655907E-04 -.254535182727E-04 + -.262729124892E-04 -.271185555052E-04 -.279912796712E-04 -.288919431682E-04 -.298214307715E-04 + -.307806546346E-04 -.317705550946E-04 -.327921014965E-04 -.338462930403E-04 -.349341596486E-04 + -.360567628560E-04 -.372151967208E-04 -.384105887585E-04 -.396441008986E-04 -.409169304631E-04 + -.422303111689E-04 -.435855141531E-04 -.449838490212E-04 -.464266649193E-04 -.479153516296E-04 + -.494513406894E-04 -.510361065335E-04 -.526711676611E-04 -.543580878243E-04 -.560984772421E-04 + -.578939938353E-04 -.597463444862E-04 -.616572863188E-04 -.636286280026E-04 -.656622310770E-04 + -.677600112965E-04 -.699239399964E-04 -.721560454777E-04 -.744584144105E-04 -.768331932539E-04 + -.792825896932E-04 -.818088740907E-04 -.844143809508E-04 -.871015103953E-04 -.898727296496E-04 + -.927305745357E-04 -.956776509712E-04 -.987166364702E-04 -.101850281645E-03 -.105081411705E-03 + -.108412927949E-03 -.111847809248E-03 -.115389113513E-03 -.119039979150E-03 -.122803626483E-03 + -.126683359162E-03 -.130682565527E-03 -.134804719940E-03 -.139053384073E-03 -.143432208139E-03 + -.147944932068E-03 -.152595386619E-03 -.157387494410E-03 -.162325270874E-03 -.167412825110E-03 + -.172654360643E-03 -.178054176055E-03 -.183616665503E-03 -.189346319090E-03 -.195247723081E-03 + -.201325559962E-03 -.207584608305E-03 -.214029742439E-03 -.220665931907E-03 -.227498240686E-03 + -.234531826147E-03 -.241771937751E-03 -.249223915435E-03 -.256893187684E-03 -.264785269257E-03 + -.272905758533E-03 -.281260334465E-03 -.289854753099E-03 -.298694843630E-03 -.307786503967E-03 + -.317135695765E-03 -.326748438899E-03 -.336630805319E-03 -.346788912276E-03 -.357228914847E-03 + -.367956997739E-03 -.378979366308E-03 -.390302236747E-03 -.401931825406E-03 -.413874337166E-03 + -.426135952835E-03 -.438722815493E-03 -.451641015734E-03 -.464896575730E-03 -.478495432072E-03 + -.492443417301E-03 -.506746240072E-03 -.521409463873E-03 -.536438484230E-03 -.551838504315E-03 + -.567614508895E-03 -.583771236517E-03 -.600313149877E-03 -.617244404277E-03 -.634568814079E-03 + -.652289817096E-03 -.670410436812E-03 -.688933242371E-03 -.707860306229E-03 -.727193159410E-03 + -.746932744273E-03 -.767079364717E-03 -.787632633752E-03 -.808591418363E-03 -.829953781613E-03 + -.851716921913E-03 -.873877109413E-03 -.896429619485E-03 -.919368663237E-03 -.942687315069E-03 + -.966377437233E-03 -.990429601424E-03 -.101483300741E-02 -.103957539876E-02 -.106464297566E-02 + -.109002030507E-02 -.111569022805E-02 -.114163376471E-02 -.116783001666E-02 -.119425606737E-02 + -.122088688052E-02 -.124769519669E-02 -.127465142868E-02 -.130172355576E-02 -.132887701736E-02 + -.135607460649E-02 -.138327636352E-02 -.141043947082E-02 -.143751814883E-02 -.146446355430E-02 + -.149122368142E-02 -.151774326652E-02 -.154396369741E-02 -.156982292811E-02 -.159525539999E-02 + -.162019197054E-02 -.164455985064E-02 -.166828255181E-02 -.169127984444E-02 -.171346772851E-02 + -.173475841814E-02 -.175506034127E-02 -.177427815611E-02 -.179231278583E-02 -.180906147281E-02 + -.182441785436E-02 -.183827206105E-02 -.185051083943E-02 -.186101770044E-02 -.186967309504E-02 + -.187635461816E-02 -.188093724242E-02 -.188329358242E-02 -.188329419051E-02 -.188080788474E-02 + -.187570210923E-02 -.186784332698E-02 -.185709744495E-02 -.184333027040E-02 -.182640799755E-02 + -.180619772262E-02 -.178256798498E-02 -.175538933148E-02 -.172453490022E-02 -.168988101939E-02 + -.165130781581E-02 -.160869982728E-02 -.156194661142E-02 -.151094334343E-02 -.145559139361E-02 + -.139579887503E-02 -.133148115055E-02 -.126256128768E-02 -.118897044893E-02 -.111064820449E-02 + -.102754275349E-02 -.939611039582E-03 -.846818745856E-03 -.749140153709E-03 -.646557849671E-03 + -.539062263517E-03 -.426651020394E-03 -.309328089220E-03 -.187102709897E-03 -.599880838515E-04 + .720001825600E-04 .208845882540E-03 .350534246572E-03 .497054178393E-03 .648400632914E-03 + .804577064382E-03 .965597871782E-03 .113149078626E-02 .130229918063E-02 .147808432308E-02 + .165892762793E-02 .184493295336E-02 .203622894624E-02 .223297134696E-02 .243534507736E-02 + .264356588222E-02 .285788129106E-02 .307857069465E-02 .330594435780E-02 .354034119917E-02 + .378212515797E-02 .403167994363E-02 .428940193867E-02 .455569100166E-02 .483093890027E-02 + .511551509457E-02 .540974958539E-02 .571391254373E-02 .602819044082E-02 .635265840777E-02 + .668724856637E-02 .703171409088E-02 .738558878481E-02 .774814198662E-02 .811832865644E-02 + .849473454000E-02 .887551635833E-02 .925833702998E-02 .964029599629E-02 .100178547868E-01 + .103867580288E-01 .107419501671E-01 .110774882165E-01 .113864509092E-01 .116608446298E-01 + .118915065430E-01 .120680053329E-01 .121785399967E-01 .122098372057E-01 .121470479066E-01 + .119736441032E-01 .116713171792E-01 .112198796429E-01 .105971727185E-01 .977898257453E-02 + .873896786599E-02 .744860013681E-02 .587711563848E-02 .399147119709E-02 .175628797936E-02 + -.866239019038E-03 -.391647408054E-02 -.743746940754E-02 -.114749637066E-01 -.160771276901E-01 + -.212941062664E-01 -.271776042085E-01 -.337807161610E-01 -.411579574899E-01 -.493653243621E-01 + -.584602786172E-01 -.685016626504E-01 -.795495976261E-01 -.916654172796E-01 -.104911674326E+00 + -.119352243438E+00 -.135052537078E+00 -.152079847668E+00 + pseudo wavefunction + .291401328267E-08 .310660741021E-08 .331193054558E-08 .353082397944E-08 .376418460535E-08 + .401296859474E-08 .427819531469E-08 .456095150469E-08 .486239572944E-08 .518376312600E-08 + .552637046455E-08 .589162154379E-08 .628101294285E-08 .669614015334E-08 .713870411675E-08 + .761051819386E-08 .811351559483E-08 .864975730028E-08 .922144050602E-08 .983090762574E-08 + .104806558889E-07 .111733475729E-07 .119118209112E-07 .126991017233E-07 .135384158119E-07 + .144332021812E-07 .153871271269E-07 .164040992594E-07 .174882855184E-07 .186441282465E-07 + .198763633914E-07 .211900399110E-07 .225905404609E-07 .240836034492E-07 .256753465491E-07 + .273722917656E-07 .291813921584E-07 .311100603318E-07 .331661988066E-07 .353582324001E-07 + .376951427462E-07 .401865050959E-07 .428425275519E-07 .456740928944E-07 .486928031728E-07 + .519110272435E-07 .553419514499E-07 .589996336526E-07 .628990608296E-07 .670562104837E-07 + .714881161091E-07 .762129369843E-07 .812500325772E-07 .866200418695E-07 .923449679216E-07 + .984482680290E-07 .104954949835E-06 .111891673797E-06 .119286862426E-06 .127170816744E-06 + .135575840437E-06 .144536372221E-06 .154089126946E-06 .164273246033E-06 .175130457852E-06 + .186705248698E-06 .199045045072E-06 .212200408000E-06 .226225240208E-06 .241177006976E-06 + .257116971601E-06 .274110446410E-06 .292227060376E-06 .311541044413E-06 .332131535525E-06 + .354082901063E-06 .377485084413E-06 .402433973521E-06 .429031793789E-06 .457387526929E-06 + .487617357500E-06 .519845148962E-06 .554202951188E-06 .590831541524E-06 .629881001606E-06 + .671511332296E-06 .715893109266E-06 .763208181910E-06 .813650418444E-06 .867426500254E-06 + .924756768742E-06 .985876128147E-06 .105103500802E-05 .112050038933E-05 .119455689838E-05 + .127350797300E-05 .135767710584E-05 .144740916984E-05 .154307183128E-05 .164505705620E-05 + .175378271646E-05 .186969430185E-05 .199326674539E-05 .212500636934E-05 .226545295966E-05 + .241518197771E-05 .257480691811E-05 .274498182232E-05 .292640395847E-05 .311981667823E-05 + .332601246248E-05 .354583616833E-05 .378018849066E-05 .403002965244E-05 .429638333898E-05 + .458034089216E-05 .488306578181E-05 .520579837264E-05 .554986100620E-05 .591666341865E-05 + .630770851660E-05 .672459853464E-05 .716904159982E-05 .764285872985E-05 .814799129391E-05 + .868650896637E-05 .926061820619E-05 .987267129663E-05 .105251759823E-04 .112208057432E-04 + .119624107473E-04 .127530295272E-04 .135959014285E-04 .144944798800E-04 .154524465418E-04 + .164737263873E-04 .175625037821E-04 .187232396258E-04 .199606896253E-04 .212799237765E-04 + .226863471325E-04 .241857219440E-04 .257841912628E-04 .274883041044E-04 .293050422725E-04 + .312418489565E-04 .333066592171E-04 .355079324866E-04 .378546872150E-04 .403565378054E-04 + .430237339888E-04 .458672027984E-04 .488985933180E-04 .521303243834E-04 .555756354354E-04 + .592486407301E-04 .631643871285E-04 .673389157022E-04 .717893274054E-04 .765338530833E-04 + .815919281008E-04 .869842718977E-04 .927329727939E-04 .988615783914E-04 .105395191942E-03 + .112360575071E-03 .119786257283E-03 .127702652682E-03 .136142184401E-03 .145139417227E-03 + .154731198977E-03 .164956811193E-03 .175858129767E-03 .187479796156E-03 .199869399874E-03 + .213077673012E-03 .227158697560E-03 .242170126392E-03 .258173418790E-03 .275234091470E-03 + .293421986129E-03 .312811554584E-03 .333482162664E-03 .355518414075E-03 .379010495548E-03 + .404054544654E-03 .430753041771E-03 .459215227769E-03 .489557549103E-03 .521904132075E-03 + .556387288181E-03 .593148052553E-03 .632336757633E-03 .674113644380E-03 .718649513420E-03 + .766126418722E-03 .816738406546E-03 .870692302575E-03 .928208550323E-03 .989522104105E-03 + .105488338007E-02 .112455926899E-02 .119883421475E-02 .127801136268E-02 .136241378226E-02 + .145238576868E-02 .154829422848E-02 .165053015436E-02 .175951019478E-02 .187567832433E-02 + .199950762094E-02 .213150215675E-02 .227219900947E-02 .242217040155E-02 .258202597513E-02 + .275241521072E-02 .293402999840E-02 .312760737056E-02 .333393240565E-02 .355384131315E-02 + .378822470998E-02 .403803109964E-02 .430427056539E-02 .458801868954E-02 .489042071142E-02 + .521269593699E-02 .555614241356E-02 .592214188380E-02 .631216503324E-02 .672777704632E-02 + .717064348614E-02 .764253651345E-02 .814534146086E-02 .868106377808E-02 .925183636437E-02 + .985992730423E-02 .105077480221E-01 .111978618716E-01 .119329931739E-01 .127160367202E-01 + .135500677497E-01 .144383524159E-01 .153843587512E-01 .163917681354E-01 .174644872754E-01 + .186066606954E-01 .198226837362E-01 .211172160564E-01 .224951956216E-01 .239618531636E-01 + .255227270816E-01 .271836787499E-01 .289509081858E-01 .308309700202E-01 .328307896988E-01 + .349576798280E-01 .372193565604E-01 .396239558955E-01 .421800497506E-01 .448966616271E-01 + .477832816749E-01 .508498809210E-01 .541069243959E-01 .575653828518E-01 .612367427231E-01 + .651330139336E-01 .692667351008E-01 .736509756357E-01 .782993341711E-01 .832259326911E-01 + .884454056628E-01 .939728833996E-01 .998239688107E-01 .106014706613E+00 .112561544003E+00 + .119481281715E+00 .126791014304E+00 .134508058440E+00 .142649867935E+00 .151233934173E+00 + .160277670588E+00 .169798279848E+00 .179812602404E+00 .190336945154E+00 .201386889071E+00 + .212977074828E+00 .225120965693E+00 .237830587274E+00 .251116244142E+00 .264986213837E+00 + .279446419435E+00 .294500082568E+00 .310147359718E+00 .326384965564E+00 .343205788327E+00 + .360598503251E+00 .378547191656E+00 .397030974266E+00 .416023668739E+00 .435493482341E+00 + .455402751380E+00 .475707739190E+00 .496358503829E+00 .517298844985E+00 .538466336475E+00 + .559792445834E+00 .581202735295E+00 .602617128586E+00 .623950214870E+00 .645111544538E+00 + .666005851127E+00 .686533109442E+00 .706588312368E+00 .726060818994E+00 .744833096173E+00 + .762778647533E+00 .779758902369E+00 .795618827667E+00 .810181037401E+00 .823238213856E+00 + .834543737580E+00 .843795379495E+00 .850759109048E+00 + ae wavefunction + -.227639975927E-06 -.241553083020E-06 -.256238531448E-06 -.271743785200E-06 -.288119039224E-06 + -.305417391637E-06 -.323695026587E-06 -.343011408299E-06 -.363429487022E-06 -.385015917681E-06 + -.407841292027E-06 -.431980385198E-06 -.457512417605E-06 -.484521333149E-06 -.513096094823E-06 + -.543330998835E-06 -.575326008437E-06 -.609187108752E-06 -.645026683949E-06 -.682963918224E-06 + -.723125222119E-06 -.765644685826E-06 -.810664561235E-06 -.858335774579E-06 -.908818471664E-06 + -.962282597814E-06 -.101890851477E-05 -.107888765696E-05 -.114242322970E-05 -.120973095201E-05 + -.128103984706E-05 -.135659308322E-05 -.143664886909E-05 -.152148140599E-05 -.161138190170E-05 + -.170665964933E-05 -.180764317575E-05 -.191468146391E-05 -.202814525399E-05 -.214842842850E-05 + -.227594948673E-05 -.241115311447E-05 -.255451185510E-05 -.270652788873E-05 -.286773492636E-05 + -.303870022660E-05 -.322002674287E-05 -.341235540958E-05 -.361636757635E-05 -.383278759983E-05 + -.406238560344E-05 -.430598041586E-05 -.456444269986E-05 -.483869828392E-05 -.512973170970E-05 + -.543859000934E-05 -.576638672758E-05 -.611430620447E-05 -.648360813551E-05 -.687563242730E-05 + -.729180436770E-05 -.773364013080E-05 -.820275263846E-05 -.870085780133E-05 -.922978116380E-05 + -.979146497909E-05 -.103879757420E-04 -.110215122090E-04 -.116944139365E-04 -.124091703718E-04 + -.131684305304E-04 -.139750132996E-04 -.148319184057E-04 -.157423380908E-04 -.167096695415E-04 + -.177375281191E-04 -.188297614430E-04 -.199904643804E-04 -.212239950010E-04 -.225349915590E-04 + -.239283905651E-04 -.254094460215E-04 -.269837498904E-04 -.286572538768E-04 -.304362926072E-04 + -.323276082937E-04 -.343383769763E-04 -.364762364443E-04 -.387493159417E-04 -.411662677688E-04 + -.437363009004E-04 -.464692167451E-04 -.493754471826E-04 -.524660950179E-04 -.557529770072E-04 + -.592486696121E-04 -.629665576550E-04 -.669208860529E-04 -.711268148224E-04 -.756004775571E-04 + -.803590435918E-04 -.854207840798E-04 -.908051422247E-04 -.965328079196E-04 -.102625797063E-03 + -.109107535840E-03 -.116002950260E-03 -.123338561283E-03 -.131142585864E-03 -.139445044266E-03 + -.148277874034E-03 -.157675051007E-03 -.167672717809E-03 -.178309320241E-03 -.189625752061E-03 + -.201665508629E-03 -.214474849945E-03 -.228102973627E-03 -.242602198405E-03 -.258028158739E-03 + -.274440011195E-03 -.291900653263E-03 -.310476955313E-03 -.330240006432E-03 -.351265374934E-03 + -.373633384344E-03 -.397429405728E-03 -.422744167254E-03 -.449674081948E-03 -.478321594601E-03 + -.508795548883E-03 -.541211575720E-03 -.575692504072E-03 -.612368795275E-03 -.651379002161E-03 + -.692870254233E-03 -.736998770214E-03 -.783930399325E-03 -.833841192722E-03 -.886918006549E-03 + -.943359138131E-03 -.100337499686E-02 -.106718881141E-02 -.113503737486E-02 -.120717182952E-02 + -.128385849317E-02 -.136537972838E-02 -.145203485685E-02 -.154414112049E-02 -.164203469122E-02 + -.174607173112E-02 -.185662950504E-02 -.197410754735E-02 -.209892888474E-02 -.223154131687E-02 + -.237241875665E-02 -.252206263177E-02 -.268100334926E-02 -.284980182450E-02 -.302905107608E-02 + -.321937788792E-02 -.342144453961E-02 -.363595060592E-02 -.386363482621E-02 -.410527704411E-02 + -.436170021744E-02 -.463377249841E-02 -.492240938313E-02 -.522857592952E-02 -.555328904201E-02 + -.589761982068E-02 -.626269597230E-02 -.664970427950E-02 -.705989312401E-02 -.749457505857E-02 + -.795512942174E-02 -.844300498806E-02 -.895972264571E-02 -.950687809174E-02 -.100861445343E-01 + -.106992753895E-01 -.113481069581E-01 -.120345610684E-01 -.127606476645E-01 -.135284673243E-01 + -.143402136813E-01 -.151981757303E-01 -.161047399864E-01 -.170623924716E-01 -.180737204949E-01 + -.191414141916E-01 -.202682677838E-01 -.214571805211E-01 -.227111572555E-01 -.240333086037E-01 + -.254268506438E-01 -.268951040903E-01 -.284414928881E-01 -.300695421604E-01 -.317828754443E-01 + -.335852111384E-01 -.354803580901E-01 -.374722102372E-01 -.395647402230E-01 -.417619918931E-01 + -.440680715826E-01 -.464871380971E-01 -.490233912878E-01 -.516810591191E-01 -.544643831232E-01 + -.573776021360E-01 -.604249342075E-01 -.636105565785E-01 -.669385836182E-01 -.704130426186E-01 + -.740378473440E-01 -.778167692409E-01 -.817534062181E-01 -.858511489161E-01 -.901131443956E-01 + -.945422571848E-01 -.991410276437E-01 -.103911627616E+00 -.108855813361E+00 -.113974875783E+00 + -.119269587988E+00 -.124740150247E+00 -.130386132443E+00 -.136206414151E+00 -.142199122499E+00 + -.148361568035E+00 -.154690178833E+00 -.161180433171E+00 -.167826791131E+00 -.174622625584E+00 + -.181560153093E+00 -.188630365378E+00 -.195822962130E+00 -.203126286096E+00 -.210527261502E+00 + -.218011337039E+00 -.225562434682E+00 -.233162905552E+00 -.240793493705E+00 -.248433308057E+00 + -.256059801489E+00 -.263648754700E+00 -.271174260698E+00 -.278608704786E+00 -.285922735197E+00 + -.293085222036E+00 -.300063207002E+00 -.306821852678E+00 -.313324406286E+00 -.319532196442E+00 + -.325404680492E+00 -.330899553158E+00 -.335972915728E+00 -.340579493099E+00 -.344672879444E+00 + -.348205795003E+00 -.351130344271E+00 -.353398274261E+00 -.354961236692E+00 -.355771058893E+00 + -.355780026498E+00 -.354941178483E+00 -.353208612980E+00 -.350537801067E+00 -.346885905329E+00 + -.342212100159E+00 -.336477891180E+00 -.329647431712E+00 -.321687834653E+00 -.312569478552E+00 + -.302266306889E+00 -.290756119819E+00 -.278020857663E+00 -.264046875488E+00 -.248825207961E+00 + -.232351823470E+00 -.214627866128E+00 -.195659883790E+00 -.175460039600E+00 -.154046303832E+00 + -.131442622052E+00 -.107679054871E+00 -.827918840025E-01 -.568236791368E-01 -.298233205159E-01 + -.184597323164E-02 .270469885701E-01 .567881062803E-01 .873040050703E-01 .118515596879E+00 + .150338306883E+00 .182682313261E+00 .215452796875E+00 .248550212706E+00 .281870620849E+00 + .315306154149E+00 .348745752676E+00 .382076353569E+00 .415184746117E+00 .447960165155E+00 + .480297179596E+00 .512097397715E+00 .543267510319E+00 .573711993632E+00 .603322782157E+00 + .631972546868E+00 .659516791165E+00 .685802866227E+00 .710679504466E+00 .734002703277E+00 + .755638014234E+00 .775461066058E+00 .793357766636E+00 .809224792331E+00 .822970439701E+00 + .834515700400E+00 .843795379495E+00 .850759109048E+00 + pseudo wavefunction + .188259325656E-09 .200701836025E-09 .213966701744E-09 .228108274249E-09 .243184497194E-09 + .259257143867E-09 .276392070301E-09 .294659485112E-09 .314134237172E-09 .334896122293E-09 + .357030210184E-09 .380627193015E-09 .405783757020E-09 .432602978655E-09 .461194746947E-09 + .491676213752E-09 .524172273773E-09 .558816076302E-09 .595749570786E-09 .635124088452E-09 + .677100962369E-09 .721852188493E-09 .769561130406E-09 .820423270627E-09 .874647011580E-09 + .932454529506E-09 .994082684803E-09 .105978399254E-08 .112982765710E-08 .120450067525E-08 + .128410901202E-08 .136897885444E-08 .145945794800E-08 .155591702150E-08 .165875130612E-08 + .176838215480E-08 .188525876868E-08 .200986003770E-08 .214269650275E-08 .228431244760E-08 + .243528812901E-08 .259624215430E-08 .276783401601E-08 .295076679410E-08 .314579003675E-08 + .335370283154E-08 .357535707967E-08 .381166098646E-08 .406358278269E-08 .433215469178E-08 + .461847715923E-08 .492372336155E-08 .524914401326E-08 .559607249152E-08 .596593029951E-08 + .636023289086E-08 .678059587908E-08 .722874165731E-08 .770650645568E-08 .821584786499E-08 + .875885285776E-08 .933774633931E-08 .995490026410E-08 .106128433544E-07 .113142714617E-07 + .120620586123E-07 .128592687834E-07 .137091684574E-07 .146152400060E-07 .155811959585E-07 + .166109942135E-07 .177088542561E-07 .188792744464E-07 .201270504508E-07 .214572948920E-07 + .228754582969E-07 .243873514295E-07 .259991690995E-07 .277175155448E-07 .295494314911E-07 + .315024230005E-07 .335844922259E-07 .358041701992E-07 .381705517848E-07 .406933329453E-07 + .433828504679E-07 .462501243186E-07 .493069027933E-07 .525657106550E-07 .560399004512E-07 + .597437072231E-07 .636923068306E-07 .679018781323E-07 .723896692744E-07 .771740683610E-07 + .822746787944E-07 .877123995959E-07 .935095110327E-07 .996897659063E-07 .106278486872E-06 + .113302670191E-06 .120791096338E-06 .128774447922E-06 .137285435397E-06 .146358931079E-06 + .156032112024E-06 .166344612347E-06 .177338685603E-06 .189059377909E-06 .201554712490E-06 + .214875886441E-06 .229077480474E-06 .244217682537E-06 .260358526204E-06 .277566144822E-06 + .295911042451E-06 .315468382706E-06 .336318296692E-06 .358546211276E-06 .382243199059E-06 + .407506351473E-06 .434439176528E-06 .463152022837E-06 .493762531665E-06 .526396118840E-06 + .561186488509E-06 .598276180831E-06 .637817155864E-06 .679971416021E-06 .724911669647E-06 + .772822038440E-06 .823898811601E-06 .878351249803E-06 .936402442264E-06 .998290220443E-06 + .106426813207E-05 .113460647955E-05 .120959342687E-05 .128953617969E-05 .137476224337E-05 + .146562076397E-05 .156248395791E-05 .166574863599E-05 .177583782802E-05 .189320251473E-05 + .201832347399E-05 .215171324889E-05 .229391824580E-05 .244552097081E-05 .260714241377E-05 + .277944458969E-05 .296313324782E-05 .315896075937E-05 .336772919581E-05 .359029361017E-05 + .382756553466E-05 .408051670906E-05 .435018305473E-05 .463766891071E-05 .494415154892E-05 + .527088598687E-05 .561921011746E-05 .599055017661E-05 .638642657091E-05 .680846008894E-05 + .725837852142E-05 .773802371682E-05 .824935910117E-05 .879447769232E-05 .937561064095E-05 + .999513633285E-05 .106555900890E-04 .113596745027E-04 .121102704547E-04 .129104488515E-04 + .137634831326E-04 .146728625977E-04 .156423066068E-04 .166757797093E-04 .177775077628E-04 + .189519951060E-04 .202040428520E-04 .215387683771E-04 .229616260786E-04 .244784294863E-04 + .260953748122E-04 .278190660317E-04 .296565415935E-04 .316153028623E-04 .337033444036E-04 + .359291862279E-04 .383019081186E-04 .408311861731E-04 .435273316971E-04 .464013325996E-04 + .494648974426E-04 .527305023115E-04 .562114406801E-04 .599218764523E-04 .638769003772E-04 + .680925900398E-04 .725860736440E-04 .773755978153E-04 .824805996618E-04 .879217833433E-04 + .937212014151E-04 .999023412187E-04 .106490216612E-03 .113511465340E-03 .120994452360E-03 + .128969379448E-03 .137468401441E-03 .146525749442E-03 .156177861381E-03 .166463520291E-03 + .177424000698E-03 .189103223502E-03 .201547919779E-03 .214807803882E-03 .228935756279E-03 + .243988016516E-03 .260024386720E-03 .277108446041E-03 .295307776404E-03 .314694199941E-03 + .335344028437E-03 .357338325072E-03 .380763178723E-03 .405709990999E-03 .432275776138E-03 + .460563473773E-03 .490682274495E-03 .522747957989E-03 .556883243367E-03 .593218151151E-03 + .631890376108E-03 .673045669922E-03 .716838232348E-03 .763431109165E-03 .812996594826E-03 + .865716637226E-03 .921783241464E-03 .981398868826E-03 .104477682649E-02 .111214164262E-02 + .118372942048E-02 .125978816423E-02 .134057806758E-02 .142637175521E-02 .151745446512E-02 + .161412415806E-02 .171669153832E-02 .182547996737E-02 .194082524924E-02 .206307526326E-02 + .219258941639E-02 .232973788293E-02 .247490059520E-02 .262846594337E-02 .279082913687E-02 + .296239017320E-02 .314355135267E-02 .333471426917E-02 .353627619812E-02 .374862579194E-02 + .397213798232E-02 .420716797543E-02 .445404421192E-02 .471306014793E-02 .498446469549E-02 + .526845114184E-02 .556514434534E-02 .587458598281E-02 .619671759756E-02 .653136116924E-02 + .687819689722E-02 .723673785601E-02 .760630114682E-02 .798597513191E-02 .837458229890E-02 + .877063726069E-02 .917229935323E-02 .957731924895E-02 .998297895804E-02 .103860245445E-01 + .107825908400E-01 .111681173956E-01 .115372548753E-01 .118837610617E-01 .122003856210E-01 + .124787427655E-01 .127091709518E-01 .128805787801E-01 .129802763102E-01 .129937910905E-01 + .129046683256E-01 .126942547801E-01 .123414662634E-01 .118225388591E-01 .111107644916E-01 + .101762119689E-01 .898543534943E-02 .750117238625E-02 .568203694441E-02 .348221074715E-02 + .851141640091E-03 -.226674211916E-02 -.593228912367E-02 -.102118375499E-01 -.151773626963E-01 + -.209065329490E-01 -.274826407059E-01 -.349943660481E-01 -.435353202661E-01 -.532033034353E-01 + -.640991948492E-01 -.763253771158E-01 -.899835741667E-01 -.105171960694E+00 -.121981376528E+00 + -.140490455867E+00 -.160752140242E+00 -.182838197398E+00 + ae wavefunction + .329908017899E-08 .350070879538E-08 .371353032623E-08 .393823260492E-08 .417554304096E-08 + .442623111551E-08 .469111103129E-08 .497104452448E-08 .526694384922E-08 .557977494597E-08 + .591056080576E-08 .626038504303E-08 .663039569071E-08 .702180923184E-08 .743591488320E-08 + .787407914718E-08 .833775064943E-08 .882846528060E-08 .934785166202E-08 .989763695626E-08 + .104796530450E-07 .110958430977E-07 .117482685572E-07 .124391165681E-07 .131707078780E-07 + .139455052412E-07 .147661223583E-07 .156353333861E-07 .165560830548E-07 .175314974331E-07 + .185648953814E-07 .196598007399E-07 .208199552982E-07 .220493325979E-07 .233521526224E-07 + .247328974311E-07 .261963278005E-07 .277475009372E-07 .293917893326E-07 .311349008342E-07 + .329829000119E-07 .349422309040E-07 .370197412336E-07 .392227081895E-07 .415588658745E-07 + .440364345292E-07 .466641516475E-07 .494513051048E-07 .524077684326E-07 .555440383768E-07 + .588712748880E-07 .624013437039E-07 .661468616893E-07 .701212451142E-07 .743387610605E-07 + .788145821596E-07 .835648448764E-07 .886067115712E-07 .939584365812E-07 .996394365846E-07 + .105670365522E-06 .112073194371E-06 .118871296086E-06 .126089536039E-06 .133754368318E-06 + .141893938246E-06 .150538191549E-06 .159718990577E-06 .169470238034E-06 .179828008724E-06 + .190830689788E-06 .202519130018E-06 .214936798801E-06 .228129955327E-06 .242147828705E-06 + .257042809702E-06 .272870654832E-06 .289690703594E-06 .307566109690E-06 .326564087128E-06 + .346756172139E-06 .368218501929E-06 .391032111332E-06 .415283248495E-06 .441063710808E-06 + .468471202359E-06 .497609714270E-06 .528589929370E-06 .561529652727E-06 .596554269675E-06 + .633797233063E-06 .673400581564E-06 .715515490979E-06 .760302860615E-06 .807933936922E-06 + .858590976703E-06 .912467952376E-06 .969771301889E-06 .103072072606E-05 .109555003626E-05 + .116450805559E-05 .123785957678E-05 .131588638035E-05 .139888831671E-05 .148718445608E-05 + .158111431043E-05 .168103913172E-05 .178734329115E-05 .190043574433E-05 .202075158739E-05 + .214875370975E-05 .228493454907E-05 .242981795469E-05 .258396116581E-05 .274795691142E-05 + .292243563898E-05 .310806787948E-05 .330556675685E-05 .351569065019E-05 .373924601751E-05 + .397709039049E-05 .423013554987E-05 .449935089198E-05 .478576699710E-05 .509047941113E-05 + .541465265242E-05 .575952445644E-05 .612641027142E-05 .651670801861E-05 .693190313178E-05 + .737357389105E-05 .784339706665E-05 .834315388946E-05 .887473636521E-05 .944015395058E-05 + .100415406097E-04 .106811622710E-04 .113614247036E-04 .120848818358E-04 .128542445362E-04 + .136723898809E-04 .145423709291E-04 .154674270325E-04 .164509947032E-04 .174967190638E-04 + .186084659092E-04 .197903344043E-04 .210466704466E-04 .223820807216E-04 .238014474792E-04 + .253099440608E-04 .269130512058E-04 .286165741680E-04 .304266606703E-04 .323498197291E-04 + .343929413762E-04 .365633173085E-04 .388686624936E-04 .413171377592E-04 .439173733939E-04 + .466784937828E-04 .496101431055E-04 .527225121145E-04 .560263660175E-04 .595330734786E-04 + .632546367534E-04 .672037229692E-04 .713936965562E-04 .758386528320E-04 .805534527382E-04 + .855537587174E-04 .908560717189E-04 .964777693090E-04 .102437144857E-03 .108753447759E-03 + .115446924650E-03 .122538861549E-03 .130051626865E-03 .138008715186E-03 .146434791756E-03 + .155355737528E-03 .164798694679E-03 .174792112435E-03 .185365793069E-03 .196550937879E-03 + .208380192963E-03 .220887694586E-03 .234109113894E-03 .248081700728E-03 .262844326268E-03 + .278437524200E-03 .294903530092E-03 .312286318645E-03 .330631638438E-03 .349987043795E-03 + .370401923370E-03 .391927525004E-03 .414616976437E-03 .438525301396E-03 .463709430588E-03 + .490228207127E-03 .518142385893E-03 .547514626344E-03 .578409478292E-03 .610893360173E-03 + .645034529359E-03 .680903044093E-03 .718570716657E-03 .758111057440E-03 .799599209646E-03 + .843111874437E-03 .888727226421E-03 .936524819495E-03 .986585483195E-03 .103899120984E-02 + .109382503292E-02 .115117089748E-02 .121111352320E-02 .127373826159E-02 .133913094834E-02 + .140737775294E-02 .147856502718E-02 .155277915525E-02 .163010640797E-02 .171063280434E-02 + .179444398399E-02 .188162509437E-02 .197226069717E-02 .206643469870E-02 .216423030948E-02 + .226573003870E-02 .237101572979E-02 .248016864360E-02 .259326959640E-02 .271039916068E-02 + .283163793710E-02 .295706690745E-02 .308676787920E-02 .322082403378E-02 .335932059220E-02 + .350234561239E-02 .364999093291E-02 .380235327479E-02 .395953550720E-02 .412164806889E-02 + .428881051644E-02 .446115314045E-02 .463881855679E-02 .482196315214E-02 .501075825528E-02 + .520539093344E-02 .540606438254E-02 .561299798267E-02 .582642719909E-02 .604660358714E-02 + .627379516452E-02 .650828731395E-02 .675038417942E-02 .700041028844E-02 .725871197647E-02 + .752565817955E-02 .780164027316E-02 .808707077981E-02 .838238086423E-02 .868801655628E-02 + .900443360736E-02 .933209082854E-02 .967144170169E-02 .100229240120E-01 .103869472209E-01 + .107638772809E-01 .111540185848E-01 .115575927342E-01 .119747138083E-01 .124053598104E-01 + .128493399678E-01 .133062575600E-01 .137754679559E-01 .142560315452E-01 .147466612667E-01 + .152456644480E-01 .157508787005E-01 .162596016357E-01 .167685142012E-01 .172735974648E-01 + .177700427009E-01 .182521546525E-01 .187132478523E-01 .191455358726E-01 .195400133505E-01 + .198863305955E-01 .201726605474E-01 .203855578566E-01 .205098099183E-01 .205282799298E-01 + .204217424344E-01 .201687124905E-01 .197452704861E-01 .191248856466E-01 .182782422416E-01 + .171730730409E-01 .157740040676E-01 .140424119477E-01 .119362882257E-01 .941009223694E-02 + .641455956391E-02 .289643672970E-02 -.120182972349E-02 -.594230845433E-02 -.113915061558E-01 + -.176199584845E-01 -.247017208792E-01 -.327140327375E-01 -.417371826148E-01 -.518544026197E-01 + -.631516436073E-01 -.757171941354E-01 -.896411710603E-01 -.105014918512E+00 -.121930338317E+00 + -.140479159189E+00 -.160752140242E+00 -.182838197398E+00 + End of Dataset From 8693997a619bd52a008be8f06e47e89b8c07c5ee Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Wed, 26 Feb 2020 01:58:27 -0800 Subject: [PATCH 076/207] Remove parents options from ld fireworks --- atomate/vasp/fireworks/lattice_dynamics.py | 19 ++++++++----------- 1 file changed, 8 insertions(+), 11 deletions(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 360e98c45..18cdd4664 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -11,7 +11,6 @@ MAX_IMAGINARY_FREQ, MAX_N_IMAGINARY, ) -from atomate.vasp.analysis.phonopy import MESH_DENSITY from atomate.vasp.config import SHENGBTE_CMD from atomate.vasp.firetasks.lattice_dynamics import ( DEFAULT_TEMPERATURE, @@ -20,7 +19,7 @@ RunHiPhive, RunShengBTE, ShengBTEToDb, -) + MESH_DENSITY) from fireworks import Firework __author__ = "Alex Ganose" @@ -67,7 +66,7 @@ def __init__( mesh_density: float = MESH_DENSITY, **kwargs ): - collect_structures = CollectPerturbedStructures(db_file) + collect_structures = CollectPerturbedStructures() fit_constants = RunHiPhive( cutoffs=cutoffs, imaginary_tol=imaginary_tol, @@ -75,7 +74,9 @@ def __init__( max_imaginary_freq=max_imaginary_freq, fit_method=fit_method, ) - to_db = ForceConstantsToDb(db_file=db_file, mesh_density=mesh_density) + to_db = ForceConstantsToDb( + db_file=db_file, mesh_density=mesh_density, additional_fields={} + ) pass_locs = PassCalcLocs(name=name) tasks = [collect_structures, fit_constants, to_db, pass_locs] @@ -88,7 +89,6 @@ class LatticeThermalConductivityFW(Firework): Args: name: Name of this FW. - parents: Parent(s) of this Firework. prev_calc_dir: Path to a directory containing the force constant information. Will override ``parents`` when collecting the force constants to run ShengBTE. @@ -106,7 +106,6 @@ class LatticeThermalConductivityFW(Firework): def __init__( self, name="Lattice Thermal Conductivity", - parents: Optional[Union[Firework, List[Firework]]] = None, prev_calc_dir: Optional[str] = None, db_file: str = None, shengbte_cmd: str = SHENGBTE_CMD, @@ -123,17 +122,15 @@ def __init__( if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) - elif parents: - copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) else: - raise ValueError("Must specify parents or prev_calc_dir.") + copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) run_shengbte = RunShengBTE( shengbte_cmd=shengbte_cmd, temperature=temperature, control_kwargs=shengbte_control_kwargs, ) - shengbte_to_db = ShengBTEToDb(db_file=db_file) + shengbte_to_db = ShengBTEToDb(db_file=db_file, additional_fields={}) tasks = [copy_files, run_shengbte, shengbte_to_db] - super().__init__(tasks, parents=parents, name=name, **kwargs) + super().__init__(tasks, name=name, **kwargs) From 9279f8bcd41b53be583e329284a79b7bc058ec06 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Wed, 26 Feb 2020 01:59:59 -0800 Subject: [PATCH 077/207] BUG: Fixes for lattice dynamics workflow --- .../vasp/workflows/base/lattice_dynamics.py | 66 +++++++++++-------- 1 file changed, 38 insertions(+), 28 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 44f806793..a5d893e3a 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -23,32 +23,32 @@ CubicSupercellTransformation, ) -__author__ = "Rees Chang, Alex Ganose" -__email__ = "rc564@cornell.edu, aganose@lbl.gov" -__date__ = "July 2019" +__author__ = "Alex Ganose, Rees Chang" +__email__ = "aganose@lbl.gov, rc564@cornell.edu" +__date__ = "February 2020" logger = get_logger(__name__) _static_user_incar_settings = { - "ADDGRID": True, # Fast Fourier Transform grid + "ADDGRID": True, "LCHARG": False, "ENCUT": 700, - "EDIFF": 1e-8, # may need to tune this + "ISMEAR": 0, + "EDIFF": 1e-8, "PREC": "Accurate", "LAECHG": False, "LREAL": False, "LASPH": True, } - - _DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} -_WF_VERSION = 1.0 +_WF_VERSION = 0.1 def get_lattice_dynamics_wf( structure: Structure, common_settings: Dict = None, vasp_input_set: Optional[VaspInputSet] = None, + copy_vasp_outputs: bool = False, supercell_matrix_kwargs: Optional[dict] = None, num_supercell_kwargs: Optional[dict] = None, perturbed_structure_kwargs: Optional[dict] = None, @@ -85,6 +85,7 @@ def get_lattice_dynamics_wf( common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", and "user_incar_settings" keys. vasp_input_set: Vasp input set for perturbed structure calculations. + copy_vasp_outputs: Whether or not to copy previous vasp outputs. supercell_matrix_kwargs: Options that control the size of the supercell. Will be passed directly to CubicSupercellTransformation in pymatgen.transformations.advanced_transformations. Note, a diagonal @@ -125,29 +126,28 @@ def get_lattice_dynamics_wf( supercell = st.apply_transformation(structure) supercell_matrix = st.transformation_matrix - if "n_supercells" not in perturbed_structure_kwargs: + if "n_configs_per_std" not in perturbed_structure_kwargs: n_supercells = get_num_supercells(supercell, **num_supercell_kwargs) - perturbed_structure_kwargs["n_supercells"] = n_supercells + perturbed_structure_kwargs["n_configs_per_std"] = n_supercells wf = get_perturbed_structure_wf( structure, supercell_matrix=supercell_matrix, - name="ld perturbed structure", vasp_input_set=vasp_input_set, common_settings=common_settings, + copy_vasp_outputs=copy_vasp_outputs, pass_forces=True, **perturbed_structure_kwargs, ) allow_fizzled = {"_allow_fizzled_parents": True} fw_fit_force_constant = FitForceConstantsFW( - parents=wf.fws[wf.leaf_fw_ids], db_file=db_file, spec=allow_fizzled + db_file=db_file, spec=allow_fizzled ) - wf.fws.append(fw_fit_force_constant) + wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) if calculate_lattice_thermal_conductivity: fw_lattice_conductivity = LatticeThermalConductivityFW( - parents=wf.fws[-1], db_file=db_file, shengbte_cmd=shengbte_cmd, temperature=thermal_conductivity_temperature, @@ -155,7 +155,9 @@ def get_lattice_dynamics_wf( if shengbte_fworker: fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker - wf.fws.append(fw_lattice_conductivity) + wf.append_wf( + Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-1].fw_id] + ) formula = structure.composition.reduced_formula wf.name = "{} - lattice dynamics".format(formula) @@ -176,6 +178,7 @@ def get_perturbed_structure_wf( name: str = "perturbed structure", vasp_input_set: Optional[VaspInputSet] = None, common_settings: Optional[Dict] = None, + copy_vasp_outputs: bool = False, rattle_stds: Optional[List[float]] = None, n_configs_per_std: int = 1, min_nn_scale: float = 0.85, @@ -191,6 +194,7 @@ def get_perturbed_structure_wf( vasp_input_set: Vasp input set for perturbed structure calculations. common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", and "user_incar_settings" keys. + copy_vasp_outputs: Whether or not to copy previous vasp outputs. rattle_stds: List of standard deviations (in normal distribution) to to use when displacing the sites. n_configs_per_std: Number of structures to generate per rattle standard @@ -206,7 +210,9 @@ def get_perturbed_structure_wf( common_settings = _get_common_settings(common_settings) vasp_cmd = common_settings["VASP_CMD"] db_file = common_settings["DB_FILE"] - user_incar_settings = common_settings["user_incar_settings"] + override_vasp_params = { + "user_incar_settings": common_settings["user_incar_settings"] + } if supercell_matrix is None: supercell_matrix = np.eye(3) @@ -218,21 +224,24 @@ def get_perturbed_structure_wf( if vasp_input_set is None: vasp_input_set = MPStaticSet(structure) - else: - # ensure we don't override the user_incar_settings in the input set - user_incar_settings.update(vasp_input_set.user_incar_settings) - vasp_input_set.user_incar_settings = user_incar_settings - min_distance = np.min(structure.distance_matrix) * min_nn_scale + # find the smallest nearest neighbor distance taking into account PBC + min_distance = np.min( + [d.nn_distance for d in structure.get_all_neighbors(10)[0]] + ) + min_distance *= min_nn_scale all_rattle_stds = np.repeat(rattle_stds, n_configs_per_std) - logger.debug("Using {} supercells / displacement".format(n_configs_per_std)) + logger.debug("Using supercell_matrix of: {}".format(supercell_matrix)) + logger.debug( + "Using {} supercells per displacement".format(n_configs_per_std) + ) logger.debug("Using {} rattle stds".format(len(rattle_stds))) logger.debug("Rattle stds: {}".format(rattle_stds)) fws = [] - for i, rattle_std in all_rattle_stds: - name = "{} : i = {}; rattle_std : {:.3f}".format(name, i, rattle_std) + for i, rattle_std in enumerate(all_rattle_stds): + fw_name = "{}: i={}; rattle_std={:.3f}".format(name, i, rattle_std) transformations = [ "SupercellTransformation", "MonteCarloRattleTransformation", @@ -243,12 +252,13 @@ def get_perturbed_structure_wf( ] fw = TransmuterFW( - name=name, + name=fw_name, structure=structure, transformations=transformations, transformation_params=transformation_params, vasp_input_set=vasp_input_set, - copy_vasp_outputs=True, + override_default_vasp_params=override_vasp_params, + copy_vasp_outputs=copy_vasp_outputs, vasp_cmd=vasp_cmd, db_file=db_file, ) @@ -301,11 +311,11 @@ def get_num_supercells( # site degeneracy sga = SpacegroupAnalyzer(supercell_structure, symprec=symprec) equiv_idxs = sga.get_symmetry_dataset()["equivalent_atoms"] - equiv_counts = np.unique(equiv_idxs, return_counts=True) + _, equiv_counts = np.unique(equiv_idxs, return_counts=True) min_count = np.min(equiv_counts) n_cells = math.ceil(min_num_equivalent_sites / min_count) - return min(n_cells, max_num_supercells) + return min([n_cells, max_num_supercells]) def _get_common_settings(common_settings: Optional[Dict]): From a67b01cbd0d06a882aff7082f45d39ea9235f252 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Wed, 26 Feb 2020 02:00:25 -0800 Subject: [PATCH 078/207] Add lattice dynamics workflow test --- .../tests/test_lattice_dynamics_workflow.py | 93 +++++++++++++++++++ 1 file changed, 93 insertions(+) create mode 100644 atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py diff --git a/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py b/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py new file mode 100644 index 000000000..1f0bb7254 --- /dev/null +++ b/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py @@ -0,0 +1,93 @@ + +from pathlib import Path + +from atomate.vasp.workflows import get_lattice_dynamics_wf +from fireworks import FWorker +from fireworks.core.rocket_launcher import rapidfire + +from atomate.vasp.powerups import use_fake_vasp, use_potcar_spec +from atomate.utils.testing import AtomateTest + +from pymatgen.util.testing import PymatgenTest + +__author__ = 'Alex Ganose' +__email__ = 'aganose@lbl.gov' + +module_dir = Path(__file__).resolve().parent +db_dir = module_dir / "../../../common/test_files" +ref_dir = module_dir / "../../test_files" +wf_dir = ref_dir / "lattice_dynamics_wf" + +test_fworker = FWorker(env={"db_file": db_dir / "db.json"}) + + +class TestRamanWorkflow(AtomateTest): + + def setUp(self, lpad=True): + super().setUp(lpad=lpad) + + self.struct_si = PymatgenTest.get_structure("Si") + + self.wf = get_lattice_dynamics_wf( + self.struct_si, + perturbed_structure_kwargs={"rattle_stds": [0.01]}, + calculate_lattice_thermal_conductivity=True + ) + + def test_wf(self): + self.wf = get_simulated_wf(self.wf) + self.lp.add_wf(self.wf) + rapidfire(self.lp, fworker=test_fworker) + + self.assertEqual(len(self.wf.fws), 3) + + # check static calculation + result = self.get_task_collection().find_one( + {"task_label": "perturbed structure: i=0; rattle_std=0.010"} + ) + self.check_run(result, mode="structure optimization") + + wf = self.lp.get_wf_by_fw_id(1) + self.assertTrue(all([s == 'COMPLETED' for s in wf.fw_states.values()])) + + def check_run(self, d, mode): + pass + # if mode not in ["structure optimization", "static dielectric", + # "raman_0_0.005", "raman analysis"]: + # raise ValueError("Invalid mode!") + # + # if mode not in ["raman analysis"]: + # self.assertEqual(d["formula_pretty"], "Si") + # self.assertEqual(d["formula_anonymous"], "A") + # self.assertEqual(d["nelements"], 1) + # self.assertEqual(d["state"], "successful") + # self.assertAlmostEqual(d["calcs_reversed"][0]["output"]["structure"]["lattice"]["a"], 3.867, 2) + # + # if mode in ["structure optimization"]: + # self.assertAlmostEqual(d["output"]["energy"], -10.850, 2) + # self.assertAlmostEqual(d["output"]["energy_per_atom"], -5.425, 2) + # + # elif mode in ["static dielectric"]: + # epsilon = [[13.23245131, -1.98e-06, -1.4e-06], + # [-1.98e-06, 13.23245913, 8.38e-06], + # [-1.4e-06, 8.38e-06, 13.23245619]] + # np.testing.assert_allclose(epsilon, d["output"]["epsilon_static"], rtol=1e-5) + # + # elif mode in ["raman_0_0.005"]: + # epsilon = [[13.16509632, 0.00850098, 0.00597267], + # [0.00850097, 13.25477303, -0.02979572], + # [0.00597267, -0.0297953, 13.28883867]] + # np.testing.assert_allclose(epsilon, d["output"]["epsilon_static"], rtol=1e-5) + + + +def get_simulated_wf(wf): + ref_dirs = {"perturbed structure: i=0; rattle_std=0.010": wf_dir / "0"} + + params_to_check = ["ENCUT", "NSW", "EDIFF"] + wf = use_potcar_spec(wf) + wf = use_fake_vasp( + wf, ref_dirs, params_to_check=params_to_check, check_potcar=False + ) + + return wf From 1e2f67db2f9c4b647248ff68631f6d6d75d9f6ef Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Fri, 28 Feb 2020 12:22:50 -0800 Subject: [PATCH 079/207] BUG: Fix bugs in lattice dynamics firetasks --- atomate/vasp/analysis/lattice_dynamics.py | 22 +++++++++++----------- 1 file changed, 11 insertions(+), 11 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 8f5c6f71a..e644482dc 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -7,8 +7,8 @@ from pymatgen import Structure from pymatgen.io.phonopy import get_phonopy_structure -__author__ = "Rees Chang, Alex Ganose" -__email__ = "rc564@cornell.edu, aganose@lbl.gov" +__author__ = "Alex Ganose, Rees Chang" +__email__ = "aganose@lbl.gov, rc564@cornell.edu" logger = get_logger(__name__) @@ -67,13 +67,15 @@ def get_cutoffs(structure: Structure): steps = {2: 0.5, 3: 0.25, 4: 0.25} row = min([s.row for s in structure.species]) - mins = (min_cutoffs[row][2], min_cutoffs[row][3], min_cutoffs[row][4]) + mins = { + 2: min_cutoffs[row][2], 3: min_cutoffs[row][3], 4: min_cutoffs[row][4] + } - range_two = np.arange(mins[0], mins[0] + inc[0] + steps[0], steps[0]) - range_three = np.arange(mins[1], mins[1] + inc[1] + steps[1], steps[1]) - range_four = np.arange(mins[2], mins[2] + inc[2] + steps[2], steps[2]) + range_two = np.arange(mins[2], mins[2] + inc[2] + steps[2], steps[2]) + range_three = np.arange(mins[3], mins[3] + inc[3] + steps[3], steps[3]) + range_four = np.arange(mins[4], mins[4] + inc[4] + steps[4], steps[4]) - return list(product(range_two, range_three, range_four)) + return list(map(list, product(range_two, range_three, range_four))) def fit_force_constants( @@ -168,19 +170,17 @@ def fit_force_constants( ) fitting_data["cutoffs"].append(cutoffs) - fitting_data["rmse_train"].append(opt.rmse_test) + fitting_data["rmse_test"].append(opt.rmse_test) fitting_data["n_imaginary"].append(n_imaginary) fitting_data["min_frequency"].append(min_freq) fitting_data["300K_free_energy"].append(free_energy) - fitting_data["force_constants"].append(fcs) if ( - min_freq < -np.abs(max_imaginary_freq) + min_freq > -np.abs(max_imaginary_freq) and n_imaginary <= max_n_imaginary and n_imaginary < best_fit["n_imaginary"] and free_energy < best_fit["free_energy"] ): - best_fit.update( { "n_imaginary": n_imaginary, From a414460037b1c75501017bd4278382d21fc32526 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Fri, 28 Feb 2020 12:23:06 -0800 Subject: [PATCH 080/207] Fix bugs in lattice dynamics workflow --- atomate/vasp/workflows/base/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index a5d893e3a..1f89ac2ce 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -265,7 +265,7 @@ def get_perturbed_structure_wf( if pass_forces: pass_dict = { - "parent_structure": structure.to_json(), + "parent_structure": structure.as_dict(), "supercell_matrix": supercell_matrix, "forces": ">>output.ionic_steps.-1.forces", "structure": ">>output.ionic_steps.-1.structure", From 048ccf2f350bf2c6358b013d5eaac9cf4fa10325 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Fri, 28 Feb 2020 12:29:13 -0800 Subject: [PATCH 081/207] Update firetasks --- atomate/vasp/firetasks/lattice_dynamics.py | 95 ++++++++++++++-------- 1 file changed, 60 insertions(+), 35 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index d845a46fc..cefa4e166 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -1,4 +1,6 @@ +import json import os +import subprocess import shlex from datetime import datetime from pathlib import Path @@ -19,7 +21,6 @@ ) from atomate.vasp.database import VaspCalcDb from fireworks import FiretaskBase, FWAction, explicit_serialize -from pymatgen import Structure from pymatgen.io.ase import AseAtomsAdaptor from pymatgen.io.phonopy import get_phonon_band_structure_from_fc, \ get_phonon_dos_from_fc, get_phonon_band_structure_symm_line_from_fc @@ -67,10 +68,10 @@ def run_task(self, fw_spec): logger.info("Found {} perturbed structures".format(len(results))) - structure = Structure.from_dict(results[0]["parent_structure"]) + structure = results[0]["parent_structure"] supercell_matrix = results[0]["supercell_matrix"] - structures = [Structure.from_dict(r["structure"]) for r in results] + structures = [r["structure"] for r in results] forces = [np.asarray(r["forces"]) for r in results] # regenerate pure supercell structure @@ -89,7 +90,6 @@ def run_task(self, fw_spec): dumpfn(structure_data, "structure_data.json") -@requires(hiphive, "hiphive is required for lattice dynamics workflow") @explicit_serialize class RunHiPhive(FiretaskBase): """ @@ -122,6 +122,7 @@ class RunHiPhive(FiretaskBase): "fit_method", ] + @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): from hiphive.utilities import get_displacements @@ -131,7 +132,7 @@ def run_task(self, fw_spec): fit_method = self.get("fit_method", FIT_METHOD) all_structures = loadfn("perturbed_structures.json") - all_forces = loadfn("all_forces.json") + all_forces = loadfn("perturbed_forces.json") structure_data = loadfn("structure_data.json") parent_structure = structure_data["structure"] supercell_matrix = structure_data["supercell_matrix"] @@ -142,12 +143,12 @@ def run_task(self, fw_spec): for structure, forces in zip(all_structures, all_forces): atoms = AseAtomsAdaptor.get_atoms(structure) displacements = get_displacements(atoms, supercell_atoms) - structure.new_array("displacements", displacements) - structure.new_array("forces", forces) - structure.positions = supercell_atoms.get_positions() - structures.append(structure) + atoms.new_array("displacements", displacements) + atoms.new_array("forces", forces) + atoms.positions = supercell_atoms.get_positions() + structures.append(atoms) - cutoffs = self.get("cutoffs", get_cutoffs(supercell_structure)) + cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) force_constants, fitting_data = fit_force_constants( parent_structure, supercell_matrix, @@ -161,10 +162,10 @@ def run_task(self, fw_spec): dumpfn(fitting_data, "fitting_data.json") - if force_constants is not None: + if force_constants is None: # fitting failed raise RuntimeError( - "Could not find a force constant solution with less than {}" + "Could not find a force constant solution with less than {} " "imaginary modes.\n" "Fitting results: {}".format(max_n_imaginary, fitting_data) ) @@ -180,7 +181,6 @@ def run_task(self, fw_spec): ) -@requires(hiphive, "hiphive is required for lattice dynamics workflow") @explicit_serialize class ForceConstantsToDb(FiretaskBase): """ @@ -205,13 +205,14 @@ class ForceConstantsToDb(FiretaskBase): required_params = ["db_file"] optional_params = ["mesh_density", "additional_fields"] + @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): from hiphive.force_constants import ForceConstants db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - force_constants = ForceConstants.read("force_constants.fcs") + fc = ForceConstants.read("force_constants.fcs") fitting_data = loadfn("fitting_data.json") structure_data = loadfn("structure_data.json") forces = loadfn("perturbed_forces.json") @@ -221,7 +222,7 @@ def run_task(self, fw_spec): supercell_structure = structure_data["supercell_structure"] supercell_matrix = structure_data["supercell_matrix"] - phonopy_fc = force_constants.get_fc_array(order=2) + phonopy_fc = fc.get_fc_array(order=2) logger.info("Getting uniform phonon band structure.") uniform_bs = get_phonon_band_structure_from_fc( @@ -250,14 +251,22 @@ def run_task(self, fw_spec): lm_bs.to_json(), collection="phonon_bandstructure_fs" ) + logger.info("Inserting force constants into database.") + fc_json = json.dumps( + {str(k): v.tolist() for k, v in fc.get_fc_dict().items()} + ) + fc_fsid, _ = mmdb.insert_gridfs( + fc_json, collection="phonon_force_constants_fs" + ) + data = { "structure": structure.as_dict(), - "supercell_matrix": supercell_matrix.tolist(), + "supercell_matrix": supercell_matrix, "supercell_structure": supercell_structure.as_dict(), - "perturbed_structures": [s.to_json() for s in structures], + "perturbed_structures": [s.as_dict() for s in structures], "perturbed_forces": [f.tolist() for f in forces], "fitting_data": fitting_data, - "force_constants": force_constants.get_fc_dict(), + "force_constants_fs_id": fc_fsid, "tags": fw_spec.get("tags", None), "formula_pretty": structure.composition.reduced_formula, "phonon_dos_fs_id": dos_fsid, @@ -268,16 +277,11 @@ def run_task(self, fw_spec): data.update(self.get("additional_fields", {})) # Get an id for the force constants - mmdb.collection = mmdb.db["lattice_dynamics"] - fc_id = mmdb.db.counter.find_one_and_update( - {"_id": "taskid"}, - {"$inc": {"c": 1}}, - return_document=ReturnDocument.AFTER, - )["c"] - metadata = {"fc_id": fc_id, "fc_dir": os.getcwd()} + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} data.update(metadata) - mmdb.collection.insert_one(data) + mmdb.db.lattice_dynamics.insert_one(data) logger.info("Finished inserting force constants") return FWAction(update_spec=metadata) @@ -316,10 +320,11 @@ def run_task(self, fw_spec): "nonanalytic": False, "isotopes": False, "temperature": self.get("temperature", DEFAULT_TEMPERATURE), - "scell": np.diag(supercell_matrix), + "scell": np.diag(supercell_matrix).tolist(), } - control_dict.update(self.get("control_kwargs", {})) - control = Control.from_structure(structure, **control_dict) + control_kwargs = self.get("control_kwargs") or {} + control_dict.update(control_kwargs) + control = Control().from_structure(structure, **control_dict) control.to_file() shengbte_cmd = env_chk(self["shengbte_cmd"], fw_spec) @@ -335,7 +340,7 @@ def run_task(self, fw_spec): "shengbte_err.txt", "w", buffering=1 ) as f_err: # use line buffering for stderr - return_code = os.subprocess.call( + return_code = subprocess.call( shengbte_cmd, stdout=f_std, stderr=f_err ) logger.info( @@ -373,7 +378,7 @@ def run_task(self, fw_spec): db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - control = Control.from_file("CONTROL") + control = Control().from_file("CONTROL") structure = control.get_structure() supercell_matrix = np.diag(control["scell"]) @@ -385,23 +390,43 @@ def run_task(self, fw_spec): raise RuntimeError("Could not find ShengBTE output files.") bte_data = np.loadtxt(filename) + if len(bte_data.shape) == 1: + # pad extra axis to make compatible with multiple temperatures + bte_data = bte_data[None, :] + temperatures = bte_data[:, 0].tolist() - kappa = bte_data[:, 1:10].reshape(-1, 3, 3) + kappa = bte_data[:, 1:10].reshape(-1, 3, 3).tolist() data = { "structure": structure.as_dict(), "supercell_matrix": supercell_matrix.tolist(), "temperatures": temperatures, "lattice_thermal_conductivity": kappa, - "control": control.to_json(), + "control": control.as_dict(), "tags": fw_spec.get("tags", None), "formula_pretty": structure.composition.reduced_formula, "shengbte_dir": os.getcwd(), - "fc_id": fw_spec.get("fc_id", None), - "fc_dir": fw_spec.get("fc_dir", None), + "fc_fitting_id": fw_spec.get("fc_fitting_id", None), + "fc_fitting_dir": fw_spec.get("fc_fitting_dir", None), "created_at": datetime.utcnow(), } data.update(self.get("additional_fields", {})) mmdb.collection = mmdb.db["lattice_thermal_conductivity"] mmdb.collection.insert(data) + + +def _get_fc_fitting_id(mmdb: VaspCalcDb) -> int: + """Helper method to get a force constant fitting id.""" + fc_id = mmdb.db.counter.find_one_and_update( + {"_id": "fc_fitting_id"}, + {"$inc": {"c": 1}}, + return_document=ReturnDocument.AFTER, + ) + if fc_id is None: + mmdb.db.counter.insert({"_id": "fc_fitting_id", "c": 1}) + fc_id = 1 + else: + fc_id = fc_id["c"] + + return fc_id From c748e2703df441041fd72974352c15ac36ba1d70 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Fri, 28 Feb 2020 12:29:38 -0800 Subject: [PATCH 082/207] Update lattice dynamics workflow test --- .../tests/test_lattice_dynamics_workflow.py | 18 ++++++++++++++---- 1 file changed, 14 insertions(+), 4 deletions(-) diff --git a/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py b/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py index 1f0bb7254..55da5cde4 100644 --- a/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py +++ b/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py @@ -18,10 +18,12 @@ ref_dir = module_dir / "../../test_files" wf_dir = ref_dir / "lattice_dynamics_wf" -test_fworker = FWorker(env={"db_file": db_dir / "db.json"}) +test_fworker = FWorker( + env={"db_file": db_dir / "db.json", "shengbte_cmd": "ShengBTE"} +) -class TestRamanWorkflow(AtomateTest): +class TestLatticeThermalConductivityWorkflow(AtomateTest): def setUp(self, lpad=True): super().setUp(lpad=lpad) @@ -34,6 +36,14 @@ def setUp(self, lpad=True): calculate_lattice_thermal_conductivity=True ) + # change the cutoffs for fit CSLD + self.wf.fws[-2].tasks[1].update({"cutoffs": [[5., 3., 3.]]}) + + # change shengbte mesh density + self.wf.fws[-1].tasks[1].update( + {"control_kwargs": {"reciprocal_density": 500}} + ) + def test_wf(self): self.wf = get_simulated_wf(self.wf) self.lp.add_wf(self.wf) @@ -51,7 +61,7 @@ def test_wf(self): self.assertTrue(all([s == 'COMPLETED' for s in wf.fw_states.values()])) def check_run(self, d, mode): - pass + return 1 # if mode not in ["structure optimization", "static dielectric", # "raman_0_0.005", "raman analysis"]: # raise ValueError("Invalid mode!") @@ -80,7 +90,6 @@ def check_run(self, d, mode): # np.testing.assert_allclose(epsilon, d["output"]["epsilon_static"], rtol=1e-5) - def get_simulated_wf(wf): ref_dirs = {"perturbed structure: i=0; rattle_std=0.010": wf_dir / "0"} @@ -91,3 +100,4 @@ def get_simulated_wf(wf): ) return wf + From 8f238d558281484fa5e9012a21b82a0875e65cee Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 7 Apr 2020 11:44:40 -0700 Subject: [PATCH 083/207] Add powerup for updating any firetask --- atomate/common/powerups.py | 38 ++++++++++++++++++++++++++++++++++++++ 1 file changed, 38 insertions(+) diff --git a/atomate/common/powerups.py b/atomate/common/powerups.py index d76db63b5..f9658f89f 100644 --- a/atomate/common/powerups.py +++ b/atomate/common/powerups.py @@ -1,3 +1,4 @@ +<<<<<<< HEAD """ This module defines general powerups that can be used for all workflows """ @@ -318,3 +319,40 @@ def powerup_by_kwargs( if not found: raise RuntimeError(f"Could not find powerup {name}.") return original_wf +======= +from typing import Dict, Any, Optional + +from fireworks import Workflow +from atomate.utils.utils import get_fws_and_tasks + + +def update_firetask( + original_wf: Workflow, + update_params: Dict[str, Any], + task_name_constraint: str, + fw_name_constraint: Optional[str] = None, +) -> Workflow: + """ + General powerup for arbitrary updates to a Firetask. + + Args: + original_wf: The original workflow. + update_params: A dictionary of the keyword arguments to update. + task_name_constraint: Only apply changes to the Firetasks where the + Firetask class name contains this string. + fw_name_constraint: Only apply changes to Fireworks where the Firework + name contains this substring. + + Returns: + Workflow + """ + idx_list = get_fws_and_tasks( + original_wf, + fw_name_constraint=fw_name_constraint, + task_name_constraint=task_name_constraint, + ) + for idx_fw, idx_t in idx_list: + original_wf.fws[idx_fw].tasks[idx_t].update(update_params) + + return original_wf +>>>>>>> bd235a73 (Add powerup for updating any firetask) From 98c0c243cc04f363d678650bc7c9f69125ac62ac Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 7 Apr 2020 11:45:26 -0700 Subject: [PATCH 084/207] Tidy docstrings --- atomate/vasp/fireworks/core.py | 74 ++++++++++++++++++++++++++++++++++ 1 file changed, 74 insertions(+) diff --git a/atomate/vasp/fireworks/core.py b/atomate/vasp/fireworks/core.py index 7292a64dc..e99d18925 100644 --- a/atomate/vasp/fireworks/core.py +++ b/atomate/vasp/fireworks/core.py @@ -99,8 +99,13 @@ def __init__( and job_type == "double_relaxation" ): warnings.warn( +<<<<<<< HEAD f"A double relaxation run might not be appropriate with ISIF {vasp_input_set.incar['ISIF']}" ) +======= + "A double relaxation run might not be appropriate with ISIF {}".format( + vasp_input_set.incar["ISIF"])) +>>>>>>> 23b88a18 (Tidy docstrings) t = [] t.append(WriteVaspFromIOSet(structure=structure, vasp_input_set=vasp_input_set)) @@ -140,11 +145,26 @@ def __init__( **kwargs, ): """ +<<<<<<< HEAD Structure optimization using the SCAN metaGGA functional. If this Firework is initialized with no parents, it will perform a GGA optimization of the provided structure using the PBESol functional. This GGA-relaxed structure is intended to be passed to a second instance of this Firework for optimization with SCAN. (see workflow definition in metagga_optimization.yaml) +======= + Structure optimization using the SCAN metaGGA functional. + + This workflow performs a 3-step optmization. The first step ('relax1') + is a conventional GGA run relaxation that initializes the geometry and + calculates the bandgap of the structure. The bandgap is used to update + the KSPACING parameter, which sets the appropriate number of k-points + for the structure. The second step ('.relax2') is a static GGA + calculation that computes wavefunctions using the updated number of + k-points. The third step ('relax3') is a SCAN relaxation. + + By default, .relax1 and .relax2 are force converged with + EDIFFG = -0.05, and .relax3 is force converged with EDIFFG=-0.02. +>>>>>>> 23b88a18 (Tidy docstrings) Args: structure (Structure): Input structure. Note that for prev_calc_loc jobs, the structure @@ -188,6 +208,7 @@ def __init__( is not supported by this InputSet." ) +<<<<<<< HEAD if prev_calc_dir: has_previous_calc = True # Copy the CHGCAR from previous calc directory (usually PBE) @@ -218,6 +239,59 @@ def __init__( raise UserWarning( "You specified prev_calc_loc but did not provide a parent Firework. Set " "parents and try again." +======= + t = [] + # write the VASP input files based on MPScanRelaxSet + t.append(WriteVaspFromIOSet(structure=structure, + vasp_input_set=orig_input_set + ) + ) + + # pass the CalcLoc so that CopyFilesFromCalcLoc can find the directory + t.append(PassCalcLocs(name=name)) + + # Copy the pre-compiled VdW kernel for VASP, if required + if orig_input_set.vdw is not None: + t.append(CopyFiles(from_dir=vdw_kernel_dir)) + + # Copy original inputs with the ".orig" suffix + t.append( + CopyFilesFromCalcLoc( + calc_loc=True, + name_append=".orig", + exclude_files=["vdw_kernel.bindat", "FW.json", "FW--*"], + ) + ) + + # Update the INCAR for the GGA preconditioning step + # Disable writing the WAVECAR because the no. of k-points will likely + # change before the next step in the calculation + pre_opt_settings = {"_set": {"METAGGA": None, + "EDIFFG": -0.05, + "LWAVE": False}} + + # Disable vdW for the precondition step + if orig_input_set.incar.get("LUSE_VDW", None): + pre_opt_settings.update({"_unset": {"LUSE_VDW": True, + "BPARAM": 15.7}}) + + t.append(ModifyIncar(incar_dictmod=pre_opt_settings)) + + # Run the GGA .relax1 step + t.append(RunVaspCustodian(vasp_cmd=vasp_cmd, + job_type="normal_no_backup", + gzip_output=False + ) + ) + + # Copy GGA outputs with '.relax1' suffix + # by the subsequent UpdateScanRelaxBandgap Firetask + t.append( + CopyFilesFromCalcLoc( + calc_loc=True, + name_append=".relax1", + exclude_files=["vdw_kernel.bindat", "FW.json", "FW--*", "*.orig"], +>>>>>>> 23b88a18 (Tidy docstrings) ) if has_previous_calc: From a9acd1e0996d4c0c12ea81d02fe6d4cd3f7b833f Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 7 Apr 2020 11:47:10 -0700 Subject: [PATCH 085/207] Tweak lattice dynamics settings --- atomate/vasp/workflows/presets/core.py | 7 ++++++- 1 file changed, 6 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index a75f34427..8c5326f1a 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -332,6 +332,7 @@ def wf_elastic_constant(structure, c=None, order=2, sym_reduce=False): uis_optimize = {"ENCUT": 700, "EDIFF": 1e-6, "LAECHG": False, "LREAL": False} if order > 2: +<<<<<<< HEAD uis_optimize.update( { "EDIFF": 1e-10, @@ -341,6 +342,10 @@ def wf_elastic_constant(structure, c=None, order=2, sym_reduce=False): "ISYM": 0, } ) +======= + uis_optimize.update({"EDIFF": 1e-8, "EDIFFG": -0.001, + "ADDGRID": True, "LREAL": False, "ISYM": 0}) +>>>>>>> 16220e12 (Tweak lattice dynamics settings) # This ensures a consistent k-point mesh across all calculations # We also turn off symmetry to prevent VASP from changing the # mesh internally @@ -888,7 +893,7 @@ def wf_lattice_thermal_conductivity( wf.append_wf(wf_ld, wf.leaf_fw_ids) formula = structure.composition.reduced_formula - wf_name = "{} - lattice thermal conductivity preset".format(formula) + wf_name = "{} - lattice thermal conductivity".format(formula) wf.name = wf_name wf = add_common_powerups(wf, c) From 792755dd34cf46ef53f5deabbbec66b1302307d2 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 7 Apr 2020 11:48:01 -0700 Subject: [PATCH 086/207] Change imaginary mode requirements --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index e644482dc..a313c877f 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -14,7 +14,7 @@ MAX_IMAGINARY_FREQ = 10 # in THz IMAGINARY_TOL = 0.025 # in THz -MAX_N_IMAGINARY = 3 +MAX_N_IMAGINARY = np.inf FIT_METHOD = "least-squares" From cf98cc168aa3846b4cf4a76eda968e1b4ffe5b00 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 7 Apr 2020 11:48:41 -0700 Subject: [PATCH 087/207] Lattice dynamics settings tweaks --- .../vasp/workflows/base/lattice_dynamics.py | 25 +++++++++++++++---- 1 file changed, 20 insertions(+), 5 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 1f89ac2ce..6617f758c 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -115,7 +115,7 @@ def get_lattice_dynamics_wf( db_file = common_settings["DB_FILE"] if calculate_lattice_thermal_conductivity: - if supercell_matrix_kwargs.get("force_diagonal", True): + if supercell_matrix_kwargs.get("force_diagonal", False): warnings.warn( "Diagonal transformation required to calculate lattice thermal " "conductivity. Forcing diagonal matrix" @@ -218,6 +218,7 @@ def get_perturbed_structure_wf( supercell_matrix = np.eye(3) supercell_matrix = np.asarray(supercell_matrix).tolist() + natoms = len(structure * supercell_matrix) if rattle_stds is None: rattle_stds = np.linspace(0.01, 0.1, 5) @@ -227,12 +228,13 @@ def get_perturbed_structure_wf( # find the smallest nearest neighbor distance taking into account PBC min_distance = np.min( - [d.nn_distance for d in structure.get_all_neighbors(10)[0]] + [n.nn_distance for d in structure.get_all_neighbors(10) for n in d] ) - min_distance *= min_nn_scale + scaled_min_distance = min_distance * min_nn_scale all_rattle_stds = np.repeat(rattle_stds, n_configs_per_std) logger.debug("Using supercell_matrix of: {}".format(supercell_matrix)) + logger.debug("Supercell has {} atoms".format(natoms)) logger.debug( "Using {} supercells per displacement".format(n_configs_per_std) ) @@ -242,13 +244,19 @@ def get_perturbed_structure_wf( fws = [] for i, rattle_std in enumerate(all_rattle_stds): fw_name = "{}: i={}; rattle_std={:.3f}".format(name, i, rattle_std) + + # make sure the minimum distance is at least min_dist - 2 * rattle_std + # as a sanity check + rattle_min_distance = min_distance - 2 * rattle_std + rattle_min_distance = min(scaled_min_distance, rattle_min_distance) + transformations = [ "SupercellTransformation", "MonteCarloRattleTransformation", ] transformation_params = [ {"scaling_matrix": supercell_matrix}, - {"rattle_std": rattle_std, "min_distance": min_distance}, + {"rattle_std": rattle_std, "min_distance": rattle_min_distance}, ] fw = TransmuterFW( @@ -263,6 +271,11 @@ def get_perturbed_structure_wf( db_file=db_file, ) + # don't store CHGCAR and other volumetric data in the VASP drone + for task in fw.tasks: + if "VaspToDb" in str(task): + task.update({"store_volumetric_data": tuple()}) + if pass_forces: pass_dict = { "parent_structure": structure.as_dict(), @@ -287,7 +300,7 @@ def get_num_supercells( supercell_structure: Structure, symprec: float = 0.01, min_num_equivalent_sites: int = 100, - max_num_supercells: int = 30, + max_num_supercells: int = 6, ) -> int: """ Get the number of supercells to run per rattle standard deviation. @@ -329,3 +342,5 @@ def _get_common_settings(common_settings: Optional[Dict]): common_settings["user_incar_settings"] = user_incar_settings return common_settings + + From 67bd581481e2e84d2d6519bf103f6b8c966ea0f6 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 7 Apr 2020 12:16:24 -0700 Subject: [PATCH 088/207] Copy vasp outputs --- atomate/vasp/workflows/presets/core.py | 1 + 1 file changed, 1 insertion(+) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 8c5326f1a..3b4d03fd5 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -888,6 +888,7 @@ def wf_lattice_thermal_conductivity( structure, common_settings=c, calculate_lattice_thermal_conductivity=True, + copy_vasp_outputs=True, **ld_kwargs ) wf.append_wf(wf_ld, wf.leaf_fw_ids) From 103e46c88012bf9bbc444a7f49d7c154dccf6664 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Tue, 7 Apr 2020 12:59:43 -0700 Subject: [PATCH 089/207] Fix bug in lattice dynamics wf --- atomate/vasp/workflows/presets/core.py | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 3b4d03fd5..76fd7cfe3 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -879,6 +879,10 @@ def wf_lattice_thermal_conductivity( 'LCHARG': False, 'LASPH': True } + c = c if c is not None else {} + if "USER_INCAR_SETTINGS" not in c: + c["USER_INCAR_SETTINGS"] = {} + # wf_structure_optimization expects user incar settings in capitals c["USER_INCAR_SETTINGS"].update(optimize_uis) c["USER_INCAR_SETTINGS"].update(c.get("user_incar_settings", {})) From b7804b97b50a49f524acd622cf55f7d5f380cf78 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Fri, 10 Apr 2020 10:38:12 -0700 Subject: [PATCH 090/207] Tweak VaspToDb params --- atomate/vasp/firetasks/parse_outputs.py | 23 +++++++++++++++++++ .../vasp/workflows/base/lattice_dynamics.py | 10 ++++++-- atomate/vasp/workflows/presets/core.py | 8 ++++++- 3 files changed, 38 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 488838577..25fd107a6 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -117,6 +117,7 @@ class VaspToDb(FiretaskBase): Format: {key : path} -> fw.spec[key] = task_doc[path] The path is a full mongo-style path so subdocuments can be referenced using dot notation and array keys can be referenced using the index. +<<<<<<< HEAD E.g "calcs_reversed.0.output.outcar.run_stats" """ @@ -136,6 +137,17 @@ class VaspToDb(FiretaskBase): "parse_bader", "store_volumetric_data", ] +======= + E.g "calcs_reversed.0.output.outar.run_stats" + vasp_drone_params (dict): Additional keyword arguments to pass to the + VaspDrone. + """ + optional_params = ["calc_dir", "calc_loc", "parse_dos", "bandstructure_mode", + "additional_fields", "db_file", "fw_spec_field", "defuse_unsuccessful", + "task_fields_to_push", "parse_chgcar", "parse_aeccar", + "parse_potcar_file", + "store_volumetric_data", "vasp_drone_params"] +>>>>>>> cf160919 (Tweak VaspToDb params) def run_task(self, fw_spec): # get the directory that contains the VASP dir to parse @@ -148,6 +160,7 @@ def run_task(self, fw_spec): # parse the VASP directory logger.info(f"PARSING DIRECTORY: {calc_dir}") +<<<<<<< HEAD drone = VaspDrone( additional_fields=self.get("additional_fields"), parse_dos=self.get("parse_dos", False), @@ -160,6 +173,16 @@ def run_task(self, fw_spec): "store_volumetric_data", STORE_VOLUMETRIC_DATA ), ) +======= + drone = VaspDrone(additional_fields=self.get("additional_fields"), + parse_dos=self.get("parse_dos", False), + parse_potcar_file=self.get("parse_potcar_file", True), + bandstructure_mode=self.get("bandstructure_mode", False), + parse_chgcar=self.get("parse_chgcar", False), # deprecated + parse_aeccar=self.get("parse_aeccar", False), # deprecated + store_volumetric_data=self.get("store_volumetric_data", STORE_VOLUMETRIC_DATA), + **self.get("vasp_drone_params", {})) +>>>>>>> cf160919 (Tweak VaspToDb params) # assimilate (i.e., parse) task_doc = drone.assimilate(calc_dir) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 6617f758c..6bead2a7e 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -40,6 +40,12 @@ "LREAL": False, "LASPH": True, } + +vasp_to_db_params = { + "store_volumetric_data": tuple(), + "vasp_drone_params": {"parse_bader": False, "parse_locpot": False} +} + _DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} _WF_VERSION = 0.1 @@ -221,7 +227,7 @@ def get_perturbed_structure_wf( natoms = len(structure * supercell_matrix) if rattle_stds is None: - rattle_stds = np.linspace(0.01, 0.1, 5) + rattle_stds = np.linspace(0.008, 0.08, 5) if vasp_input_set is None: vasp_input_set = MPStaticSet(structure) @@ -274,7 +280,7 @@ def get_perturbed_structure_wf( # don't store CHGCAR and other volumetric data in the VASP drone for task in fw.tasks: if "VaspToDb" in str(task): - task.update({"store_volumetric_data": tuple()}) + task.update(vasp_to_db_params) if pass_forces: pass_dict = { diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 76fd7cfe3..6e98f1194 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -10,7 +10,8 @@ import numpy as np -from atomate.vasp.workflows.base.lattice_dynamics import get_lattice_dynamics_wf +from atomate.vasp.workflows.base.lattice_dynamics import \ + get_lattice_dynamics_wf, vasp_to_db_params from fireworks import Workflow from pymatgen import Structure from pymatgen.io.vasp.sets import MPRelaxSet, MPStaticSet, MPHSERelaxSet @@ -888,6 +889,11 @@ def wf_lattice_thermal_conductivity( c["USER_INCAR_SETTINGS"].update(c.get("user_incar_settings", {})) wf = wf_structure_optimization(structure, c=c) + # don't store CHGCAR and other volumetric data in the VASP drone + for task in wf.fws[0].tasks: + if "VaspToDb" in str(task): + task.update(vasp_to_db_params) + wf_ld = get_lattice_dynamics_wf( structure, common_settings=c, From fc248e2a508c2f0268b7f7fdc92fab2f2bfeb1a3 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Sat, 11 Apr 2020 12:29:22 -0700 Subject: [PATCH 091/207] Handle prior structural relaxations --- atomate/vasp/firetasks/lattice_dynamics.py | 18 +++++++++++++++--- .../vasp/workflows/base/lattice_dynamics.py | 2 ++ 2 files changed, 17 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index cefa4e166..bd63afcb6 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -20,7 +20,9 @@ get_cutoffs, ) from atomate.vasp.database import VaspCalcDb +from atomate.vasp.drones import VaspDrone from fireworks import FiretaskBase, FWAction, explicit_serialize +from pymatgen import Structure from pymatgen.io.ase import AseAtomsAdaptor from pymatgen.io.phonopy import get_phonon_band_structure_from_fc, \ get_phonon_dos_from_fc, get_phonon_band_structure_symm_line_from_fc @@ -68,12 +70,22 @@ def run_task(self, fw_spec): logger.info("Found {} perturbed structures".format(len(results))) - structure = results[0]["parent_structure"] - supercell_matrix = results[0]["supercell_matrix"] - structures = [r["structure"] for r in results] forces = [np.asarray(r["forces"]) for r in results] + # if relaxation, get original structure from that calculation + calc_locs = fw_spec.get("calc_locs", []) + opt_calc_locs = [c for c in calc_locs if "optimiz" in c["name"]] + if opt_calc_locs: + opt_loc = opt_calc_locs[-1]["path"] + logger.info("Parsing optimization directory: {}".format(opt_loc)) + opt_doc = VaspDrone().assimilate(opt_loc) + opt_output = opt_doc["calcs_reversed"][0]["output"] + structure = Structure.from_dict(opt_output["structure"]) + else: + structure = results[0]["parent_structure"] + supercell_matrix = results[0]["supercell_matrix"] + # regenerate pure supercell structure st = SupercellTransformation(supercell_matrix) supercell_structure = st.apply_transformation(structure) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 6bead2a7e..ec063f094 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -39,6 +39,8 @@ "LAECHG": False, "LREAL": False, "LASPH": True, + "LVTOT": False, + "LVHAR": False, } vasp_to_db_params = { From 6fa622eda379bcaf2b093568c755d2efa8308265 Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Sat, 11 Apr 2020 16:16:53 -0700 Subject: [PATCH 092/207] optimize drone parsing --- atomate/vasp/firetasks/lattice_dynamics.py | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index bd63afcb6..b91ebdb42 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -79,7 +79,10 @@ def run_task(self, fw_spec): if opt_calc_locs: opt_loc = opt_calc_locs[-1]["path"] logger.info("Parsing optimization directory: {}".format(opt_loc)) - opt_doc = VaspDrone().assimilate(opt_loc) + opt_doc = VaspDrone( + parse_dos=False, parse_locpot=False, + parse_bader=False, store_volumetric_data=[], + ).assimilate(opt_loc) opt_output = opt_doc["calcs_reversed"][0]["output"] structure = Structure.from_dict(opt_output["structure"]) else: From 83b4837321c6110b606ce86738be398e0a26d0aa Mon Sep 17 00:00:00 2001 From: Alex Ganose Date: Sat, 11 Apr 2020 17:00:06 -0700 Subject: [PATCH 093/207] fix typo in hiphive analysis --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index a313c877f..8ba57c551 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -68,7 +68,7 @@ def get_cutoffs(structure: Structure): row = min([s.row for s in structure.species]) mins = { - 2: min_cutoffs[row][2], 3: min_cutoffs[row][3], 4: min_cutoffs[row][4] + 2: min_cutoffs[2][row], 3: min_cutoffs[3][row], 4: min_cutoffs[4][row] } range_two = np.arange(mins[2], mins[2] + inc[2] + steps[2], steps[2]) From 2eca8765190fed7528c9b5d1d0c0dd41f8401a37 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Tue, 25 May 2021 23:04:25 -0700 Subject: [PATCH 094/207] gruneisen and CTE --- atomate/vasp/analysis/lattice_dynamics.py | 193 ++++++++++++++++-- .../vasp/workflows/base/lattice_dynamics.py | 5 +- 2 files changed, 179 insertions(+), 19 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 8ba57c551..10ca27fbe 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -4,11 +4,18 @@ import numpy as np from atomate.utils.utils import get_logger +<<<<<<< HEAD from pymatgen import Structure +======= +from hiphive.cutoffs import is_cutoff_allowed, estimate_maximum_cutoff +from hiphive import ForceConstants +from pymatgen.core.structure import Structure +from pymatgen.io.ase import AseAtomsAdaptor +>>>>>>> 8f4f7e37 (gruneisen and CTE) from pymatgen.io.phonopy import get_phonopy_structure -__author__ = "Alex Ganose, Rees Chang" -__email__ = "aganose@lbl.gov, rc564@cornell.edu" +__author__ = "Alex Ganose, Rees Chang, Junsoo Park" +__email__ = "aganose@lbl.gov, rc564@cornell.edu, jsyony37@lbl.gov" logger = get_logger(__name__) @@ -124,17 +131,24 @@ def fit_force_constants( ``SortedForceConstants`` object and a dictionary of information on the fitting process. """ +<<<<<<< HEAD from hiphive.fitting import Optimizer from hiphive import ForceConstantPotential, enforce_rotational_sum_rules logger.info("Starting fitting force constants.") +======= + logger.info("Starting force constant fitting.") +>>>>>>> 8f4f7e37 (gruneisen and CTE) fitting_data = { "cutoffs": [], "rmse_test": [], "n_imaginary": [], "min_frequency": [], - "300K_free_energy": [], + "temperature": [], + "free_energy": [], + "entropy": [], + "heat_capacity": [], "fit_method": fit_method, "imaginary_tol": imaginary_tol, "max_n_imaginary": max_n_imaginary, @@ -150,7 +164,66 @@ def fit_force_constants( "cutoffs": None, } n_cutoffs = len(all_cutoffs) +<<<<<<< HEAD for i, cutoffs in enumerate(all_cutoffs): +======= + + fit_kwargs = fit_kwargs if fit_kwargs else {} + if fit_method == "rfe" and n_jobs == -1: + fit_kwargs["n_jobs"] = 1 + + cutoff_results = Parallel(n_jobs=-1, backend="multiprocessing")(delayed(_run_cutoffs)( + i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, + fit_method, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) + + for result in cutoff_results: + if result is None: + pass + + fitting_data["cutoffs"].append(result["cutoffs"]) + fitting_data["rmse_test"].append(result["rmse_test"]) + fitting_data["n_imaginary"].append(result["n_imaginary"]) + fitting_data["min_frequency"].append(result["min_frequency"]) + fitting_data["temperature"].append(result["temperature"]) + fitting_data["free_energy"].append(result["free_energy"]) + fitting_data["entropy"].append(result["entropy"]) + fitting_data["heat_capcity"].append(result["heat_capacity"]) + + if ( + result["min_frequency"] > -np.abs(max_imaginary_freq) +# and result["n_imaginary"] <= max_n_imaginary +# and result["n_imaginary"] < best_fit["n_imaginary"] + and result["rmse_test"] < best_fit["rmse_test"] + ): + best_fit.update(result) + fitting_data["best"] = result["cutoffs"] + + logger.info("Finished fitting force constants.") + + return best_fit["force_constants"], fitting_data + + +def _run_cutoffs( + i, + cutoffs, + n_cutoffs, + parent_structure, + structures, + supercell_matrix, + fit_method, + imaginary_tol, + fit_kwargs +): + from hiphive.fitting import Optimizer + from hiphive import ForceConstantPotential, enforce_rotational_sum_rules + + logger.info( + "Testing cutoffs {} out of {}: {}".format(i + 1, n_cutoffs, cutoffs) + ) + supercell_atoms = structures[0] + + if not is_cutoff_allowed(supercell_atoms, max(cutoffs)): +>>>>>>> 8f4f7e37 (gruneisen and CTE) logger.info( "Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs) ) @@ -164,10 +237,12 @@ def fit_force_constants( fcp = ForceConstantPotential(sc.cluster_space, parameters) fcs = fcp.get_force_constants(supercell_atoms) - phonopy_fcs = fcs.get_fc_array(order=2) - n_imaginary, min_freq, free_energy = evaluate_force_constants( - parent_structure, supercell_matrix, phonopy_fcs, imaginary_tol + T_qha = [i*100 for i in range(16)] +# phonopy_fcs = fcs.get_fc_array(order=2) + n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( + parent_structure, supercell_matrix, fcs, imaginary_tol, T_qha ) +<<<<<<< HEAD fitting_data["cutoffs"].append(cutoffs) fitting_data["rmse_test"].append(opt.rmse_test) @@ -194,6 +269,22 @@ def fit_force_constants( logger.info("Finished fitting force constants.") return best_fit["force_constants"], fitting_data +======= + return { + "cutoffs": cutoffs, + "rmse_test": opt.rmse_test, + "n_imaginary": n_imaginary, + "min_frequency": min_freq, + "temperature": T_qha, + "free_energy": free_energy, + "entropy": entropy, + "heat_capacity": Cv, + "thermal_expansion": cte, + "force_constants": fcp + } + except Exception: + return None +>>>>>>> 8f4f7e37 (gruneisen and CTE) def get_structure_container( @@ -226,9 +317,10 @@ def get_structure_container( def evaluate_force_constants( structure: Structure, supercell_matrix: np.ndarray, - force_constants: np.ndarray, + force_constants: ForceConstants, imaginary_tol: float = IMAGINARY_TOL, -) -> Tuple[int, float, float]: + T: List +) -> Tuple[int, float, List, List, List]: """ Uses the force constants to extract phonon properties. Used for comparing the accuracy of force constant fits. @@ -242,22 +334,87 @@ def evaluate_force_constants( Returns: A tuple of the number of imaginary modes at Gamma, the minimum phonon - frequency at Gamma, and the free energy at 300 K. + frequency at Gamma, and the free energy, entropy, and heat capacity """ from phonopy import Phonopy + fcs2 = fcs.get_fc_array(2) + fcs3 = fcs.get_fc_array(3) parent_phonopy = get_phonopy_structure(structure) phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) - phonopy.set_force_constants(force_constants) + phonopy.set_force_constants(fcs2) phonopy.run_mesh(is_gamma_center=True) - phonopy.run_thermal_properties(temperatures=[300]) - free_energy = phonopy.get_thermal_properties_dict()["free_energy"][0] - + phonopy.run_thermal_properties(temperatures=T) + free_energy = phonopy.get_thermal_properties_dict()["free_energy"] + entropy = phonopy.get_thermal_properties_dict()["entropy"] + Cv = phonopy.get_thermal_properties_dict()["heat_capacity"] + freq = phonopy.mesh.frequencies # find imaginary modes at gamma - phonopy.run_qpoints([0, 0, 0]) - gamma_eigs = phonopy.get_qpoints_dict()["frequencies"] - n_imaginary = int(np.sum(gamma_eigs < -np.abs(imaginary_tol))) - min_frequency = np.min(gamma_eigs) +# phonopy.run_qpoints([0, 0, 0]) +# gamma_eigs = phonopy.get_qpoints_dict()["frequencies"] + n_imaginary = int(np.sum(freq < -np.abs(imaginary_tol))) + min_frequency = np.min(freq) + + if n_imeginary > 0: + grun, cte = gruneisen(phonopy,fcs2,fcs3,mesh,T,Cv,bulk_mod,vol) + dLfrac = thermal_expansion(T,cte) + else: + grun = np.zeros((len(T),3)) + cte = np.zeros((len(T),3)) + dLfrac = np.zeros((len(T),3)) + + return n_imaginary, min_frequency, free_energy, entropy, Cv, grun, cte, dLfrac + + +def gruneisen( + phonopy: Phonopy, + fcs2: np.ndarray, + fcs3: np.ndarray, + mesh: List, + temperature: List, + Cv: List, # in J + bulk_mod: float, # in GPa + vol: float # in A^3 +) -> Tuple[List,List]: + + from phono3py.phonon3.gruneisen import Gruneisen + + gruneisen = Gruneisen(fcs2,fcs3,phonopy.supercell,phonopy.primitive) + gruneisen.set_sampling_mesh(mesh,is_gamma_center=True) + gruneisen.run() + grun = gruneisen.get_gruneisen_parameters() # (nptk,nmode,3,3) + omega = gruneisen._frequencies + qp = gruneisen._qpoints + kweight = gruneisen._weights + grun_tot = list() + for temp in temperature: + grun_tot.append(get_total_grun(omega,grun,kweight,temp)) + grun_tot = np.array(np.nan_to_num(np.array(grun_tot))) + # linear thermal expansion coefficient + cte = grun_tot*(Cv.repeat(3).reshape((len(Cv),3)))/(vol/10**30)/(bulk_mod*10**9)/3 + cte = np.nan_to_num(cte) + logger.info('Frequency : {}'.format(np.sort(omega.flatten()))) + logger.info('Gruneisen : {}'.format(grun_tot)) + logger.info('CTE : {}'.format(cte)) + return grun_tot, cte + + +def thermal_expansion( + temperature: List, + cte: List +) -> List: + assert len(temperature)==len(cte) + if 0 not in temperature: + temperature = [0] + temperature + cte = [[0,0,0]] + cte + temperature = np.array(temperature) + cte = np.array(cte) + # linear expansion fraction + dLfrac = copy(cte) + for t in range(len(temperature)): + dLfrac[t,:] = np.trapz(cte[:t+1,:],temperature[:t+1],axis=0) + dLfrac = np.nan_to_num(dLfrac) + logger.info('dLfrac : {}'.format(dLfrac)) + return dLfrac - return n_imaginary, min_frequency, free_energy diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index ec063f094..e7c7d842f 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -126,7 +126,7 @@ def get_lattice_dynamics_wf( if supercell_matrix_kwargs.get("force_diagonal", False): warnings.warn( "Diagonal transformation required to calculate lattice thermal " - "conductivity. Forcing diagonal matrix" + "conductivity using ShengBTE. Forcing diagonal matrix" ) supercell_matrix_kwargs["force_diagonal"] = True @@ -138,6 +138,7 @@ def get_lattice_dynamics_wf( n_supercells = get_num_supercells(supercell, **num_supercell_kwargs) perturbed_structure_kwargs["n_configs_per_std"] = n_supercells + # 1. Start by pertrubing supercell and calculating forces wf = get_perturbed_structure_wf( structure, supercell_matrix=supercell_matrix, @@ -148,12 +149,14 @@ def get_lattice_dynamics_wf( **perturbed_structure_kwargs, ) + # 2. Fit interatomic force constants from pertrubed structures allow_fizzled = {"_allow_fizzled_parents": True} fw_fit_force_constant = FitForceConstantsFW( db_file=db_file, spec=allow_fizzled ) wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) + # 3. Lattice thermal conductivity calculation (optional) if calculate_lattice_thermal_conductivity: fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, From f5bf0eeb3af8bdbc4066272bc597d51afe3efd11 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 26 May 2021 13:35:09 -0700 Subject: [PATCH 095/207] gruneisen --- atomate/vasp/analysis/lattice_dynamics.py | 24 ++++++++++++++++------- 1 file changed, 17 insertions(+), 7 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 10ca27fbe..63e183cda 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -240,7 +240,7 @@ def _run_cutoffs( T_qha = [i*100 for i in range(16)] # phonopy_fcs = fcs.get_fc_array(order=2) n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( - parent_structure, supercell_matrix, fcs, imaginary_tol, T_qha + parent_structure, supercell_matrix, fcs, T_qha, imaginary_tol ) <<<<<<< HEAD @@ -318,8 +318,8 @@ def evaluate_force_constants( structure: Structure, supercell_matrix: np.ndarray, force_constants: ForceConstants, - imaginary_tol: float = IMAGINARY_TOL, - T: List + T: List, + imaginary_tol: float = IMAGINARY_TOL ) -> Tuple[int, float, List, List, List]: """ Uses the force constants to extract phonon properties. Used for comparing @@ -402,19 +402,29 @@ def gruneisen( def thermal_expansion( temperature: List, - cte: List -) -> List: + cte: List, + T=None: float +) -> np.ndarray: assert len(temperature)==len(cte) if 0 not in temperature: temperature = [0] + temperature cte = [[0,0,0]] + cte temperature = np.array(temperature) - cte = np.array(cte) + ind = np.argsort(temperature) + temperature = temperature[ind] + cte = np.array(cte)[ind] # linear expansion fraction dLfrac = copy(cte) for t in range(len(temperature)): dLfrac[t,:] = np.trapz(cte[:t+1,:],temperature[:t+1],axis=0) dLfrac = np.nan_to_num(dLfrac) logger.info('dLfrac : {}'.format(dLfrac)) - return dLfrac + if T is None: + return dLfrac + else: + try: + T_ind = np.where(temperature==T)[0][0] + return [dLfrac[T_ind]] + except: + raise ValueError('Designated T does not exist in the temperature array!') From 6ea285bbe3248f373453c505fd11d361295c6022 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 26 May 2021 14:00:04 -0700 Subject: [PATCH 096/207] gruneisen --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 63e183cda..2714571a1 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -424,7 +424,7 @@ def thermal_expansion( else: try: T_ind = np.where(temperature==T)[0][0] - return [dLfrac[T_ind]] + return np.array([dLfrac[T_ind]]) except: raise ValueError('Designated T does not exist in the temperature array!') From 8f767d9229bbd8ac510b89dc0e4b45bea828da32 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 26 May 2021 15:05:18 -0700 Subject: [PATCH 097/207] gruneisen --- atomate/vasp/analysis/lattice_dynamics.py | 23 ++++++++++++++++------- 1 file changed, 16 insertions(+), 7 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 2714571a1..8222d73d8 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -2,6 +2,7 @@ from typing import Dict, List, Tuple import numpy as np +import scipy as sp from atomate.utils.utils import get_logger <<<<<<< HEAD @@ -23,7 +24,7 @@ IMAGINARY_TOL = 0.025 # in THz MAX_N_IMAGINARY = np.inf FIT_METHOD = "least-squares" - +eV2J = 1.602e-19 def get_cutoffs(structure: Structure): """ @@ -342,14 +343,21 @@ def evaluate_force_constants( fcs3 = fcs.get_fc_array(3) parent_phonopy = get_phonopy_structure(structure) phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) - + vol = phonopy.primitive.get_volume() + natom = phonopy.primitive.get_number_of_atoms() + phonopy.set_force_constants(fcs2) phonopy.run_mesh(is_gamma_center=True) phonopy.run_thermal_properties(temperatures=T) + free_energy = phonopy.get_thermal_properties_dict()["free_energy"] + free_energy *= 1000/sp.constants.Avogadro/eV2J/natom # kJ/mol to eV/atom entropy = phonopy.get_thermal_properties_dict()["entropy"] + entropy *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom Cv = phonopy.get_thermal_properties_dict()["heat_capacity"] - freq = phonopy.mesh.frequencies + Cv *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom + + freq = phonopy.mesh.frequencies # in THz # find imaginary modes at gamma # phonopy.run_qpoints([0, 0, 0]) # gamma_eigs = phonopy.get_qpoints_dict()["frequencies"] @@ -359,7 +367,7 @@ def evaluate_force_constants( if n_imeginary > 0: grun, cte = gruneisen(phonopy,fcs2,fcs3,mesh,T,Cv,bulk_mod,vol) dLfrac = thermal_expansion(T,cte) - else: + else: # do not calculate these if imaginary modes exist grun = np.zeros((len(T),3)) cte = np.zeros((len(T),3)) dLfrac = np.zeros((len(T),3)) @@ -373,11 +381,11 @@ def gruneisen( fcs3: np.ndarray, mesh: List, temperature: List, - Cv: List, # in J + Cv: np.ndarray, # in eV/K/atom bulk_mod: float, # in GPa vol: float # in A^3 ) -> Tuple[List,List]: - + from phono3py.phonon3.gruneisen import Gruneisen gruneisen = Gruneisen(fcs2,fcs3,phonopy.supercell,phonopy.primitive) @@ -391,6 +399,7 @@ def gruneisen( for temp in temperature: grun_tot.append(get_total_grun(omega,grun,kweight,temp)) grun_tot = np.array(np.nan_to_num(np.array(grun_tot))) + Cv *= eV2J*phonopy.primitive.get_number_of_atoms() # eV/K/atom to J/K # linear thermal expansion coefficient cte = grun_tot*(Cv.repeat(3).reshape((len(Cv),3)))/(vol/10**30)/(bulk_mod*10**9)/3 cte = np.nan_to_num(cte) @@ -403,7 +412,7 @@ def gruneisen( def thermal_expansion( temperature: List, cte: List, - T=None: float + T: Optional[float]=None ) -> np.ndarray: assert len(temperature)==len(cte) if 0 not in temperature: From bdc514356abf506b479921666475baa797660e32 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 26 May 2021 17:59:39 -0700 Subject: [PATCH 098/207] imports --- atomate/vasp/analysis/lattice_dynamics.py | 20 +++++++++++++------- 1 file changed, 13 insertions(+), 7 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 8222d73d8..269891ac4 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -6,15 +6,27 @@ from atomate.utils.utils import get_logger <<<<<<< HEAD +<<<<<<< HEAD from pymatgen import Structure ======= +======= + +from hiphive import (ForceConstants, ForceConstantPotential, + enforce_rotational_sum_rules, ClusterSpace, + StructureContainer) +>>>>>>> 1e75a82a (imports) from hiphive.cutoffs import is_cutoff_allowed, estimate_maximum_cutoff -from hiphive import ForceConstants +from hiphive.fitting import Optimizer + from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor >>>>>>> 8f4f7e37 (gruneisen and CTE) from pymatgen.io.phonopy import get_phonopy_structure +from phonopy import Phonopy +from phono3py.phonon3.gruneisen import Gruneisen + + __author__ = "Alex Ganose, Rees Chang, Junsoo Park" __email__ = "aganose@lbl.gov, rc564@cornell.edu, jsyony37@lbl.gov" @@ -215,8 +227,6 @@ def _run_cutoffs( imaginary_tol, fit_kwargs ): - from hiphive.fitting import Optimizer - from hiphive import ForceConstantPotential, enforce_rotational_sum_rules logger.info( "Testing cutoffs {} out of {}: {}".format(i + 1, n_cutoffs, cutoffs) @@ -302,7 +312,6 @@ def get_structure_container( Returns: A hiPhive StructureContainer. """ - from hiphive import ClusterSpace, StructureContainer cs = ClusterSpace(structures[0], cutoffs) logger.debug(cs.__repr__()) @@ -337,7 +346,6 @@ def evaluate_force_constants( A tuple of the number of imaginary modes at Gamma, the minimum phonon frequency at Gamma, and the free energy, entropy, and heat capacity """ - from phonopy import Phonopy fcs2 = fcs.get_fc_array(2) fcs3 = fcs.get_fc_array(3) @@ -385,8 +393,6 @@ def gruneisen( bulk_mod: float, # in GPa vol: float # in A^3 ) -> Tuple[List,List]: - - from phono3py.phonon3.gruneisen import Gruneisen gruneisen = Gruneisen(fcs2,fcs3,phonopy.supercell,phonopy.primitive) gruneisen.set_sampling_mesh(mesh,is_gamma_center=True) From d12802dda421e415eae99a5b2a071e3c07172b37 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 26 May 2021 19:52:55 -0700 Subject: [PATCH 099/207] FW --- atomate/vasp/analysis/lattice_dynamics.py | 8 +- atomate/vasp/firetasks/lattice_dynamics.py | 102 ++++++++++++++++++++- atomate/vasp/fireworks/lattice_dynamics.py | 54 +++++++++++ 3 files changed, 156 insertions(+), 8 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 269891ac4..28cc37a87 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -35,6 +35,9 @@ MAX_IMAGINARY_FREQ = 10 # in THz IMAGINARY_TOL = 0.025 # in THz MAX_N_IMAGINARY = np.inf +T_QHA = [i*100 for i in range(16)] +T_RENORM = [i*100 for i in range(0,16,3)] + FIT_METHOD = "least-squares" eV2J = 1.602e-19 @@ -248,10 +251,9 @@ def _run_cutoffs( fcp = ForceConstantPotential(sc.cluster_space, parameters) fcs = fcp.get_force_constants(supercell_atoms) - T_qha = [i*100 for i in range(16)] # phonopy_fcs = fcs.get_fc_array(order=2) n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( - parent_structure, supercell_matrix, fcs, T_qha, imaginary_tol + parent_structure, supercell_matrix, fcs, T_QHA, imaginary_tol ) <<<<<<< HEAD @@ -286,7 +288,7 @@ def _run_cutoffs( "rmse_test": opt.rmse_test, "n_imaginary": n_imaginary, "min_frequency": min_freq, - "temperature": T_qha, + "temperature": T_QHA, "free_energy": free_energy, "entropy": entropy, "heat_capacity": Cv, diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index b91ebdb42..dad1a4fa4 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -16,13 +16,17 @@ IMAGINARY_TOL, MAX_IMAGINARY_FREQ, MAX_N_IMAGINARY, + T_QHA, + T_RENORM, fit_force_constants, get_cutoffs, ) from atomate.vasp.database import VaspCalcDb from atomate.vasp.drones import VaspDrone + from fireworks import FiretaskBase, FWAction, explicit_serialize -from pymatgen import Structure + +from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor from pymatgen.io.phonopy import get_phonon_band_structure_from_fc, \ get_phonon_dos_from_fc, get_phonon_band_structure_symm_line_from_fc @@ -33,17 +37,18 @@ try: import hiphive + from hiphive.utilities import get_displacements + from hiphive import Renormalization except ImportError: hiphive = False -__author__ = "Alex Ganose" -__email__ = "aganose@lbl.gov" +__author__ = "Alex Ganose, Junsoo Park" +__email__ = "aganose@lbl.gov, jsyony37@lbl.gov" logger = get_logger(__name__) # define shared constants -DEFAULT_TEMPERATURE = 300 MESH_DENSITY = 100.0 # should always be a float @@ -196,6 +201,93 @@ def run_task(self, fw_spec): ) + +@explicit_serialize +class RunHiPhiveRenorm(FiretaskBase): + """ + Perform phonon renormalization to obtain temperature-dependent force constants + using hiPhive. Requires "structure_data.json" to be present in the current working + directory. + + cs,supercell,fcs,param,T, + + Required parameters: + cs (hiphive.ClusterSpace): A list of cutoffs to trial. If None, + a set of trial cutoffs will be generated based on the structure + (default). + supercell (ase.Atoms): Tolerance used to decide if a phonon mode + is imaginary, in THz. + fcs (hiphive.ForceConstants): Maximum number of imaginary modes allowed in the + the final fitted force constant solution. If this criteria is not + reached by any cutoff combination this FireTask will fizzle. + param (np.ndarray): array of force constant parameters + Optional parameter: + T_renorm (List): list of temperatures to perform renormalization - default is T_RENORM + """ + + required_params = ["cs","supercell","fcs","param"] + optional_params = ["T_renorm"] + + @requires(hiphive, "hiphive is required for lattice dynamics workflow") + def run_task(self, fw_spec): + from hiphive.utilities import get_displacements + + max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) + max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) + imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) + fit_method = self.get("T_renorm", T_RENORM) + + all_structures = loadfn("perturbed_structures.json") + all_forces = loadfn("perturbed_forces.json") + structure_data = loadfn("structure_data.json") + parent_structure = structure_data["structure"] + supercell_matrix = structure_data["supercell_matrix"] + supercell_structure = structure_data["supercell_structure"] + + structures = [] + supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) + for structure, forces in zip(all_structures, all_forces): + atoms = AseAtomsAdaptor.get_atoms(structure) + displacements = get_displacements(atoms, supercell_atoms) + atoms.new_array("displacements", displacements) + atoms.new_array("forces", forces) + atoms.positions = supercell_atoms.get_positions() + structures.append(atoms) + + cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) + force_constants, fitting_data = fit_force_constants( + parent_structure, + supercell_matrix, + structures, + cutoffs, + imaginary_tol, + max_n_imaginary, + max_imaginary_freq, + fit_method, + ) + + dumpfn(fitting_data, "fitting_data.json") + + if force_constants is None: + # fitting failed + raise RuntimeError( + "Could not find a force constant solution with less than {} " + "imaginary modes.\n" + "Fitting results: {}".format(max_n_imaginary, fitting_data) + ) + + else: + logger.info("Writing force constants.") + force_constants.write("force_constants.fcs") + + atoms = AseAtomsAdaptor.get_atoms(parent_structure) + force_constants.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms) + force_constants.write_to_phonopy( + "FORCE_CONSTANTS_2ND", format="text" + ) + + + @explicit_serialize class ForceConstantsToDb(FiretaskBase): """ @@ -334,7 +426,7 @@ def run_task(self, fw_spec): "scalebroad": 0.5, "nonanalytic": False, "isotopes": False, - "temperature": self.get("temperature", DEFAULT_TEMPERATURE), + "temperature": self.get("temperature", T_QHA), "scell": np.diag(supercell_matrix).tolist(), } control_kwargs = self.get("control_kwargs") or {} diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 18cdd4664..6e7d4e621 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -134,3 +134,57 @@ def __init__( tasks = [copy_files, run_shengbte, shengbte_to_db] super().__init__(tasks, name=name, **kwargs) + + + +class RenormalizationFW(Firework): + """ + Performs temperature-dependent phonon renormalization to obtain phonons + at finite temperatures. Can be used to stabilize dynamically unstable modes + + Args: + name: Name of this FW. + prev_calc_dir: Path to a directory containing the force constant + information. Will override ``parents`` when collecting the force + constants to run ShengBTE. + db_file: Path to a db file. + shengbte_cmd: The name of the shengbte executable to run. Supports + env_chk. + temperature: The temperature to perform phonon renormalization at + Can be given as a single float, or a dictionary with the keys + "min", "max", "step". + shengbte_control_kwargs: Options to be included in the ShengBTE + control file. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ + + def __init__( + self, + name="Renormalization", + prev_calc_dir: Optional[str] = None, + db_file: str = None, + shengbte_cmd: str = SHENGBTE_CMD, + temperature: Union[float, dict] = DEFAULT_TEMPERATURE, + shengbte_control_kwargs: Optional[dict] = None, + **kwargs + ): + + # files needed to run ShengBTE + files = [ + "structure_data.json", + "FORCE_CONSTANTS_2ND", + "FORCE_CONSTANTS_3RD", + ] + + if prev_calc_dir: + copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) + else: + copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + + fit_constants = RunHiPhiveRenorm( + cutoffs=cutoffs, + imaginary_tol=imaginary_tol, + max_n_imaginary=max_n_imaginary, + max_imaginary_freq=max_imaginary_freq, + fit_method=fit_method, + ) From f9bc14cc6ab985a882160c5e49212d620d6f25df Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 28 May 2021 19:34:13 -0700 Subject: [PATCH 100/207] VASP runs successfully --- atomate/vasp/analysis/lattice_dynamics.py | 60 +++++++++++++++++++--- atomate/vasp/drones.py | 1 + atomate/vasp/firetasks/lattice_dynamics.py | 46 +++++++++-------- atomate/vasp/firetasks/parse_outputs.py | 8 ++- atomate/vasp/fireworks/lattice_dynamics.py | 28 ++++------ 5 files changed, 97 insertions(+), 46 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 28cc37a87..7c969c8ac 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -107,7 +107,7 @@ def fit_force_constants( structures: List["Atoms"], all_cutoffs: List[List[float]], imaginary_tol: float = IMAGINARY_TOL, - max_n_imaginary: int = MAX_N_IMAGINARY, +# max_n_imaginary: int = MAX_N_IMAGINARY, max_imaginary_freq: float = MAX_IMAGINARY_FREQ, fit_method: str = FIT_METHOD, ) -> Tuple["SortedForceConstants", Dict]: @@ -194,7 +194,7 @@ def fit_force_constants( for result in cutoff_results: if result is None: - pass + continue fitting_data["cutoffs"].append(result["cutoffs"]) fitting_data["rmse_test"].append(result["rmse_test"]) @@ -206,17 +206,17 @@ def fit_force_constants( fitting_data["heat_capcity"].append(result["heat_capacity"]) if ( - result["min_frequency"] > -np.abs(max_imaginary_freq) + result["rmse_test"] < best_fit["rmse_test"] +# and result["min_frequency"] > -np.abs(max_imaginary_freq) # and result["n_imaginary"] <= max_n_imaginary # and result["n_imaginary"] < best_fit["n_imaginary"] - and result["rmse_test"] < best_fit["rmse_test"] ): best_fit.update(result) fitting_data["best"] = result["cutoffs"] logger.info("Finished fitting force constants.") - return best_fit["force_constants"], fitting_data + return best_fit["force_constants"], best_fit["parameters"], best_fit["cluster_space"], fitting_data def _run_cutoffs( @@ -293,7 +293,9 @@ def _run_cutoffs( "entropy": entropy, "heat_capacity": Cv, "thermal_expansion": cte, - "force_constants": fcp + "cluster_space": sc.cluster_space, + "parameters": parameters, + "force_constants": fcs } except Exception: return None @@ -385,6 +387,52 @@ def evaluate_force_constants( return n_imaginary, min_frequency, free_energy, entropy, Cv, grun, cte, dLfrac +def get_total_grun( + omega: np.ndarray, + grun: np.ndarray, + kweight: np.ndarray, + T: float +) -> np.ndarray: + total = 0 + weight = 0 + nptk = omega.shape[0] + nbands = omega.shape[1] + omega = abs(omega)*1e12*2*np.pi + if T==0: + total = np.zeros((3,3)) + grun_total_diag = np.zeros(3) + else: + for i in range(nptk): + for j in range(nbands): + x = hbar*omega[i,j]/(2.0*kB*T) + dBE = (x/np.sinh(x))**2 + weight += dBE*kweight[i] + total += dBE*kweight[i]*grun[i,j] + total = total/weight + grun_total_diag = np.array([total[0,2],total[1,1],total[2,0]]) + + def percent_diff(a,b): + return abs((a-b)/b) + # This process preserves cell symmetry upon thermal expansion, i.e., it prevents + # symmetry-identical directions from inadvertently expanding by different ratios + # when the Gruneisen routine returns slighlty different ratios for those directions + if percent_diff(grun_total_diag[0],grun_total_diag[1]) < 0.1: + avg = np.mean((grun_total_diag[0],grun_total_diag[1])) + grun_total_diag[0] = avg + grun_total_diag[1] = avg + elif percent_diff(grun_total_diag[0],grun_total_diag[2]) < 0.1: + avg = np.mean((grun_total_diag[0],grun_total_diag[2])) + grun_total_diag[0] = avg + grun_total_diag[2] = avg + elif percent_diff(grun_total_diag[1],grun_total_diag[2]) < 0.1: + avg = np.mean((grun_total_diag[1],grun_total_diag[2])) + grun_total_diag[1] = avg + grun_total_diag[2] = avg + else: + pass + return grun_total_diag + + def gruneisen( phonopy: Phonopy, fcs2: np.ndarray, diff --git a/atomate/vasp/drones.py b/atomate/vasp/drones.py index 0c5714fa1..ada98aedf 100644 --- a/atomate/vasp/drones.py +++ b/atomate/vasp/drones.py @@ -575,6 +575,7 @@ def process_vasprun(self, dir_name, taskname, filename): # perform Bader analysis using Henkelman bader if self.parse_bader and "chgcar" in d["output_file_paths"]: + print(self.parse_bader) suffix = "" if taskname == "standard" else f".{taskname}" bader = bader_analysis_from_path(dir_name, suffix=suffix) d["bader"] = bader diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index dad1a4fa4..e91691617 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -144,9 +144,8 @@ class RunHiPhive(FiretaskBase): @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): - from hiphive.utilities import get_displacements - max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) +# max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) fit_method = self.get("fit_method", FIT_METHOD) @@ -169,36 +168,42 @@ def run_task(self, fw_spec): structures.append(atoms) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) - force_constants, fitting_data = fit_force_constants( + fcs, param, cs, fitting_data = fit_force_constants( parent_structure, supercell_matrix, structures, cutoffs, imaginary_tol, - max_n_imaginary, +# max_n_imaginary, max_imaginary_freq, fit_method, ) dumpfn(fitting_data, "fitting_data.json") - if force_constants is None: - # fitting failed - raise RuntimeError( - "Could not find a force constant solution with less than {} " - "imaginary modes.\n" - "Fitting results: {}".format(max_n_imaginary, fitting_data) - ) +# if force_constants is None: +# # fitting failed +# raise RuntimeError( +# "Could not find a force constant solution with less than {} " +# "imaginary modes.\n" +# "Fitting results: {}".format(max_n_imaginary, fitting_data) +# ) - else: - logger.info("Writing force constants.") - force_constants.write("force_constants.fcs") + logger.info("Writing cluster space and force_constants") + fcs.write("force_constants.fcs") + np.savetxt('parameters',parameters) + cs.write('cluster_space.cs') + if fitting_data["n_imaginary"] == 0: atoms = AseAtomsAdaptor.get_atoms(parent_structure) - force_constants.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms) - force_constants.write_to_phonopy( - "FORCE_CONSTANTS_2ND", format="text" - ) + fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms) + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND", format="text") + elif fitting_data["n_imaginary"] > 0 and renormalization: + logger.info("Imaginary modes exist!") + logger.info("Performing phonon renormalization at temperatures {}".format(T_renorm)) + renorm = Renormalization(cs,fcs,param,T) + else: + logger.info("Imaginary modes exist! ShengBTE files not written. Not performing renormalization.") @@ -215,8 +220,6 @@ class RunHiPhiveRenorm(FiretaskBase): cs (hiphive.ClusterSpace): A list of cutoffs to trial. If None, a set of trial cutoffs will be generated based on the structure (default). - supercell (ase.Atoms): Tolerance used to decide if a phonon mode - is imaginary, in THz. fcs (hiphive.ForceConstants): Maximum number of imaginary modes allowed in the the final fitted force constant solution. If this criteria is not reached by any cutoff combination this FireTask will fizzle. @@ -225,12 +228,11 @@ class RunHiPhiveRenorm(FiretaskBase): T_renorm (List): list of temperatures to perform renormalization - default is T_RENORM """ - required_params = ["cs","supercell","fcs","param"] + required_params = ["cs","fcs","param"] optional_params = ["T_renorm"] @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): - from hiphive.utilities import get_displacements max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 25fd107a6..1efb2b28c 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -67,6 +67,7 @@ from atomate.vasp.config import DEFUSE_UNSUCCESSFUL, STORE_VOLUMETRIC_DATA from atomate.vasp.database import VaspCalcDb <<<<<<< HEAD +<<<<<<< HEAD from atomate.vasp.drones import BADER_EXE_EXISTS, VaspDrone ======= from atomate.vasp.drones import VaspDrone @@ -75,12 +76,17 @@ >>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) ======= >>>>>>> fd3cc888 (Added fw_spec updates to all dynamically added fireworks and wrote a ShengBTE firetask) +======= +from atomate.vasp.drones import VaspDrone, BADER_EXE_EXISTS +from atomate.vasp.config import STORE_VOLUMETRIC_DATA, STORE_BADER +>>>>>>> 13ec960c (VASP runs successfully) __author__ = "Anubhav Jain, Kiran Mathew, Shyam Dwaraknath" __email__ = "ajain@lbl.gov, kmathew@lbl.gov, shyamd@lbl.gov" logger = get_logger(__name__) +STORE_BADER = STORE_BADER and BADER_EXE_EXISTS @explicit_serialize class VaspToDb(FiretaskBase): @@ -166,7 +172,7 @@ def run_task(self, fw_spec): parse_dos=self.get("parse_dos", False), parse_potcar_file=self.get("parse_potcar_file", True), bandstructure_mode=self.get("bandstructure_mode", False), - parse_bader=self.get("parse_bader", BADER_EXE_EXISTS), + parse_bader=STORE_BADER, #self.get("parse_bader", BADER_EXE_EXISTS), parse_chgcar=self.get("parse_chgcar", False), # deprecated parse_aeccar=self.get("parse_aeccar", False), # deprecated store_volumetric_data=self.get( diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 6e7d4e621..637370abf 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -10,6 +10,8 @@ IMAGINARY_TOL, MAX_IMAGINARY_FREQ, MAX_N_IMAGINARY, + T_QHA, + T_RENORM ) from atomate.vasp.config import SHENGBTE_CMD from atomate.vasp.firetasks.lattice_dynamics import ( @@ -22,8 +24,8 @@ MESH_DENSITY) from fireworks import Firework -__author__ = "Alex Ganose" -__email__ = "aganose@lbl.gov" +__author__ = "Alex Ganose, Junsoo Park" +__email__ = "aganose@lbl.gov, jsyony37@lbl.gov" class FitForceConstantsFW(Firework): @@ -148,8 +150,6 @@ class RenormalizationFW(Firework): information. Will override ``parents`` when collecting the force constants to run ShengBTE. db_file: Path to a db file. - shengbte_cmd: The name of the shengbte executable to run. Supports - env_chk. temperature: The temperature to perform phonon renormalization at Can be given as a single float, or a dictionary with the keys "min", "max", "step". @@ -163,28 +163,22 @@ def __init__( name="Renormalization", prev_calc_dir: Optional[str] = None, db_file: str = None, - shengbte_cmd: str = SHENGBTE_CMD, temperature: Union[float, dict] = DEFAULT_TEMPERATURE, shengbte_control_kwargs: Optional[dict] = None, **kwargs ): - # files needed to run ShengBTE - files = [ - "structure_data.json", - "FORCE_CONSTANTS_2ND", - "FORCE_CONSTANTS_3RD", - ] + # files needed to run renormalization + files = ["cluster_space.cs","parameters","force_constants.fcs"] if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) else: copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) - fit_constants = RunHiPhiveRenorm( - cutoffs=cutoffs, - imaginary_tol=imaginary_tol, - max_n_imaginary=max_n_imaginary, - max_imaginary_freq=max_imaginary_freq, - fit_method=fit_method, + fit_renorm_constants = RunHiPhiveRenorm( + cs=cluster_space.cs, + param=parameters, + fcs=force_constants.fcs, + T_renorm=T_renorm, ) From 045a35f4ca2c1864c4d54c021414fbb0a2ea8e41 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 28 May 2021 19:40:26 -0700 Subject: [PATCH 101/207] no DEFAULT TEMPERATURE --- atomate/vasp/analysis/lattice_dynamics.py | 4 ++- atomate/vasp/firetasks/lattice_dynamics.py | 1 + atomate/vasp/fireworks/lattice_dynamics.py | 32 +++++++++++----------- 3 files changed, 20 insertions(+), 17 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 7c969c8ac..1bf5b141d 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -35,8 +35,10 @@ MAX_IMAGINARY_FREQ = 10 # in THz IMAGINARY_TOL = 0.025 # in THz MAX_N_IMAGINARY = np.inf + T_QHA = [i*100 for i in range(16)] -T_RENORM = [i*100 for i in range(0,16,3)] +T_RENORM = [i*100 for i in range(0,16)] +T_KLAT = [i*100 for i in range(0,16)] FIT_METHOD = "least-squares" eV2J = 1.602e-19 diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index e91691617..68b08dd70 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -18,6 +18,7 @@ MAX_N_IMAGINARY, T_QHA, T_RENORM, + T_KLAT, fit_force_constants, get_cutoffs, ) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 637370abf..f38766c61 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -11,11 +11,11 @@ MAX_IMAGINARY_FREQ, MAX_N_IMAGINARY, T_QHA, - T_RENORM + T_RENORM, + T_KLAT ) from atomate.vasp.config import SHENGBTE_CMD from atomate.vasp.firetasks.lattice_dynamics import ( - DEFAULT_TEMPERATURE, CollectPerturbedStructures, ForceConstantsToDb, RunHiPhive, @@ -168,17 +168,17 @@ def __init__( **kwargs ): - # files needed to run renormalization - files = ["cluster_space.cs","parameters","force_constants.fcs"] - - if prev_calc_dir: - copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) - else: - copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) - - fit_renorm_constants = RunHiPhiveRenorm( - cs=cluster_space.cs, - param=parameters, - fcs=force_constants.fcs, - T_renorm=T_renorm, - ) + # files needed to run renormalization + files = ["cluster_space.cs","parameters","force_constants.fcs"] + + if prev_calc_dir: + copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) + else: + copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + + fit_renorm_constants = RunHiPhiveRenorm( + cs=cluster_space.cs, + param=parameters, + fcs=force_constants.fcs, + T_renorm=T_renorm, + ) From 5fe792baca08be629cbf0ad69eaf64e472067f8e Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 28 May 2021 19:41:58 -0700 Subject: [PATCH 102/207] T_KLAT --- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index f38766c61..59ea68da4 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -111,7 +111,7 @@ def __init__( prev_calc_dir: Optional[str] = None, db_file: str = None, shengbte_cmd: str = SHENGBTE_CMD, - temperature: Union[float, dict] = DEFAULT_TEMPERATURE, + temperature: Union[float, dict] = T_KLAT, shengbte_control_kwargs: Optional[dict] = None, **kwargs ): From 832a947d8342ea1161c71bd2a6b55a8779a73113 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 28 May 2021 19:42:59 -0700 Subject: [PATCH 103/207] T_RENORM --- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 59ea68da4..d2edb4f40 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -163,7 +163,7 @@ def __init__( name="Renormalization", prev_calc_dir: Optional[str] = None, db_file: str = None, - temperature: Union[float, dict] = DEFAULT_TEMPERATURE, + temperature: Union[float, dict] = T_RENORM, shengbte_control_kwargs: Optional[dict] = None, **kwargs ): From 85eef6c837d86bfb011dbe073994ff04ea24c8bc Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 28 May 2021 20:17:54 -0700 Subject: [PATCH 104/207] import renormalization --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- atomate/vasp/firetasks/lattice_dynamics.py | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 1bf5b141d..606fbe3fa 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -40,7 +40,7 @@ T_RENORM = [i*100 for i in range(0,16)] T_KLAT = [i*100 for i in range(0,16)] -FIT_METHOD = "least-squares" +FIT_METHOD = "rfe" #"least-squares" eV2J = 1.602e-19 def get_cutoffs(structure: Structure): diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 68b08dd70..d120e1e01 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -39,7 +39,7 @@ try: import hiphive from hiphive.utilities import get_displacements - from hiphive import Renormalization + from hiphive.renormalization import Renormalization except ImportError: hiphive = False From 6359a632a3a2114b70346f3d5f66adb1bb327d19 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 28 May 2021 20:49:19 -0700 Subject: [PATCH 105/207] parameters to best_fit --- atomate/vasp/analysis/lattice_dynamics.py | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 606fbe3fa..0567d1864 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -169,7 +169,7 @@ def fit_force_constants( "heat_capacity": [], "fit_method": fit_method, "imaginary_tol": imaginary_tol, - "max_n_imaginary": max_n_imaginary, +# "max_n_imaginary": max_n_imaginary, "max_imaginary_freq": max_imaginary_freq, } @@ -179,6 +179,7 @@ def fit_force_constants( "n_imaginary": np.inf, "free_energy": np.inf, "force_constants": None, + "parameters":None, "cutoffs": None, } n_cutoffs = len(all_cutoffs) From 9a7928ce999be1a488135337a405bd9bb445cd67 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 28 May 2021 20:55:52 -0700 Subject: [PATCH 106/207] cluster_space to best_fit --- atomate/vasp/analysis/lattice_dynamics.py | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 0567d1864..cd319959b 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -177,7 +177,12 @@ def fit_force_constants( best_fit = { "n_imaginary": np.inf, +<<<<<<< HEAD "free_energy": np.inf, +======= + "rmse_test": np.inf, + "cluster_space": None, +>>>>>>> cd00c732 (cluster_space to best_fit) "force_constants": None, "parameters":None, "cutoffs": None, From 1ba2a949af6de18e5b37d84cef3e8121e580a534 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sat, 29 May 2021 12:15:15 -0700 Subject: [PATCH 107/207] get_cutoffs --- atomate/vasp/analysis/lattice_dynamics.py | 35 +++++++++++++++---- atomate/vasp/firetasks/lattice_dynamics.py | 29 ++++++++------- atomate/vasp/fireworks/lattice_dynamics.py | 1 + .../vasp/workflows/base/lattice_dynamics.py | 2 ++ 4 files changed, 48 insertions(+), 19 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index cd319959b..d45fa8769 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -112,7 +112,13 @@ def fit_force_constants( # max_n_imaginary: int = MAX_N_IMAGINARY, max_imaginary_freq: float = MAX_IMAGINARY_FREQ, fit_method: str = FIT_METHOD, +<<<<<<< HEAD ) -> Tuple["SortedForceConstants", Dict]: +======= + n_jobs: int = -1, + fit_kwargs: Optional[Dict] = None +) -> Tuple["SortedForceConstants", np.ndarray, ClusterSpace, Dict]: +>>>>>>> fddd9681 (get_cutoffs) """ Fit force constants using hiphive and select the optimum cutoff values. @@ -146,8 +152,8 @@ def fit_force_constants( Returns: A tuple of the best fitted force constants as a hiphive - ``SortedForceConstants`` object and a dictionary of information on the - fitting process. + ``SortedForceConstants`` object, array of parameters, cluster space, + and a dictionary of information on the fitting results. """ <<<<<<< HEAD from hiphive.fitting import Optimizer @@ -192,14 +198,17 @@ def fit_force_constants( for i, cutoffs in enumerate(all_cutoffs): ======= - fit_kwargs = fit_kwargs if fit_kwargs else {} - if fit_method == "rfe" and n_jobs == -1: - fit_kwargs["n_jobs"] = 1 +# fit_kwargs = fit_kwargs if fit_kwargs else {} +# if fit_method == "rfe" and n_jobs == -1: +# fit_kwargs["n_jobs"] = 1 + logger.info('cutoff_results') cutoff_results = Parallel(n_jobs=-1, backend="multiprocessing")(delayed(_run_cutoffs)( i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, fit_method, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) + logger.info(cutoff_results) + for result in cutoff_results: if result is None: continue @@ -250,19 +259,28 @@ def _run_cutoffs( "Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs) ) sc = get_structure_container(cutoffs, structures) +<<<<<<< HEAD opt = Optimizer(sc.get_fit_data(), fit_method) +======= + logger.info('{}, {}: FINE UNTIL SC'.format(i,cutoffs)) + opt = Optimizer(sc.get_fit_data(), fit_method, **fit_kwargs) + logger.info('{}, {}: FINE UNTIL OPT'.format(i,cutoffs)) +>>>>>>> fddd9681 (get_cutoffs) opt.train() + logger.info('{}, {}: FINE UNTIL TRAIN'.format(i,cutoffs)) parameters = enforce_rotational_sum_rules( sc.cluster_space, opt.parameters, ["Huang", "Born-Huang"] ) + logger.info('{}, {}: FINE UNTIL SUM RULE'.format(i,cutoffs)) fcp = ForceConstantPotential(sc.cluster_space, parameters) + logger.info('{}, {}: FINE UNTIL FCP'.format(i,cutoffs)) fcs = fcp.get_force_constants(supercell_atoms) - -# phonopy_fcs = fcs.get_fc_array(order=2) + logger.info('{}, {}: FINE UNTIL FCS'.format(i,cutoffs)) n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( parent_structure, supercell_matrix, fcs, T_QHA, imaginary_tol ) +<<<<<<< HEAD <<<<<<< HEAD fitting_data["cutoffs"].append(cutoffs) @@ -291,6 +309,9 @@ def _run_cutoffs( return best_fit["force_constants"], fitting_data ======= +======= + logger.info('evaluate_force_constants success!') +>>>>>>> fddd9681 (get_cutoffs) return { "cutoffs": cutoffs, "rmse_test": opt.rmse_test, diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index d120e1e01..67547ee69 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -20,7 +20,7 @@ T_RENORM, T_KLAT, fit_force_constants, - get_cutoffs, + get_cutoffs ) from atomate.vasp.database import VaspCalcDb from atomate.vasp.drones import VaspDrone @@ -157,6 +157,7 @@ def run_task(self, fw_spec): parent_structure = structure_data["structure"] supercell_matrix = structure_data["supercell_matrix"] supercell_structure = structure_data["supercell_structure"] + cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) structures = [] supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) @@ -168,7 +169,13 @@ def run_task(self, fw_spec): atoms.positions = supercell_atoms.get_positions() structures.append(atoms) - cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) + logger.info(parent_structure) + logger.info(supercell_structure) + logger.info(fit_method) + from_get_cutoffs = get_cutoffs(supercell_structure) + logger.info('SELF.GET_CUTOFFS \n {}'.format(self.get("cutoffs"))) + logger.info('FROM GET_CUTOFFS \n {}'.format(from_get_cutoffs)) + logger.info('FINAL INPUT CUTOFFS \n {}'.format(cutoffs)) fcs, param, cs, fitting_data = fit_force_constants( parent_structure, supercell_matrix, @@ -177,7 +184,7 @@ def run_task(self, fw_spec): imaginary_tol, # max_n_imaginary, max_imaginary_freq, - fit_method, + fit_method ) dumpfn(fitting_data, "fitting_data.json") @@ -191,20 +198,18 @@ def run_task(self, fw_spec): # ) logger.info("Writing cluster space and force_constants") + logger.info("{}".format(type(fcs))) fcs.write("force_constants.fcs") - np.savetxt('parameters',parameters) + np.savetxt('parameters.txt',parameters) cs.write('cluster_space.cs') if fitting_data["n_imaginary"] == 0: + logger.info("No imaginary modes! Writing ShengBTE files") atoms = AseAtomsAdaptor.get_atoms(parent_structure) fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms) fcs.write_to_phonopy("FORCE_CONSTANTS_2ND", format="text") - elif fitting_data["n_imaginary"] > 0 and renormalization: - logger.info("Imaginary modes exist!") - logger.info("Performing phonon renormalization at temperatures {}".format(T_renorm)) - renorm = Renormalization(cs,fcs,param,T) - else: - logger.info("Imaginary modes exist! ShengBTE files not written. Not performing renormalization.") + elif fitting_data["n_imaginary"] > 0: + logger.info("Imaginary modes exist! ShengBTE files not written. You may want to perform phonon renormalization.") @@ -238,7 +243,7 @@ def run_task(self, fw_spec): max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) - fit_method = self.get("T_renorm", T_RENORM) + T_renorm = self.get("T_renorm", T_RENORM) all_structures = loadfn("perturbed_structures.json") all_forces = loadfn("perturbed_forces.json") @@ -264,7 +269,7 @@ def run_task(self, fw_spec): structures, cutoffs, imaginary_tol, - max_n_imaginary, +# max_n_imaginary, max_imaginary_freq, fit_method, ) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index d2edb4f40..9a42dfc1f 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -69,6 +69,7 @@ def __init__( **kwargs ): collect_structures = CollectPerturbedStructures() + logger.info("INPUT CUTOFF \n {}".format(cutoffs)) fit_constants = RunHiPhive( cutoffs=cutoffs, imaginary_tol=imaginary_tol, diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index e7c7d842f..5d76a979b 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -156,6 +156,8 @@ def get_lattice_dynamics_wf( ) wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) + # RenormalizeFW(pass_inputs like bulk modulus) + # 3. Lattice thermal conductivity calculation (optional) if calculate_lattice_thermal_conductivity: fw_lattice_conductivity = LatticeThermalConductivityFW( From 505479f3c7bd6a9b3076eecfe55d120d408c6b50 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 30 May 2021 20:42:10 -0700 Subject: [PATCH 108/207] cutoff vs cell_size --- atomate/vasp/analysis/lattice_dynamics.py | 12 +++++++- atomate/vasp/firetasks/lattice_dynamics.py | 7 +++-- atomate/vasp/fireworks/lattice_dynamics.py | 29 +++++++++++++------ .../vasp/workflows/base/lattice_dynamics.py | 2 +- 4 files changed, 36 insertions(+), 14 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index d45fa8769..21536d189 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -34,7 +34,7 @@ MAX_IMAGINARY_FREQ = 10 # in THz IMAGINARY_TOL = 0.025 # in THz -MAX_N_IMAGINARY = np.inf +#MAX_N_IMAGINARY = np.inf T_QHA = [i*100 for i in range(16)] T_RENORM = [i*100 for i in range(0,16)] @@ -100,7 +100,17 @@ def get_cutoffs(structure: Structure): range_three = np.arange(mins[3], mins[3] + inc[3] + steps[3], steps[3]) range_four = np.arange(mins[4], mins[4] + inc[4] + steps[4], steps[4]) +<<<<<<< HEAD return list(map(list, product(range_two, range_three, range_four))) +======= + cutoffs = np.array(list(map(list, product(range_two, range_three, range_four)))) + logger.info('CUTOFFS \n {}'.format(cutoffs)) + max_cutoff = estimate_maximum_cutoff(AseAtomsAdaptor.get_atoms(supercell_structure)) + logger.info('MAX_CUTOFF \n {}'.format(max_cutoff)) + good_cutoffs = np.all(cutoffs < np.around(max_cutoff, 4) - 0.0001, axis=1) + logger.info('GOOD CUTOFFS \n {}'.format(good_cutoffs)) + return cutoffs[good_cutoffs].tolist() +>>>>>>> c094a175 (cutoff vs cell_size) def fit_force_constants( diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 67547ee69..ddde2a512 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -15,7 +15,7 @@ FIT_METHOD, IMAGINARY_TOL, MAX_IMAGINARY_FREQ, - MAX_N_IMAGINARY, +# MAX_N_IMAGINARY, T_QHA, T_RENORM, T_KLAT, @@ -41,6 +41,7 @@ from hiphive.utilities import get_displacements from hiphive.renormalization import Renormalization except ImportError: + logger.info('Could not import hiphive!') hiphive = False @@ -169,8 +170,8 @@ def run_task(self, fw_spec): atoms.positions = supercell_atoms.get_positions() structures.append(atoms) - logger.info(parent_structure) - logger.info(supercell_structure) + logger.info('PARENT \n {}'.format(parent_structure)) + logger.info('SUPERCELL \n {}'.format(supercell_structure)) logger.info(fit_method) from_get_cutoffs = get_cutoffs(supercell_structure) logger.info('SELF.GET_CUTOFFS \n {}'.format(self.get("cutoffs"))) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 9a42dfc1f..4defbdfac 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -75,7 +75,7 @@ def __init__( imaginary_tol=imaginary_tol, max_n_imaginary=max_n_imaginary, max_imaginary_freq=max_imaginary_freq, - fit_method=fit_method, + fit_method=fit_method ) to_db = ForceConstantsToDb( db_file=db_file, mesh_density=mesh_density, additional_fields={} @@ -170,16 +170,27 @@ def __init__( ): # files needed to run renormalization - files = ["cluster_space.cs","parameters","force_constants.fcs"] + files = ["cluster_space.cs","parameters.txt","force_constants.fcs"] if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) else: copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) - - fit_renorm_constants = RunHiPhiveRenorm( - cs=cluster_space.cs, - param=parameters, - fcs=force_constants.fcs, - T_renorm=T_renorm, - ) + + cs = ClusterSpace.read('cluster_space.cs') + fcs = ForceConstants.read('force_constants.fcs') + param = np.loadtxt('parameters.txt') + renorm_force_constants = RunHiPhiveRenorm( + cs=cluster_space.cs, + param=parameters, + fcs=force_constants.fcs, + T_renorm=T_renorm + ) + + to_db = ForceConstantsToDb( + db_file=db_file, mesh_density=mesh_density, additional_fields={} + ) + pass_locs = PassCalcLocs(name=name) + + tasks = [collect_structures, renorm_force_constants, to_db, pass_locs] + super().__init__(tasks, name=name, **kwargs) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 5d76a979b..e26199890 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -228,7 +228,7 @@ def get_perturbed_structure_wf( } if supercell_matrix is None: - supercell_matrix = np.eye(3) + supercell_matrix = np.eye(4) supercell_matrix = np.asarray(supercell_matrix).tolist() natoms = len(structure * supercell_matrix) From 53875933533c84485be670a4fa7dc9a16891efec Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Tue, 1 Jun 2021 21:52:51 -0700 Subject: [PATCH 109/207] bulk_mod input --- atomate/vasp/analysis/lattice_dynamics.py | 100 ++++++++++++------ atomate/vasp/firetasks/lattice_dynamics.py | 7 +- atomate/vasp/fireworks/lattice_dynamics.py | 2 + .../vasp/workflows/base/lattice_dynamics.py | 10 +- 4 files changed, 78 insertions(+), 41 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 21536d189..699d507c3 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -55,13 +55,13 @@ def get_cutoffs(structure: Structure): ------ ----------- Period 2ND 3RD 4TH ====== === === === - 1 5.5 3.0 3.0 - 2 5.5 3.0 3.0 - 3 6.5 4.0 3.5 - 4 7.5 5.0 4.0 - 5 8.5 6.0 4.5 - 6 9.5 7.0 5.0 - 7 9.5 7.0 5.0 + 1 5.0 3.0 2.0 + 2 5.5 3.5 2.5 + 3 6.0 4.0 3.0 + 4 6.5 4.5 3.0 + 5 7.0 5.0 3.5 + 6 8.0 5.5 4.0 + 7 9.0 6.0 4.5 ====== === === === The maximum cutoff for each order is determined by the minimum cutoff and @@ -84,9 +84,9 @@ def get_cutoffs(structure: Structure): """ # indexed as min_cutoffs[order][period] min_cutoffs = { - 2: {1: 5.5, 2: 5.5, 3: 6.5, 4: 7.5, 5: 8.5, 6: 9.5, 7: 9.5}, - 3: {1: 3.0, 2: 3.0, 3: 4.0, 4: 5.0, 5: 6.0, 6: 7.0, 7: 7.0}, - 4: {1: 3.0, 2: 3.0, 3: 3.5, 4: 4.0, 5: 4.5, 6: 5.0, 7: 5.0}, + 2: {1: 5.0, 2: 5.5, 3: 6.0, 4: 6.5, 5: 7.0, 6: 8.0, 7: 9.0}, + 3: {1: 3.0, 2: 3.5, 3: 4.0, 4: 4.5, 5: 5.0, 6: 5.5, 7: 6.0}, + 4: {1: 2.0, 2: 2.5, 3: 3.0, 4: 3.0, 5: 3.5, 6: 4.0, 7: 4.5}, } inc = {2: 3, 3: 1.5, 4: 1} steps = {2: 0.5, 3: 0.25, 4: 0.25} @@ -104,11 +104,9 @@ def get_cutoffs(structure: Structure): return list(map(list, product(range_two, range_three, range_four))) ======= cutoffs = np.array(list(map(list, product(range_two, range_three, range_four)))) - logger.info('CUTOFFS \n {}'.format(cutoffs)) max_cutoff = estimate_maximum_cutoff(AseAtomsAdaptor.get_atoms(supercell_structure)) logger.info('MAX_CUTOFF \n {}'.format(max_cutoff)) good_cutoffs = np.all(cutoffs < np.around(max_cutoff, 4) - 0.0001, axis=1) - logger.info('GOOD CUTOFFS \n {}'.format(good_cutoffs)) return cutoffs[good_cutoffs].tolist() >>>>>>> c094a175 (cutoff vs cell_size) @@ -118,6 +116,7 @@ def fit_force_constants( supercell_matrix: np.ndarray, structures: List["Atoms"], all_cutoffs: List[List[float]], + bulk_modulus: float, imaginary_tol: float = IMAGINARY_TOL, # max_n_imaginary: int = MAX_N_IMAGINARY, max_imaginary_freq: float = MAX_IMAGINARY_FREQ, @@ -208,16 +207,15 @@ def fit_force_constants( for i, cutoffs in enumerate(all_cutoffs): ======= -# fit_kwargs = fit_kwargs if fit_kwargs else {} -# if fit_method == "rfe" and n_jobs == -1: -# fit_kwargs["n_jobs"] = 1 + fit_kwargs = fit_kwargs if fit_kwargs else {} + if fit_method == "rfe" and n_jobs == -1: + fit_kwargs["n_jobs"] = 1 - logger.info('cutoff_results') - cutoff_results = Parallel(n_jobs=-1, backend="multiprocessing")(delayed(_run_cutoffs)( - i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, + cutoff_results = Parallel(n_jobs=5, backend="multiprocessing")(delayed(_run_cutoffs)( + i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, bulk_modulus, fit_method, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) - logger.info(cutoff_results) + logger.info('CUTOFF RESULTS \n {}'.format(cutoff_results)) for result in cutoff_results: if result is None: @@ -253,6 +251,7 @@ def _run_cutoffs( parent_structure, structures, supercell_matrix, + bulk_modulus, fit_method, imaginary_tol, fit_kwargs @@ -268,6 +267,7 @@ def _run_cutoffs( logger.info( "Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs) ) +<<<<<<< HEAD sc = get_structure_container(cutoffs, structures) <<<<<<< HEAD opt = Optimizer(sc.get_fit_data(), fit_method) @@ -276,21 +276,33 @@ def _run_cutoffs( opt = Optimizer(sc.get_fit_data(), fit_method, **fit_kwargs) logger.info('{}, {}: FINE UNTIL OPT'.format(i,cutoffs)) >>>>>>> fddd9681 (get_cutoffs) +======= + return None + + try: + sc, cs = get_structure_container(cutoffs, structures) + ncut = cs.n_dofs + logger.info('SC and CS generated for cutoff: {}, {}'.format(i,cutoffs)) + opt = Optimizer(sc.get_fit_data(), + fit_method, + [0,ncut], + **fit_kwargs) + logger.info('Optimizer set up for cutoff: {}, {}'.format(i,cutoffs)) +>>>>>>> 79348b89 (bulk_mod input) opt.train() - logger.info('{}, {}: FINE UNTIL TRAIN'.format(i,cutoffs)) + logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) parameters = enforce_rotational_sum_rules( sc.cluster_space, opt.parameters, ["Huang", "Born-Huang"] ) - logger.info('{}, {}: FINE UNTIL SUM RULE'.format(i,cutoffs)) fcp = ForceConstantPotential(sc.cluster_space, parameters) - logger.info('{}, {}: FINE UNTIL FCP'.format(i,cutoffs)) fcs = fcp.get_force_constants(supercell_atoms) - logger.info('{}, {}: FINE UNTIL FCS'.format(i,cutoffs)) + logger.info('FCS generated for cutoff {}, {}'.format(i,cutoffs)) n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( - parent_structure, supercell_matrix, fcs, T_QHA, imaginary_tol + parent_structure, supercell_matrix, fcs, bulk_modulus, T_QHA, imaginary_tol ) <<<<<<< HEAD +<<<<<<< HEAD <<<<<<< HEAD fitting_data["cutoffs"].append(cutoffs) @@ -322,6 +334,9 @@ def _run_cutoffs( ======= logger.info('evaluate_force_constants success!') >>>>>>> fddd9681 (get_cutoffs) +======= + logger.info('evaluate_force_constants success: {}, {}'.format(i,cutoffs)) +>>>>>>> 79348b89 (bulk_mod input) return { "cutoffs": cutoffs, "rmse_test": opt.rmse_test, @@ -356,7 +371,7 @@ def get_structure_container( A hiPhive StructureContainer. """ - cs = ClusterSpace(structures[0], cutoffs) + cs = ClusterSpace(structures[0], cutoffs, symprec=1e-3, acoustic_sum_rules=True) logger.debug(cs.__repr__()) sc = StructureContainer(cs) @@ -364,13 +379,14 @@ def get_structure_container( sc.add_structure(structure) logger.debug(sc.__repr__()) - return sc + return sc, cs def evaluate_force_constants( structure: Structure, supercell_matrix: np.ndarray, - force_constants: ForceConstants, + fcs: ForceConstants, + bulk_modulus: float, T: List, imaginary_tol: float = IMAGINARY_TOL ) -> Tuple[int, float, List, List, List]: @@ -390,40 +406,54 @@ def evaluate_force_constants( frequency at Gamma, and the free energy, entropy, and heat capacity """ + logger.info('EVALUATE FC STARTING') fcs2 = fcs.get_fc_array(2) fcs3 = fcs.get_fc_array(3) parent_phonopy = get_phonopy_structure(structure) phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) vol = phonopy.primitive.get_volume() natom = phonopy.primitive.get_number_of_atoms() + mesh = supercell_matrix.diagonal()*5 phonopy.set_force_constants(fcs2) - phonopy.run_mesh(is_gamma_center=True) + logger.info('FCS2 SET') + phonopy.set_mesh(mesh,is_eigenvectors=True,is_mesh_symmetry=False) #run_mesh(is_gamma_center=True) + logger.info('MESH SET') phonopy.run_thermal_properties(temperatures=T) + logger.info('Thermal properties successfully run!') - free_energy = phonopy.get_thermal_properties_dict()["free_energy"] + _, free_energy, entropy, Cv = phonopy.get_thermal_properties() free_energy *= 1000/sp.constants.Avogadro/eV2J/natom # kJ/mol to eV/atom - entropy = phonopy.get_thermal_properties_dict()["entropy"] entropy *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom - Cv = phonopy.get_thermal_properties_dict()["heat_capacity"] Cv *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom + logger.info('Units converted!') freq = phonopy.mesh.frequencies # in THz # find imaginary modes at gamma # phonopy.run_qpoints([0, 0, 0]) # gamma_eigs = phonopy.get_qpoints_dict()["frequencies"] + logger.info('FREQ \n {}:'.format(freq)) n_imaginary = int(np.sum(freq < -np.abs(imaginary_tol))) - min_frequency = np.min(freq) + logger.info('N_IMAGINARY: {}'.format(n_imaginary)) + min_freq = np.min(freq) - if n_imeginary > 0: - grun, cte = gruneisen(phonopy,fcs2,fcs3,mesh,T,Cv,bulk_mod,vol) + if n_imeginary > 0 and bulk_modulus is not None: + logger.info('No imaginary modes! Computing Gruneisen and thermal expansion.') + grun, cte = gruneisen(phonopy,fcs2,fcs3,mesh,T,Cv,bulk_modulus,vol) dLfrac = thermal_expansion(T,cte) + elif n_imeginary > 0 and bulk_modulus is None: # need bulk modulus input + logger.warning('No imaginary modes, but bulk modulus is not supplied!') + logger.warning('Gruneisen and thermal expansion are not calculated.') + grun = np.zeros((len(T),3)) + cte = np.zeros((len(T),3)) + dLfrac = np.zeros((len(T),3)) else: # do not calculate these if imaginary modes exist + logger.warning('Imaginary modes found!') grun = np.zeros((len(T),3)) cte = np.zeros((len(T),3)) dLfrac = np.zeros((len(T),3)) - return n_imaginary, min_frequency, free_energy, entropy, Cv, grun, cte, dLfrac + return n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac def get_total_grun( diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index ddde2a512..87a5c8305 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -156,8 +156,8 @@ def run_task(self, fw_spec): all_forces = loadfn("perturbed_forces.json") structure_data = loadfn("structure_data.json") parent_structure = structure_data["structure"] - supercell_matrix = structure_data["supercell_matrix"] supercell_structure = structure_data["supercell_structure"] + supercell_matrix = np.array(structure_data["supercell_matrix"]) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) structures = [] @@ -172,7 +172,8 @@ def run_task(self, fw_spec): logger.info('PARENT \n {}'.format(parent_structure)) logger.info('SUPERCELL \n {}'.format(supercell_structure)) - logger.info(fit_method) + logger.info('SUPERCELL MATRIX \n {}'.format(supercell_matrix)) + logger.info('FIT_METHOD {}'.format(fit_method)) from_get_cutoffs = get_cutoffs(supercell_structure) logger.info('SELF.GET_CUTOFFS \n {}'.format(self.get("cutoffs"))) logger.info('FROM GET_CUTOFFS \n {}'.format(from_get_cutoffs)) @@ -182,6 +183,7 @@ def run_task(self, fw_spec): supercell_matrix, structures, cutoffs, + bulk_modulus, imaginary_tol, # max_n_imaginary, max_imaginary_freq, @@ -269,6 +271,7 @@ def run_task(self, fw_spec): supercell_matrix, structures, cutoffs, + bulk_modulus, imaginary_tol, # max_n_imaginary, max_imaginary_freq, diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 4defbdfac..59ffc56c0 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -61,6 +61,7 @@ def __init__( parents: Optional[Union[Firework, List[Firework]]] = None, db_file: str = None, cutoffs: Optional[List[List[float]]] = None, + bulk_modulus:float = None, imaginary_tol: float = IMAGINARY_TOL, max_n_imaginary: int = MAX_N_IMAGINARY, max_imaginary_freq: float = MAX_IMAGINARY_FREQ, @@ -72,6 +73,7 @@ def __init__( logger.info("INPUT CUTOFF \n {}".format(cutoffs)) fit_constants = RunHiPhive( cutoffs=cutoffs, + bulk_modulus=bulk_modulus, imaginary_tol=imaginary_tol, max_n_imaginary=max_n_imaginary, max_imaginary_freq=max_imaginary_freq, diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index e26199890..f7308bb71 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -8,7 +8,7 @@ from atomate.utils.utils import get_logger from atomate.vasp.config import DB_FILE, SHENGBTE_CMD, VASP_CMD from atomate.vasp.firetasks import pass_vasp_result -from atomate.vasp.firetasks.lattice_dynamics import DEFAULT_TEMPERATURE +from atomate.vasp.firetasks.lattice_dynamics import T_KLAT from atomate.vasp.fireworks.core import TransmuterFW from atomate.vasp.fireworks.lattice_dynamics import ( FitForceConstantsFW, @@ -54,6 +54,7 @@ def get_lattice_dynamics_wf( structure: Structure, + bulk_modulus: float = None common_settings: Dict = None, vasp_input_set: Optional[VaspInputSet] = None, copy_vasp_outputs: bool = False, @@ -61,7 +62,7 @@ def get_lattice_dynamics_wf( num_supercell_kwargs: Optional[dict] = None, perturbed_structure_kwargs: Optional[dict] = None, calculate_lattice_thermal_conductivity: bool = False, - thermal_conductivity_temperature: Union[float, Dict] = DEFAULT_TEMPERATURE, + thermal_conductivity_temperature: Union[float, Dict] = T_Klat, shengbte_cmd: str = SHENGBTE_CMD, shengbte_fworker: Optional[str] = None, ): @@ -122,11 +123,12 @@ def get_lattice_dynamics_wf( common_settings = _get_common_settings(common_settings) db_file = common_settings["DB_FILE"] + if calculate_lattice_thermal_conductivity: if supercell_matrix_kwargs.get("force_diagonal", False): warnings.warn( "Diagonal transformation required to calculate lattice thermal " - "conductivity using ShengBTE. Forcing diagonal matrix" + "conductivity using ShengBTE. Forcing diagonal matrix." ) supercell_matrix_kwargs["force_diagonal"] = True @@ -152,7 +154,7 @@ def get_lattice_dynamics_wf( # 2. Fit interatomic force constants from pertrubed structures allow_fizzled = {"_allow_fizzled_parents": True} fw_fit_force_constant = FitForceConstantsFW( - db_file=db_file, spec=allow_fizzled + db_file=db_file, spec=allow_fizzled, bulk_modulus=bulk_modulus ) wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) From c4241109309feb114f2f0a21d089b60ef95e8b82 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Jun 2021 08:52:01 -0700 Subject: [PATCH 110/207] separate fitting --- atomate/vasp/analysis/lattice_dynamics.py | 358 ++++++++++++++---- atomate/vasp/firetasks/lattice_dynamics.py | 335 +++++++++------- atomate/vasp/fireworks/lattice_dynamics.py | 30 +- .../vasp/workflows/base/lattice_dynamics.py | 36 +- 4 files changed, 537 insertions(+), 222 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 699d507c3..1419c6fbd 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -3,6 +3,9 @@ import numpy as np import scipy as sp +import os +import psutil +from copy import copy from atomate.utils.utils import get_logger <<<<<<< HEAD @@ -17,12 +20,16 @@ >>>>>>> 1e75a82a (imports) from hiphive.cutoffs import is_cutoff_allowed, estimate_maximum_cutoff from hiphive.fitting import Optimizer +from hiphive.renormalization import Renormalization +from hiphive.utilities import get_displacements from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor >>>>>>> 8f4f7e37 (gruneisen and CTE) from pymatgen.io.phonopy import get_phonopy_structure +from ase.cell import Cell + from phonopy import Phonopy from phono3py.phonon3.gruneisen import Gruneisen @@ -32,16 +39,19 @@ logger = get_logger(__name__) -MAX_IMAGINARY_FREQ = 10 # in THz IMAGINARY_TOL = 0.025 # in THz #MAX_N_IMAGINARY = np.inf +#MAX_IMAGINARY_FREQ = 10 # in THz T_QHA = [i*100 for i in range(16)] T_RENORM = [i*100 for i in range(0,16)] T_KLAT = [i*100 for i in range(0,16)] FIT_METHOD = "rfe" #"least-squares" + eV2J = 1.602e-19 +hbar = sp.constants.hbar +kB = sp.constants.Boltzmann def get_cutoffs(structure: Structure): """ @@ -58,10 +68,10 @@ def get_cutoffs(structure: Structure): 1 5.0 3.0 2.0 2 5.5 3.5 2.5 3 6.0 4.0 3.0 - 4 6.5 4.5 3.0 - 5 7.0 5.0 3.5 - 6 8.0 5.5 4.0 - 7 9.0 6.0 4.5 + 4 7.0 4.5 3.0 + 5 8.0 5.0 3.5 + 6 9.0 5.5 4.0 + 7 10.0 6.0 4.5 ====== === === === The maximum cutoff for each order is determined by the minimum cutoff and @@ -84,21 +94,29 @@ def get_cutoffs(structure: Structure): """ # indexed as min_cutoffs[order][period] min_cutoffs = { - 2: {1: 5.0, 2: 5.5, 3: 6.0, 4: 6.5, 5: 7.0, 6: 8.0, 7: 9.0}, + 2: {1: 5.0, 2: 5.5, 3: 6.0, 4: 7.0, 5: 8.0, 6: 9.0, 7: 10.0}, 3: {1: 3.0, 2: 3.5, 3: 4.0, 4: 4.5, 5: 5.0, 6: 5.5, 7: 6.0}, 4: {1: 2.0, 2: 2.5, 3: 3.0, 4: 3.0, 5: 3.5, 6: 4.0, 7: 4.5}, } +<<<<<<< HEAD inc = {2: 3, 3: 1.5, 4: 1} steps = {2: 0.5, 3: 0.25, 4: 0.25} row = min([s.row for s in structure.species]) +======= + inc = {2: 2, 3: 1, 4: 0.5} + steps = {2: 1, 3: 0.5, 4: 0.5} + + row = min([s.row for s in supercell_structure.species]) + factor = row/4 +>>>>>>> cc7520c5 (separate fitting) mins = { 2: min_cutoffs[2][row], 3: min_cutoffs[3][row], 4: min_cutoffs[4][row] } - range_two = np.arange(mins[2], mins[2] + inc[2] + steps[2], steps[2]) - range_three = np.arange(mins[3], mins[3] + inc[3] + steps[3], steps[3]) - range_four = np.arange(mins[4], mins[4] + inc[4] + steps[4], steps[4]) + range_two = np.arange(mins[2], mins[2] + factor*(inc[2]+steps[2]), factor*steps[2]) + range_three = np.arange(mins[3], mins[3] + factor*(inc[3]+steps[3]), factor*steps[3]) + range_four = np.arange(mins[4], mins[4] + factor*(inc[4]+steps[4]), factor*steps[4]) <<<<<<< HEAD return list(map(list, product(range_two, range_three, range_four))) @@ -116,10 +134,10 @@ def fit_force_constants( supercell_matrix: np.ndarray, structures: List["Atoms"], all_cutoffs: List[List[float]], - bulk_modulus: float, + separate_fit: bool, imaginary_tol: float = IMAGINARY_TOL, # max_n_imaginary: int = MAX_N_IMAGINARY, - max_imaginary_freq: float = MAX_IMAGINARY_FREQ, +# max_imaginary_freq: float = MAX_IMAGINARY_FREQ, fit_method: str = FIT_METHOD, <<<<<<< HEAD ) -> Tuple["SortedForceConstants", Dict]: @@ -176,16 +194,15 @@ def fit_force_constants( fitting_data = { "cutoffs": [], "rmse_test": [], - "n_imaginary": [], - "min_frequency": [], - "temperature": [], - "free_energy": [], - "entropy": [], - "heat_capacity": [], +# "n_imaginary": [], +# "min_frequency": [], +# "temperature": [], +# "free_energy": [], +# "entropy": [], +# "heat_capacity": [], "fit_method": fit_method, "imaginary_tol": imaginary_tol, # "max_n_imaginary": max_n_imaginary, - "max_imaginary_freq": max_imaginary_freq, } supercell_atoms = structures[0] @@ -211,9 +228,10 @@ def fit_force_constants( if fit_method == "rfe" and n_jobs == -1: fit_kwargs["n_jobs"] = 1 - cutoff_results = Parallel(n_jobs=5, backend="multiprocessing")(delayed(_run_cutoffs)( - i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, bulk_modulus, - fit_method, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) + logger.info('CPU COUNT: {}'.format(os.cpu_count())) + cutoff_results = Parallel(n_jobs=12, backend="multiprocessing")(delayed(_run_cutoffs)( + i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, fit_method, + separate_fit, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) logger.info('CUTOFF RESULTS \n {}'.format(cutoff_results)) @@ -223,12 +241,8 @@ def fit_force_constants( fitting_data["cutoffs"].append(result["cutoffs"]) fitting_data["rmse_test"].append(result["rmse_test"]) - fitting_data["n_imaginary"].append(result["n_imaginary"]) - fitting_data["min_frequency"].append(result["min_frequency"]) - fitting_data["temperature"].append(result["temperature"]) - fitting_data["free_energy"].append(result["free_energy"]) - fitting_data["entropy"].append(result["entropy"]) - fitting_data["heat_capcity"].append(result["heat_capacity"]) +# fitting_data["n_imaginary"].append(result["n_imaginary"]) +# fitting_data["min_frequency"].append(result["min_frequency"]) if ( result["rmse_test"] < best_fit["rmse_test"] @@ -251,11 +265,11 @@ def _run_cutoffs( parent_structure, structures, supercell_matrix, - bulk_modulus, fit_method, + separate_fit, imaginary_tol, fit_kwargs -): +) -> Dict: logger.info( "Testing cutoffs {} out of {}: {}".format(i + 1, n_cutoffs, cutoffs) @@ -279,19 +293,36 @@ def _run_cutoffs( ======= return None - try: - sc, cs = get_structure_container(cutoffs, structures) - ncut = cs.n_dofs - logger.info('SC and CS generated for cutoff: {}, {}'.format(i,cutoffs)) + cs = ClusterSpace(supercell_atoms, cutoffs, symprec=1e-3, acoustic_sum_rules=True) + logger.debug(cs.__repr__()) + n2nd = cs.get_n_dofs_by_order(2) + nall = cs.n_dofs + + if separate_fit: + logger.info('Fitting harmonic force constants separately') + sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=None) opt = Optimizer(sc.get_fit_data(), fit_method, - [0,ncut], + [0,2nd], **fit_kwargs) +<<<<<<< HEAD logger.info('Optimizer set up for cutoff: {}, {}'.format(i,cutoffs)) >>>>>>> 79348b89 (bulk_mod input) +======= +>>>>>>> cc7520c5 (separate fitting) opt.train() - logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) + param_harmonic = opt.parameters # harmonic force constant parameters + + logger.info('Fitting anharmonic force constants separately') + sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=param2) + opt = Optimizer(sc.get_fit_data(), + fit_method, + [2nd,nall], + **fit_kwargs) + opt.train() + param_anharmonic = opt.parameters # anharmonic force constant parameters +<<<<<<< HEAD parameters = enforce_rotational_sum_rules( sc.cluster_space, opt.parameters, ["Huang", "Born-Huang"] ) @@ -358,6 +389,58 @@ def _run_cutoffs( def get_structure_container( cutoffs: List[float], structures: List["Atoms"] +======= + parameters = np.concatenate((param_harmonic,param_anharmonic)) # combine + assert(nall==len(parameters)) + logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) + + else: + logger.info('Fitting all force constants in one shot') + sc = get_structure_container(cs, structures, separate_fit, ncut=None, param2=None) + opt = Optimizer(sc.get_fit_data(), + fit_method, + [0,nall], + **fit_kwargs) + opt.train() + parameters = opt.parameters + logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) + + parameters = enforce_rotational_sum_rules( + sc.cluster_space, parameters, ["Huang", "Born-Huang"] + ) + fcp = ForceConstantPotential(cs, parameters) + fcs = fcp.get_force_constants(supercell_atoms) + logger.info('FCS generated for cutoff {}, {}'.format(i,cutoffs)) + +# n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( +# parent_structure, supercell_matrix, fcs, bulk_modulus, T_QHA, imaginary_tol +# ) + + return { + "cutoffs": cutoffs, + "rmse_test": opt.rmse_test, +# "n_imaginary": n_imaginary, +# "min_frequency": min_freq, +# "temperature": T_QHA, +# "free_energy": free_energy, +# "entropy": entropy, +# "heat_capacity": Cv, +# "thermal_expansion": cte, + "cluster_space": sc.cluster_space, + "parameters": parameters, + "force_constants": fcs + } + #except Exception: + # return None + + +def get_structure_container( + cs: ClusterSpace, + structures: List["Atoms"], + separate_fit: bool, + ncut: int, + param2: np.ndarray +>>>>>>> cc7520c5 (separate fitting) ) -> "StructureContainer": """ Get a hiPhive StructureContainer from cutoffs and a list of atoms objects. @@ -371,25 +454,42 @@ def get_structure_container( A hiPhive StructureContainer. """ - cs = ClusterSpace(structures[0], cutoffs, symprec=1e-3, acoustic_sum_rules=True) - logger.debug(cs.__repr__()) - sc = StructureContainer(cs) + saved_strutures = [] for structure in structures: - sc.add_structure(structure) + displacements = get_displacements(atoms, supercell_atoms) + mean_displacements = np.linalg.norm(displacements,axis=1).mean() + if not separate_fit: # fit all + sc.add_structure(structure) + else: # fit separately + if param2 is None: # for harmonic fitting + sc.add_structure(structure) if mean_displacements <= 0.05 + else: # for anharmonic fitting + sc.add_structure(structure) if mean_displacements >= 0.2 + saved_structures.append(structure) if mean_displacements >= 0.2 + if separate_fit and param2 is not None: + A_mat = sc.get_fit_data()[0] # displacement matrix + f_vec = sc.get_fit_data()[1] # force vector + new_force = f_vec - np.dot(A_mat[:,:ncut],param2) # subract harmonic forces + sc.delete_all_structures() + for i, structure in enumerate(saved_structures): + naroms = structure.et_global_number_of_atoms() + ndisp = natoms*3 + structure.set_array('forces',new_force[i*ndisp:(i+1)*ndisp].reshape(natoms,3)) + sc.add_structure(structure) + logger.debug(sc.__repr__()) - return sc, cs + return sc -def evaluate_force_constants( +def harmonic_properties( structure: Structure, supercell_matrix: np.ndarray, fcs: ForceConstants, - bulk_modulus: float, T: List, imaginary_tol: float = IMAGINARY_TOL -) -> Tuple[int, float, List, List, List]: +) -> Tuple[Dict,Phonopy]: """ Uses the force constants to extract phonon properties. Used for comparing the accuracy of force constant fits. @@ -406,19 +506,16 @@ def evaluate_force_constants( frequency at Gamma, and the free energy, entropy, and heat capacity """ - logger.info('EVALUATE FC STARTING') + logger.info('Evaluating harmonic properties.') fcs2 = fcs.get_fc_array(2) fcs3 = fcs.get_fc_array(3) parent_phonopy = get_phonopy_structure(structure) phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) - vol = phonopy.primitive.get_volume() natom = phonopy.primitive.get_number_of_atoms() - mesh = supercell_matrix.diagonal()*5 + mesh = supercell_matrix.diagonal()*4 phonopy.set_force_constants(fcs2) - logger.info('FCS2 SET') phonopy.set_mesh(mesh,is_eigenvectors=True,is_mesh_symmetry=False) #run_mesh(is_gamma_center=True) - logger.info('MESH SET') phonopy.run_thermal_properties(temperatures=T) logger.info('Thermal properties successfully run!') @@ -426,34 +523,60 @@ def evaluate_force_constants( free_energy *= 1000/sp.constants.Avogadro/eV2J/natom # kJ/mol to eV/atom entropy *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom Cv *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom - logger.info('Units converted!') freq = phonopy.mesh.frequencies # in THz # find imaginary modes at gamma # phonopy.run_qpoints([0, 0, 0]) # gamma_eigs = phonopy.get_qpoints_dict()["frequencies"] - logger.info('FREQ \n {}:'.format(freq)) n_imaginary = int(np.sum(freq < -np.abs(imaginary_tol))) - logger.info('N_IMAGINARY: {}'.format(n_imaginary)) min_freq = np.min(freq) - if n_imeginary > 0 and bulk_modulus is not None: - logger.info('No imaginary modes! Computing Gruneisen and thermal expansion.') - grun, cte = gruneisen(phonopy,fcs2,fcs3,mesh,T,Cv,bulk_modulus,vol) - dLfrac = thermal_expansion(T,cte) - elif n_imeginary > 0 and bulk_modulus is None: # need bulk modulus input - logger.warning('No imaginary modes, but bulk modulus is not supplied!') - logger.warning('Gruneisen and thermal expansion are not calculated.') - grun = np.zeros((len(T),3)) - cte = np.zeros((len(T),3)) - dLfrac = np.zeros((len(T),3)) + if n_imaginary == 0: + logger.info('No imaginary modes!') else: # do not calculate these if imaginary modes exist logger.warning('Imaginary modes found!') + + return { + "temperature": T, + "free_energy": free_energy, + "entropy": entropy, + "heat_capacity": Cv, + "n_imaginary": n_imaginary + }, phonopy + + +def anharmonic_properties( + phonopy: Phonopy, + fcs: ForceConstants, + T: List, + Cv: np.ndarray, + n_imaginary: float, + bulk_modulus: float = None +) -> Tuple[Dict, Phonopy]: + + if n_imaginary == 0: + logger.info('Evaluating anharmonic properties') + fcs2 = fcs.get_fc_array(2) + fcs3 = fcs.get_fc_array(3) + grun, cte = gruneisen(phonopy,fcs2,fcs3,T,Cv,bulk_modulus=bulk_modulus) + if type(bulk_modulus) is float or int: + dLfrac = thermal_expansion(T,cte) + else: + logger.warning('Thermal expansion cannot be calculated without bulk modulus input. Set to 0.') + cte = np.zeros((len(T),3)) + dLfrac = np.zeros((len(T),3)) + else: # do not calculate these if imaginary modes exist + logger.warning('Gruneisen and thermal expansion cannot be calculated with imaginary modes. All set to 0.') grun = np.zeros((len(T),3)) cte = np.zeros((len(T),3)) dLfrac = np.zeros((len(T),3)) - - return n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac + + return { + "temperature": T, + "gruneisen": grun, + "thermal_expansion": cte, + "expansion_ratio": dLfrac, + }, phonopy def get_total_grun( @@ -506,16 +629,16 @@ def gruneisen( phonopy: Phonopy, fcs2: np.ndarray, fcs3: np.ndarray, - mesh: List, temperature: List, Cv: np.ndarray, # in eV/K/atom - bulk_mod: float, # in GPa - vol: float # in A^3 + bulk_modulus: float = None # in GPa ) -> Tuple[List,List]: - + gruneisen = Gruneisen(fcs2,fcs3,phonopy.supercell,phonopy.primitive) - gruneisen.set_sampling_mesh(mesh,is_gamma_center=True) + gruneisen.set_sampling_mesh(phonopy.mesh_numbers,is_gamma_center=True) + logger.info('Memory use before Gruneisen: {} %'.format(psutil.virtual_memory().percent)) gruneisen.run() + logger.info('Memory use after Gruneisen: {} %'.format(psutil.virtual_memory().percent)) grun = gruneisen.get_gruneisen_parameters() # (nptk,nmode,3,3) omega = gruneisen._frequencies qp = gruneisen._qpoints @@ -523,14 +646,18 @@ def gruneisen( grun_tot = list() for temp in temperature: grun_tot.append(get_total_grun(omega,grun,kweight,temp)) - grun_tot = np.array(np.nan_to_num(np.array(grun_tot))) - Cv *= eV2J*phonopy.primitive.get_number_of_atoms() # eV/K/atom to J/K - # linear thermal expansion coefficient - cte = grun_tot*(Cv.repeat(3).reshape((len(Cv),3)))/(vol/10**30)/(bulk_mod*10**9)/3 - cte = np.nan_to_num(cte) - logger.info('Frequency : {}'.format(np.sort(omega.flatten()))) - logger.info('Gruneisen : {}'.format(grun_tot)) - logger.info('CTE : {}'.format(cte)) + grun_tot = np.nan_to_num(np.array(grun_tot)) + + # linear thermal expansion coefficient + if bulk_modulus is None: + cte = None + else: + Cv *= eV2J*phonopy.primitive.get_number_of_atoms() # eV/K/atom to J/K + vol = phonopy.primitive.get_volume() + cte = grun_tot*(Cv.repeat(3).reshape((len(Cv),3)))/(vol/10**30)/(bulk_modulus*10**9)/3 + cte = np.nan_to_num(cte) + logger.info('Gruneisen : {}'.format(grun_tot)) + logger.info('CTE : {}'.format(cte)) return grun_tot, cte @@ -562,3 +689,82 @@ def thermal_expansion( except: raise ValueError('Designated T does not exist in the temperature array!') + +def renormalization( + structure: Structure, + supercell_matrix: np.ndarray, + cs: ClusterSpace, + fcs: ForceConstants, + param: np.ndarray, + T: float, + nconfig: int, + conv_tresh: float, + bulk_modulus: float = None, + imaginary_tol: float = IMAGINARY_TOL, + fit_method: str = None +) -> Dict: + """ + Uses the force constants to extract phonon properties. Used for comparing + the accuracy of force constant fits. + + Args: + structure: The parent structure. + supercell_matrix: The supercell transformation matrix. + fcs: ForceConstants from previous fitting or renormalization + imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, + in THz. + + Returns: + A tuple of the number of imaginary modes at Gamma, the minimum phonon + frequency at Gamma, and the free energy, entropy, and heat capacity + """ + renorm = Renormalization(cs,fcs,param,T,fit_method) + fcp, fcs, param = renorm.renormalize(nconfig,'pseudoinverse',conv_tresh) + + renorm_data, phonopy = harmonic_properties( + structure, supercell_matrix, fcs, [T], imaginary_tol + ) + + if renorm_data["n_imaginary"] ==0: + logger.info('Renormalized phonon is completely real at T = {} K!'.format(T)) + anharmonic_data, phonopy = anharmonic_properties( + phonopy, fcs, [T], thermal_data["heat_capacity"], n_imaginary, bulk_modulus=bulk_modulus + ) + else: + anharmonic_data = dict() + anharmonic_data["gruneisen"] = np.array([[0,0,0]]) + anharmonic_data["thermal_expansion"] = np.array([[0,0,0]]) + renorm_data.update(anharmonic_data) + renorm_data["fcp"] = fcp + renorm_data["fcs"] = fcs + renorm_data["param"] = param + + return renorm_data + + + +def setup_TE_renorm(parent_structure,temperatures,dLfracs): + parent_structure_TE = [] + cs_TE = [] + fcs_TE = [] + for t, (T,dLfrac) in enumerate(zip(temperatures,dLfracs)): + new_atoms = AseAtomsAdaptor.get_atoms(parent_structure) + new_cell = Cell(np.transpose([new_atoms.get_cell()[:,i]*(1+dLfrac[0,i]) for i in range(3)])) + new_atoms.set_cell(new_cell,scale_atoms=True) + new_parent_structure = AseAtomsAdaptor.get_structure(new_atoms) + new_supercell_atoms = AseAtomsAdaptor.get_atoms(new_parent_structure*supercell_matrix) + new_cutoffs = [i*(1+np.linalg.norm(dLfrac)) for i in cutoffs] + while True: + new_cs = ClusterSpace(atoms,new_cutoffs,1e-3,acoustic_sum_rules=True) + if cs_TD.n_dofs == cs.n_dofs: + break + elif cs_TD.n_dofs > cs.n_dofs: + new_cutoffs = [i*0.999 for i in new_cutoffs] + elif cs_TD.n_dofs < cs.n_dofs: + new_cutoffs = [i*1.001 for i in new_cutoffs] + cs_TE.append(new_cs) + parent_structure_TE.append(new_parent_structure) + new_fcp = ForceConstantsPotential(new_cs,param_real[t]) + fcs_TE.append(new_fcp.get_force_constants(new_supercell_atoms)) + + return parent_structure_TE, cs_TE, fcs_TE diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 87a5c8305..5a5752cee 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -6,24 +6,29 @@ from pathlib import Path import numpy as np +from joblib import Parallel, delayed + from monty.dev import requires from monty.serialization import dumpfn, loadfn from pymongo import ReturnDocument from atomate.utils.utils import env_chk, get_logger +from atomate.vasp.database import VaspCalcDb +from atomate.vasp.drones import VaspDrone from atomate.vasp.analysis.lattice_dynamics import ( FIT_METHOD, IMAGINARY_TOL, - MAX_IMAGINARY_FREQ, +# MAX_IMAGINARY_FREQ, # MAX_N_IMAGINARY, T_QHA, T_RENORM, T_KLAT, fit_force_constants, + harmonic_properties, + anharmonic_properties, + renormalization, get_cutoffs ) -from atomate.vasp.database import VaspCalcDb -from atomate.vasp.drones import VaspDrone from fireworks import FiretaskBase, FWAction, explicit_serialize @@ -38,8 +43,8 @@ try: import hiphive + from hiphive import ForceConstants from hiphive.utilities import get_displacements - from hiphive.renormalization import Renormalization except ImportError: logger.info('Could not import hiphive!') hiphive = False @@ -124,6 +129,9 @@ class RunHiPhive(FiretaskBase): cutoffs (Optional[list[list]]): A list of cutoffs to trial. If None, a set of trial cutoffs will be generated based on the structure (default). + separate_fit: If True, harmonic and anharmonic force constants are fit + separately and sequentially, harmonic first then anharmonic. If + False, then they are all fit in one go. Default is False. imaginary_tol (float): Tolerance used to decide if a phonon mode is imaginary, in THz. max_n_imaginary (int): Maximum number of imaginary modes allowed in the @@ -138,9 +146,11 @@ class RunHiPhive(FiretaskBase): optional_params = [ "cutoffs", + "separate_fit", + "bulk_modulus", "imaginary_tol", - "max_n_imaginary", - "max_imaginary_freq", +# "max_n_imaginary", +# "max_imaginary_freq", "fit_method", ] @@ -148,10 +158,11 @@ class RunHiPhive(FiretaskBase): def run_task(self, fw_spec): # max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) - max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) +# max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) fit_method = self.get("fit_method", FIT_METHOD) - + separate_fit = self.get('separate_fit', False) + all_structures = loadfn("perturbed_structures.json") all_forces = loadfn("perturbed_forces.json") structure_data = loadfn("structure_data.json") @@ -159,6 +170,7 @@ def run_task(self, fw_spec): supercell_structure = structure_data["supercell_structure"] supercell_matrix = np.array(structure_data["supercell_matrix"]) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) + bulk_modulus = self.get("bulk_modulus") structures = [] supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) @@ -174,23 +186,32 @@ def run_task(self, fw_spec): logger.info('SUPERCELL \n {}'.format(supercell_structure)) logger.info('SUPERCELL MATRIX \n {}'.format(supercell_matrix)) logger.info('FIT_METHOD {}'.format(fit_method)) - from_get_cutoffs = get_cutoffs(supercell_structure) - logger.info('SELF.GET_CUTOFFS \n {}'.format(self.get("cutoffs"))) - logger.info('FROM GET_CUTOFFS \n {}'.format(from_get_cutoffs)) logger.info('FINAL INPUT CUTOFFS \n {}'.format(cutoffs)) + fcs, param, cs, fitting_data = fit_force_constants( parent_structure, supercell_matrix, structures, cutoffs, - bulk_modulus, + separate_fit, imaginary_tol, # max_n_imaginary, - max_imaginary_freq, +# max_imaginary_freq, fit_method ) + thermal_data, phonopy = harmonic_properties( + parent_structure, supercell_matrix, fcs, T_QHA, imaginary_tol + ) + anharmonic_data, phonopy = anharmonic_properties( + phonopy, fcs, T_QHA, thermal_data["heat_capacity"], + thermal_data["n_imaginary"], bulk_modulus=bulk_modulus + ) + + fitting_data["n_imaginary"] = thermal_data.pop("n_imaginary") + thermal_data.update(anharmonic_data) dumpfn(fitting_data, "fitting_data.json") + dumpfn(thermal_data, "thermal_data_qha.json") # if force_constants is None: # # fitting failed @@ -203,15 +224,15 @@ def run_task(self, fw_spec): logger.info("Writing cluster space and force_constants") logger.info("{}".format(type(fcs))) fcs.write("force_constants.fcs") - np.savetxt('parameters.txt',parameters) + np.savetxt('parameters.txt',param) cs.write('cluster_space.cs') if fitting_data["n_imaginary"] == 0: logger.info("No imaginary modes! Writing ShengBTE files") atoms = AseAtomsAdaptor.get_atoms(parent_structure) - fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms) + fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms, order=3) fcs.write_to_phonopy("FORCE_CONSTANTS_2ND", format="text") - elif fitting_data["n_imaginary"] > 0: + elif n_imaginary > 0: logger.info("Imaginary modes exist! ShengBTE files not written. You may want to perform phonon renormalization.") @@ -233,71 +254,94 @@ class RunHiPhiveRenorm(FiretaskBase): the final fitted force constant solution. If this criteria is not reached by any cutoff combination this FireTask will fizzle. param (np.ndarray): array of force constant parameters + cutoffs (np.ndarray): cutoffs used for best fitting + Optional parameter: T_renorm (List): list of temperatures to perform renormalization - default is T_RENORM + bulk_modulus (float): manually input bulk modulus - necessary for thermal expansion + renorm_with_te (bool): if True, """ - required_params = ["cs","fcs","param"] - optional_params = ["T_renorm"] + required_params = ["cs","fcs","param","cutoff"] + optional_params = ["T_renorm","bulk_modulus","renorm_with_te","fit_method"] @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): - max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) - max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) +# max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) +# max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) - T_renorm = self.get("T_renorm", T_RENORM) + fit_method = self.get("fit_method", FIT_METHOD) - all_structures = loadfn("perturbed_structures.json") - all_forces = loadfn("perturbed_forces.json") structure_data = loadfn("structure_data.json") parent_structure = structure_data["structure"] - supercell_matrix = structure_data["supercell_matrix"] supercell_structure = structure_data["supercell_structure"] - - structures = [] supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) - for structure, forces in zip(all_structures, all_forces): - atoms = AseAtomsAdaptor.get_atoms(structure) - displacements = get_displacements(atoms, supercell_atoms) - atoms.new_array("displacements", displacements) - atoms.new_array("forces", forces) - atoms.positions = supercell_atoms.get_positions() - structures.append(atoms) - - cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) - force_constants, fitting_data = fit_force_constants( - parent_structure, - supercell_matrix, - structures, - cutoffs, - bulk_modulus, - imaginary_tol, -# max_n_imaginary, - max_imaginary_freq, - fit_method, - ) + supercell_matrix = np.array(structure_data["supercell_matrix"]) - dumpfn(fitting_data, "fitting_data.json") + cs = self.get("cs") + fcs = self.get("fcs") + param = self.get("param") + bulk_modulus = self.get("bulk_modulus") + T_renorm = self.get("T_renorm", T_RENORM) - if force_constants is None: - # fitting failed - raise RuntimeError( - "Could not find a force constant solution with less than {} " - "imaginary modes.\n" - "Fitting results: {}".format(max_n_imaginary, fitting_data) - ) - + renorm_results = Parallel(n_jobs=2, backend="multiprocessing")(delayed(renormalization)( + parent_structure, supercell_matrix, cs, fcs, param, T, nconfig, conv_thresh, imaginary_tol + ) for t, T in enumerate(T_renorm)) + + T_real = [] + cte_real = [] + fcs_real = [] + param_real = [] + for result in renorm_results: + if result is None: + continue + elif result["n_imaginary"] > 0 or bulk_modulus is None: + fcs = result["fcs"][0] + fcs.write("force_constants_{}K.fcs".format(T)) + np.savetxt('parameters_{}K.txt'.format(T),result["param"][0]) + else: + T_real = T_real + result["temperature"] + cte_real = cte_real + result["thermal_expansion"] + fcs_real = fcs_real + result["fcs"] + param_real = param_real + result["param"] + if len(T_real)==0: + pass + elif len(T_real)==1 and T_real[0]==0: + fcs = result["fcs"][0] + fcs.write("force_constants_{}K.fcs".format(T)) + np.savetxt('parameters_{}K.txt'.format(T),result["param"][0]) else: - logger.info("Writing force constants.") - force_constants.write("force_constants.fcs") - - atoms = AseAtomsAdaptor.get_atoms(parent_structure) - force_constants.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms) - force_constants.write_to_phonopy( - "FORCE_CONSTANTS_2ND", format="text" - ) - + ind = np.argsort(np.array(T_real)) + T_real = list(np.array(T_real)[ind]) + cte_real = list(np.array(cte_real)[ind]) + dLfrac_real = thermal_expansion(T_real,cte_real) + parent_structure_TE, cs_TE, fcs_TE = setup_TE_renorm(parent_structure,T_real,dLfrac_real) + renorm_results = Parallel(n_jobs=2, backend="multiprocessing")(delayed(renormalization)( + parent_structure_TE[t], supercell_matrix, cs_TE[t], fcs_TE[t], param, T, nconfig, conv_thresh, imaginary_tol + ) for t, T in enumerate(T_real)) + + logger.info("Writing renormalized results") + thermal_keys = ["temperature","free_energy","entropy","heat_capacity", + "gruneisen","thermal_expansion","expansion_ratio"] + thermal_data = {key: [] for key in thermal_keys} + for t, result in enumerate(renorm_results): + T = result["temperature"][0] + fcs = result["fcs"][0] + fcs.write("force_constants_{}K.fcs".format(T)) + np.savetxt('parameters_{}K.txt'.format(T),result["param"][0]) + for key in thermal_keys: + thermal_data[key].append(result[key][0]) + if result["n_imaginary"] > 0: + logger.warning('Imaginary modes generated for {} K!'.format(T)) + logger.warning('Renormalization with thermal expansion may have failed') + logger.warning('ShengBTE files not written') + else: + logger.info("No imaginary modes! Writing ShengBTE files") + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(T), format="text") + + thermal_data.pop("n_imaginary") + dumpfn(thermal_data, "thermal_data_renorm.json") @explicit_serialize @@ -314,6 +358,9 @@ class ForceConstantsToDb(FiretaskBase): perturbed structure calculations. Optional parameters: + renormalized (bool): Whether FC resulted from original fitting (False) + or renormalization process (True) determines how data are stored. + Default is False. mesh_density (float): The density of the q-point mesh used to calculate the phonon density of states. See the docstring for the ``mesh`` argument in Phonopy.init_mesh() for more details. @@ -322,17 +369,16 @@ class ForceConstantsToDb(FiretaskBase): """ required_params = ["db_file"] - optional_params = ["mesh_density", "additional_fields"] + optional_params = ["renormalized","mesh_density", "additional_fields"] @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): - from hiphive.force_constants import ForceConstants db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + renormalized = self.get("renormalized", False) + mesh_density = self.get("mesh_density", MESH_DENSITY) - fc = ForceConstants.read("force_constants.fcs") - fitting_data = loadfn("fitting_data.json") structure_data = loadfn("structure_data.json") forces = loadfn("perturbed_forces.json") structures = loadfn("perturbed_structures.json") @@ -341,66 +387,61 @@ def run_task(self, fw_spec): supercell_structure = structure_data["supercell_structure"] supercell_matrix = structure_data["supercell_matrix"] - phonopy_fc = fc.get_fc_array(order=2) - - logger.info("Getting uniform phonon band structure.") - uniform_bs = get_phonon_band_structure_from_fc( - structure, supercell_matrix, phonopy_fc - ) - - logger.info("Getting line mode phonon band structure.") - lm_bs = get_phonon_band_structure_symm_line_from_fc( - structure, supercell_matrix, phonopy_fc - ) - - logger.info("Getting phonon density of states.") - mesh_density = self.get("mesh_density", MESH_DENSITY) - dos = get_phonon_dos_from_fc( - structure, supercell_matrix, phonopy_fc, mesh_density=mesh_density - ) - - logger.info("Inserting phonon objects into database.") - dos_fsid, _ = mmdb.insert_gridfs( - dos.to_json(), collection="phonon_dos_fs" - ) - uniform_bs_fsid, _ = mmdb.insert_gridfs( - uniform_bs.to_json(), collection="phonon_bandstructure_fs" - ) - lm_bs_fsid, _ = mmdb.insert_gridfs( - lm_bs.to_json(), collection="phonon_bandstructure_fs" - ) - - logger.info("Inserting force constants into database.") - fc_json = json.dumps( - {str(k): v.tolist() for k, v in fc.get_fc_dict().items()} - ) - fc_fsid, _ = mmdb.insert_gridfs( - fc_json, collection="phonon_force_constants_fs" - ) - - data = { - "structure": structure.as_dict(), - "supercell_matrix": supercell_matrix, - "supercell_structure": supercell_structure.as_dict(), - "perturbed_structures": [s.as_dict() for s in structures], - "perturbed_forces": [f.tolist() for f in forces], - "fitting_data": fitting_data, - "force_constants_fs_id": fc_fsid, - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, - "phonon_dos_fs_id": dos_fsid, - "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, - "phonon_bandstructure_line_fs_id": lm_bs_fsid, - "created_at": datetime.utcnow(), - } - data.update(self.get("additional_fields", {})) - - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} - data.update(metadata) + if renormalized: # FC from renormalization + thermal_data = loadfn("thermal_data_renorm.json") + temperature = thermal_data["temperature"] + for t, T in enumerate(temperature): + ## err should I collect results for all T and push data at once, + ## or push data for each T individually? + fcs = ForceConstants.read("force_constants_{}K.fcs") + phonopy_fc = fcs.get_fc_array(order=2) + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, phonopy_fc, mesh_density, mmdb + ) + data = { + "thermal_data": thermal_data, + "force_constants_fs_id": fc_fsid, + "tags": fw_spec.get("tags", None), + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + "created_at": datetime.utcnow(), + } + data.update(self.get("additional_fields", {})) + else: # FC directly from fitting + fitting_data = loadfn("fitting_data.json") + thermal_data = loadfn("thermal_data_qha.json") + fcs = ForceConstants.read("force_constants.fcs") + + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, fcs, mesh_density, mmdb + ) - mmdb.db.lattice_dynamics.insert_one(data) + data = { + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix, + "supercell_structure": supercell_structure.as_dict(), + "perturbed_structures": [s.as_dict() for s in structures], + "perturbed_forces": [f.tolist() for f in forces], + "fitting_data": fitting_data, + "thermal_data": thermal_data, + "force_constants_fs_id": fc_fsid, + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + "created_at": datetime.utcnow(), + } + data.update(self.get("additional_fields", {})) + + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + data.update(metadata) + mmdb.db.lattice_dynamics.insert_many(data) # WHAT TO DO HERE? +# mmdb.db.lattice_dynamics.insert_one(data) + logger.info("Finished inserting force constants") return FWAction(update_spec=metadata) @@ -549,3 +590,43 @@ def _get_fc_fitting_id(mmdb: VaspCalcDb) -> int: fc_id = fc_id["c"] return fc_id + + +def _get_fc_fsid(structure, supercell_matrix, fcs, mesh_density, mmdb): + phonopy_fc = fcs.get_fc_array(order=2) + + logger.info("Getting uniform phonon band structure.") + uniform_bs = get_phonon_band_structure_from_fc( + structure, supercell_matrix, phonopy_fc + ) + + logger.info("Getting line mode phonon band structure.") + lm_bs = get_phonon_band_structure_symm_line_from_fc( + structure, supercell_matrix, phonopy_fc + ) + + logger.info("Getting phonon density of states.") + dos = get_phonon_dos_from_fc( + structure, supercell_matrix, phonopy_fc, mesh_density=mesh_density + ) + + logger.info("Inserting phonon objects into database.") + dos_fsid, _ = mmdb.insert_gridfs( + dos.to_json(), collection="phonon_dos_fs" + ) + uniform_bs_fsid, _ = mmdb.insert_gridfs( + uniform_bs.to_json(), collection="phonon_bandstructure_fs" + ) + lm_bs_fsid, _ = mmdb.insert_gridfs( + lm_bs.to_json(), collection="phonon_bandstructure_fs" + ) + + logger.info("Inserting force constants into database.") + fc_json = json.dumps( + {str(k): v.tolist() for k, v in fcs.get_fc_dict().items()} + ) + fc_fsid, _ = mmdb.insert_gridfs( + fc_json, collection="phonon_force_constants_fs" + ) + + return dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 59ffc56c0..34b2057e3 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -19,6 +19,7 @@ CollectPerturbedStructures, ForceConstantsToDb, RunHiPhive, + RunHiPhiveRenorm, RunShengBTE, ShengBTEToDb, MESH_DENSITY) @@ -39,6 +40,10 @@ class FitForceConstantsFW(Firework): db_file: Path to a db file. cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs will be generated based on the structure (default). + separate_fit: If True, harmonic and anharmonic force constants are fit + separately and sequentially, harmonic first then anharmonic. If + False, then they are all fit in one go. Default is False. + bulk_modulus: Must be supplied (in GPa) to copute thermal expansion imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, in THz. max_n_imaginary: Maximum number of imaginary modes allowed in the @@ -61,6 +66,7 @@ def __init__( parents: Optional[Union[Firework, List[Firework]]] = None, db_file: str = None, cutoffs: Optional[List[List[float]]] = None, + separate_fit: bool = False, bulk_modulus:float = None, imaginary_tol: float = IMAGINARY_TOL, max_n_imaginary: int = MAX_N_IMAGINARY, @@ -71,20 +77,22 @@ def __init__( ): collect_structures = CollectPerturbedStructures() logger.info("INPUT CUTOFF \n {}".format(cutoffs)) - fit_constants = RunHiPhive( + + fit_force_constants = RunHiPhive( cutoffs=cutoffs, + separate_fit=separate_fit bulk_modulus=bulk_modulus, imaginary_tol=imaginary_tol, - max_n_imaginary=max_n_imaginary, - max_imaginary_freq=max_imaginary_freq, +# max_n_imaginary=max_n_imaginary, +# max_imaginary_freq=max_imaginary_freq, fit_method=fit_method ) to_db = ForceConstantsToDb( - db_file=db_file, mesh_density=mesh_density, additional_fields={} + db_file=db_file, renormalized=False, mesh_density=mesh_density, additional_fields={} ) pass_locs = PassCalcLocs(name=name) - tasks = [collect_structures, fit_constants, to_db, pass_locs] + tasks = [collect_structures, fit_force_constants, to_db, pass_locs] super().__init__(tasks, parents=parents, name=name, **kwargs) @@ -167,7 +175,6 @@ def __init__( prev_calc_dir: Optional[str] = None, db_file: str = None, temperature: Union[float, dict] = T_RENORM, - shengbte_control_kwargs: Optional[dict] = None, **kwargs ): @@ -182,17 +189,18 @@ def __init__( cs = ClusterSpace.read('cluster_space.cs') fcs = ForceConstants.read('force_constants.fcs') param = np.loadtxt('parameters.txt') + renorm_force_constants = RunHiPhiveRenorm( - cs=cluster_space.cs, - param=parameters, - fcs=force_constants.fcs, + cs=cs, + param=param, + fcs=fcs, T_renorm=T_renorm ) to_db = ForceConstantsToDb( - db_file=db_file, mesh_density=mesh_density, additional_fields={} + db_file=db_file, renormalized=True, mesh_density=mesh_density, additional_fields={} ) pass_locs = PassCalcLocs(name=name) - tasks = [collect_structures, renorm_force_constants, to_db, pass_locs] + tasks = [renorm_force_constants, to_db, pass_locs] super().__init__(tasks, name=name, **kwargs) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index f7308bb71..a711e4d5f 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -4,11 +4,12 @@ from typing import Dict, List, Optional, Union import numpy as np +from monty.serialization import loadfn, dumpfn from atomate.utils.utils import get_logger from atomate.vasp.config import DB_FILE, SHENGBTE_CMD, VASP_CMD from atomate.vasp.firetasks import pass_vasp_result -from atomate.vasp.firetasks.lattice_dynamics import T_KLAT +from atomate.vasp.firetasks.lattice_dynamics import T_KLAT, T_RENORM from atomate.vasp.fireworks.core import TransmuterFW from atomate.vasp.fireworks.lattice_dynamics import ( FitForceConstantsFW, @@ -54,7 +55,8 @@ def get_lattice_dynamics_wf( structure: Structure, - bulk_modulus: float = None + separate_fit: bool = False + bulk_modulus: float = None, common_settings: Dict = None, vasp_input_set: Optional[VaspInputSet] = None, copy_vasp_outputs: bool = False, @@ -62,7 +64,9 @@ def get_lattice_dynamics_wf( num_supercell_kwargs: Optional[dict] = None, perturbed_structure_kwargs: Optional[dict] = None, calculate_lattice_thermal_conductivity: bool = False, - thermal_conductivity_temperature: Union[float, Dict] = T_Klat, + thermal_conductivity_temperature: Union[float, Dict] = T_KLAT, + renormalize: bool = False, + renormalization_temperature: Union[float, Dict] = T_RENORM, shengbte_cmd: str = SHENGBTE_CMD, shengbte_fworker: Optional[str] = None, ): @@ -109,9 +113,15 @@ def get_lattice_dynamics_wf( calculate_lattice_thermal_conductivity: If True and force constant fitting does not return imaginary modes, then use ShengBTE to calculate the lattice thermal conductivity. - thermal_conductivity_temperature: The temperature to calculate the + renormalize: If True and force constant fitting returns imaginary modes, + then use HiPhiveRenorm to obtain phonons and force constants at + finite temperatures, which at some temperatures are hopefully real. + thermal_conductivity_temperature: The temperature at which to calculate lattice thermal conductivity for. Can be given as a single float, or a dictionary with the keys "min", "max", "step". + renormalization_temperature: The temperature at which to perform phonon + renormalization. Can be given as a single float, or a dictionary + with the keys "min", "max", "step". shengbte_cmd: Command to run ShengBTE. Supports env_chk. shengbte_fworker: If None, the ShengBTE firework's fworker will be set to all the previous fireworks' fworker. If str, the ShengBTE @@ -154,13 +164,23 @@ def get_lattice_dynamics_wf( # 2. Fit interatomic force constants from pertrubed structures allow_fizzled = {"_allow_fizzled_parents": True} fw_fit_force_constant = FitForceConstantsFW( - db_file=db_file, spec=allow_fizzled, bulk_modulus=bulk_modulus + db_file=db_file, spec=allow_fizzled, + separate_fit=separate_fit, bulk_modulus=bulk_modulus ) wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) - # RenormalizeFW(pass_inputs like bulk modulus) - - # 3. Lattice thermal conductivity calculation (optional) + # 3. RenormalizeFW (pass_inputs like bulk modulus) +# fitting_data = loadfn(fitting_data, "fitting_data.json") +# if fitting_data["n_imaginary"] > 0 and renormalize: +# fw_renormalization = RenormalizationFW( +# db_file=db_file, +# temperature=renormalization_temperature +# ) +# wf.append_wf( +# Workflow.from_Firework(fw_fw_renormalization), [wf.fws[-1].fw_id] +# ) + + # 4. Lattice thermal conductivity calculation (optional) if calculate_lattice_thermal_conductivity: fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, From 989affbaf540173eac7d4065f74ba80385231714 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Jun 2021 13:16:59 -0700 Subject: [PATCH 111/207] separate fitting --- atomate/vasp/analysis/lattice_dynamics.py | 4 ++-- atomate/vasp/workflows/base/lattice_dynamics.py | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 1419c6fbd..c91cd8119 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -303,7 +303,7 @@ def _run_cutoffs( sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=None) opt = Optimizer(sc.get_fit_data(), fit_method, - [0,2nd], + [0,n2nd], **fit_kwargs) <<<<<<< HEAD logger.info('Optimizer set up for cutoff: {}, {}'.format(i,cutoffs)) @@ -317,7 +317,7 @@ def _run_cutoffs( sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=param2) opt = Optimizer(sc.get_fit_data(), fit_method, - [2nd,nall], + [n2nd,nall], **fit_kwargs) opt.train() param_anharmonic = opt.parameters # anharmonic force constant parameters diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index a711e4d5f..d800076e1 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -55,7 +55,7 @@ def get_lattice_dynamics_wf( structure: Structure, - separate_fit: bool = False + separate_fit: bool = False, bulk_modulus: float = None, common_settings: Dict = None, vasp_input_set: Optional[VaspInputSet] = None, From 3f88a26c76e059171e849afcc139e6b392b04458 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Jun 2021 13:19:15 -0700 Subject: [PATCH 112/207] separate fitting --- atomate/vasp/analysis/lattice_dynamics.py | 8 +++++--- 1 file changed, 5 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index c91cd8119..e07c7027f 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -463,10 +463,12 @@ def get_structure_container( sc.add_structure(structure) else: # fit separately if param2 is None: # for harmonic fitting - sc.add_structure(structure) if mean_displacements <= 0.05 + if mean_displacements <= 0.05: + sc.add_structure(structure) else: # for anharmonic fitting - sc.add_structure(structure) if mean_displacements >= 0.2 - saved_structures.append(structure) if mean_displacements >= 0.2 + if mean_displacements >= 0.15: + sc.add_structure(structure) + saved_structures.append(structure) if separate_fit and param2 is not None: A_mat = sc.get_fit_data()[0] # displacement matrix f_vec = sc.get_fit_data()[1] # force vector From 1107deb9c8f23eaa0a53c5cb1f72c87eb3cbbb63 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Jun 2021 13:27:18 -0700 Subject: [PATCH 113/207] separate fitting --- atomate/vasp/firetasks/lattice_dynamics.py | 2 +- atomate/vasp/fireworks/lattice_dynamics.py | 5 ++--- 2 files changed, 3 insertions(+), 4 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 5a5752cee..205a399cd 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -205,7 +205,7 @@ def run_task(self, fw_spec): ) anharmonic_data, phonopy = anharmonic_properties( phonopy, fcs, T_QHA, thermal_data["heat_capacity"], - thermal_data["n_imaginary"], bulk_modulus=bulk_modulus + thermal_data["n_imaginary"], bulk_modulus ) fitting_data["n_imaginary"] = thermal_data.pop("n_imaginary") diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 34b2057e3..74615c0a8 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -67,7 +67,7 @@ def __init__( db_file: str = None, cutoffs: Optional[List[List[float]]] = None, separate_fit: bool = False, - bulk_modulus:float = None, + bulk_modulus: float = None, imaginary_tol: float = IMAGINARY_TOL, max_n_imaginary: int = MAX_N_IMAGINARY, max_imaginary_freq: float = MAX_IMAGINARY_FREQ, @@ -76,11 +76,10 @@ def __init__( **kwargs ): collect_structures = CollectPerturbedStructures() - logger.info("INPUT CUTOFF \n {}".format(cutoffs)) fit_force_constants = RunHiPhive( cutoffs=cutoffs, - separate_fit=separate_fit + separate_fit=separate_fit, bulk_modulus=bulk_modulus, imaginary_tol=imaginary_tol, # max_n_imaginary=max_n_imaginary, From ae4ed812d83f58b1068c0b3c48bc6dd8cec03b06 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Jun 2021 13:28:39 -0700 Subject: [PATCH 114/207] separate fitting --- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 74615c0a8..4445616fb 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -201,5 +201,5 @@ def __init__( ) pass_locs = PassCalcLocs(name=name) - tasks = [renorm_force_constants, to_db, pass_locs] + tasks = [renorm_force_constants, to_db, pass_locs] super().__init__(tasks, name=name, **kwargs) From 170b96ec9626a4b127e48badf1894dbe55de59e8 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Jun 2021 13:31:20 -0700 Subject: [PATCH 115/207] separate fitting --- atomate/vasp/analysis/lattice_dynamics.py | 4 ---- atomate/vasp/firetasks/lattice_dynamics.py | 16 ---------------- 2 files changed, 20 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index e07c7027f..e3f51acf9 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -40,8 +40,6 @@ logger = get_logger(__name__) IMAGINARY_TOL = 0.025 # in THz -#MAX_N_IMAGINARY = np.inf -#MAX_IMAGINARY_FREQ = 10 # in THz T_QHA = [i*100 for i in range(16)] T_RENORM = [i*100 for i in range(0,16)] @@ -136,8 +134,6 @@ def fit_force_constants( all_cutoffs: List[List[float]], separate_fit: bool, imaginary_tol: float = IMAGINARY_TOL, -# max_n_imaginary: int = MAX_N_IMAGINARY, -# max_imaginary_freq: float = MAX_IMAGINARY_FREQ, fit_method: str = FIT_METHOD, <<<<<<< HEAD ) -> Tuple["SortedForceConstants", Dict]: diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 205a399cd..5e8f3d207 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -18,8 +18,6 @@ from atomate.vasp.analysis.lattice_dynamics import ( FIT_METHOD, IMAGINARY_TOL, -# MAX_IMAGINARY_FREQ, -# MAX_N_IMAGINARY, T_QHA, T_RENORM, T_KLAT, @@ -134,12 +132,6 @@ class RunHiPhive(FiretaskBase): False, then they are all fit in one go. Default is False. imaginary_tol (float): Tolerance used to decide if a phonon mode is imaginary, in THz. - max_n_imaginary (int): Maximum number of imaginary modes allowed in the - the final fitted force constant solution. If this criteria is not - reached by any cutoff combination this FireTask will fizzle. - max_imaginary_freq (float): Maximum allowed imaginary frequency in the - final fitted force constant solution. If this criteria is not - reached by any cutoff combination this FireTask will fizzle. fit_method (str): Method used for fitting force constants. This can be any of the values allowed by the hiphive ``Optimizer`` class. """ @@ -149,16 +141,12 @@ class RunHiPhive(FiretaskBase): "separate_fit", "bulk_modulus", "imaginary_tol", -# "max_n_imaginary", -# "max_imaginary_freq", "fit_method", ] @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): -# max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) -# max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) fit_method = self.get("fit_method", FIT_METHOD) separate_fit = self.get('separate_fit', False) @@ -195,8 +183,6 @@ def run_task(self, fw_spec): cutoffs, separate_fit, imaginary_tol, -# max_n_imaginary, -# max_imaginary_freq, fit_method ) @@ -268,8 +254,6 @@ class RunHiPhiveRenorm(FiretaskBase): @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): -# max_n_imaginary = self.get("max_n_imaginary", MAX_N_IMAGINARY) -# max_imaginary_freq = self.get("max_imaginary_freq", MAX_IMAGINARY_FREQ) imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) fit_method = self.get("fit_method", FIT_METHOD) From 6cd23c7a2f0950316fe9710d03763d062a8c4029 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Jun 2021 13:32:36 -0700 Subject: [PATCH 116/207] separate fitting --- atomate/vasp/fireworks/lattice_dynamics.py | 12 ------------ 1 file changed, 12 deletions(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 4445616fb..a14003177 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -8,8 +8,6 @@ from atomate.vasp.analysis.lattice_dynamics import ( FIT_METHOD, IMAGINARY_TOL, - MAX_IMAGINARY_FREQ, - MAX_N_IMAGINARY, T_QHA, T_RENORM, T_KLAT @@ -46,12 +44,6 @@ class FitForceConstantsFW(Firework): bulk_modulus: Must be supplied (in GPa) to copute thermal expansion imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, in THz. - max_n_imaginary: Maximum number of imaginary modes allowed in the - final fitted force constant solution. If this criteria is not - reached by any cutoff combination the Firework will fizzle. - max_imaginary_freq: Maximum allowed imaginary frequency in the - final fitted force constant solution. If this criteria is not - reached by any cutoff combination this FireTask will fizzle. fit_method: Method used for fitting force constants. This can be any of the values allowed by the hiphive ``Optimizer`` class. mesh_density: The density of the q-point mesh used to calculate the @@ -69,8 +61,6 @@ def __init__( separate_fit: bool = False, bulk_modulus: float = None, imaginary_tol: float = IMAGINARY_TOL, - max_n_imaginary: int = MAX_N_IMAGINARY, - max_imaginary_freq: float = MAX_IMAGINARY_FREQ, fit_method: str = FIT_METHOD, mesh_density: float = MESH_DENSITY, **kwargs @@ -82,8 +72,6 @@ def __init__( separate_fit=separate_fit, bulk_modulus=bulk_modulus, imaginary_tol=imaginary_tol, -# max_n_imaginary=max_n_imaginary, -# max_imaginary_freq=max_imaginary_freq, fit_method=fit_method ) to_db = ForceConstantsToDb( From 5da14aa553b7ff985312784d77d3225beb8dbef5 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 9 Jun 2021 08:10:59 -0700 Subject: [PATCH 117/207] presets + other things --- atomate/vasp/analysis/lattice_dynamics.py | 100 ++++---- atomate/vasp/firetasks/lattice_dynamics.py | 214 ++++++++++++------ .../vasp/workflows/base/lattice_dynamics.py | 13 +- atomate/vasp/workflows/presets/core.py | 9 +- 4 files changed, 218 insertions(+), 118 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index e3f51acf9..cc6626c26 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -42,8 +42,8 @@ IMAGINARY_TOL = 0.025 # in THz T_QHA = [i*100 for i in range(16)] -T_RENORM = [i*100 for i in range(0,16)] -T_KLAT = [i*100 for i in range(0,16)] +T_RENORM = [0,100,200,300,500,700,1000,1500]#[i*100 for i in range(0,16)] +T_KLAT = [i*100 for i in range(0,11)] FIT_METHOD = "rfe" #"least-squares" @@ -268,7 +268,7 @@ def _run_cutoffs( ) -> Dict: logger.info( - "Testing cutoffs {} out of {}: {}".format(i + 1, n_cutoffs, cutoffs) + "Testing cutoffs {} out of {}: {}".format(i+1, n_cutoffs, cutoffs) ) supercell_atoms = structures[0] @@ -310,7 +310,7 @@ def _run_cutoffs( param_harmonic = opt.parameters # harmonic force constant parameters logger.info('Fitting anharmonic force constants separately') - sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=param2) + sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=param_harmonic) opt = Optimizer(sc.get_fit_data(), fit_method, [n2nd,nall], @@ -402,32 +402,22 @@ def get_structure_container( logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) parameters = enforce_rotational_sum_rules( - sc.cluster_space, parameters, ["Huang", "Born-Huang"] + cs, parameters, ["Huang", "Born-Huang"] ) fcp = ForceConstantPotential(cs, parameters) fcs = fcp.get_force_constants(supercell_atoms) logger.info('FCS generated for cutoff {}, {}'.format(i,cutoffs)) -# n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( -# parent_structure, supercell_matrix, fcs, bulk_modulus, T_QHA, imaginary_tol -# ) - - return { - "cutoffs": cutoffs, - "rmse_test": opt.rmse_test, -# "n_imaginary": n_imaginary, -# "min_frequency": min_freq, -# "temperature": T_QHA, -# "free_energy": free_energy, -# "entropy": entropy, -# "heat_capacity": Cv, -# "thermal_expansion": cte, - "cluster_space": sc.cluster_space, - "parameters": parameters, - "force_constants": fcs - } - #except Exception: - # return None + try: + return { + "cutoffs": cutoffs, + "rmse_test": opt.rmse_test, + "cluster_space": sc.cluster_space, + "parameters": parameters, + "force_constants": fcs + } + except Exception: + return None def get_structure_container( @@ -452,8 +442,11 @@ def get_structure_container( sc = StructureContainer(cs) saved_strutures = [] - for structure in structures: - displacements = get_displacements(atoms, supercell_atoms) + structure_orig = structures[0] + for i, structure in enumerate(structures): + if i==0: + continue + displacements = get_displacements(structure_orig, structure) mean_displacements = np.linalg.norm(displacements,axis=1).mean() if not separate_fit: # fit all sc.add_structure(structure) @@ -465,7 +458,7 @@ def get_structure_container( if mean_displacements >= 0.15: sc.add_structure(structure) saved_structures.append(structure) - if separate_fit and param2 is not None: + if separate_fit and param2 is not None: # do after anharmonic fitting A_mat = sc.get_fit_data()[0] # displacement matrix f_vec = sc.get_fit_data()[1] # force vector new_force = f_vec - np.dot(A_mat[:,:ncut],param2) # subract harmonic forces @@ -504,7 +497,7 @@ def harmonic_properties( frequency at Gamma, and the free energy, entropy, and heat capacity """ - logger.info('Evaluating harmonic properties.') + logger.info('Evaluating harmonic properties...') fcs2 = fcs.get_fc_array(2) fcs3 = fcs.get_fc_array(3) parent_phonopy = get_phonopy_structure(structure) @@ -553,7 +546,7 @@ def anharmonic_properties( ) -> Tuple[Dict, Phonopy]: if n_imaginary == 0: - logger.info('Evaluating anharmonic properties') + logger.info('Evaluating anharmonic properties...') fcs2 = fcs.get_fc_array(2) fcs3 = fcs.get_fc_array(3) grun, cte = gruneisen(phonopy,fcs2,fcs3,T,Cv,bulk_modulus=bulk_modulus) @@ -606,20 +599,41 @@ def percent_diff(a,b): # This process preserves cell symmetry upon thermal expansion, i.e., it prevents # symmetry-identical directions from inadvertently expanding by different ratios # when the Gruneisen routine returns slighlty different ratios for those directions - if percent_diff(grun_total_diag[0],grun_total_diag[1]) < 0.1: - avg = np.mean((grun_total_diag[0],grun_total_diag[1])) - grun_total_diag[0] = avg - grun_total_diag[1] = avg - elif percent_diff(grun_total_diag[0],grun_total_diag[2]) < 0.1: - avg = np.mean((grun_total_diag[0],grun_total_diag[2])) - grun_total_diag[0] = avg - grun_total_diag[2] = avg - elif percent_diff(grun_total_diag[1],grun_total_diag[2]) < 0.1: - avg = np.mean((grun_total_diag[1],grun_total_diag[2])) - grun_total_diag[1] = avg - grun_total_diag[2] = avg - else: + avg012 = np.mean((grun_total_diag[0],grun_total_diag[1],grun_total_diag[2])) + avg01 = np.mean((grun_total_diag[0],grun_total_diag[1])) + avg02 = np.mean((grun_total_diag[0],grun_total_diag[2])) + avg12 = np.mean((grun_total_diag[1],grun_total_diag[2])) + if percent_diff(grun_total_diag[0],avg012) < 0.1: + if percent_diff(grun_total_diag[1],avg012) < 0.1: + if percent_diff(grun_total_diag[2],avg012) < 0.1: # all siilar + grun_total_diag[0] = avg012 + grun_total_diag[1] = avg012 + grun_total_diag[2] = avg012 + elif percent_diff(grun_total_diag[2],avg02) < 0.1: # 0 and 2 similar + grun_total_diag[0] = avg02 + grun_total_diag[2] = avg02 + elif percent_diff(grun_total_diag[2],avg12) < 0.1: # 1 and 2 similar + grun_total_diag[1] = avg12 + grun_total_diag[2] = avg12 + else: + pass + elif percent_diff(grun_total_diag[1],avg01) < 0.1: # 0 and 1 similar + grun_total_diag[0] = avg01 + grun_total_diag[1] = avg01 + elif percent_diff(grun_total_diag[1],avg12) < 0.1: # 1 and 2 similar + grun_total_diag[1] = avg12 + grun_total_diag[2] = avg12 + else: + pass + elif percent_diff(grun_total_diag[0],avg01) < 0.1: # 0 and 1 similar + grun_total_diag[0] = avg01 + grun_total_diag[1] = avg01 + elif percent_diff(grun_total_diag[0],avg02) < 0.1: # 0 and 2 similar + grun_total_diag[0] = avg02 + grun_total_diag[2] = avg02 + else: # nothing similar pass + return grun_total_diag diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 5e8f3d207..edf6e26e0 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -10,6 +10,7 @@ from monty.dev import requires from monty.serialization import dumpfn, loadfn +from monty.json import jsanitize from pymongo import ReturnDocument from atomate.utils.utils import env_chk, get_logger @@ -170,12 +171,6 @@ def run_task(self, fw_spec): atoms.positions = supercell_atoms.get_positions() structures.append(atoms) - logger.info('PARENT \n {}'.format(parent_structure)) - logger.info('SUPERCELL \n {}'.format(supercell_structure)) - logger.info('SUPERCELL MATRIX \n {}'.format(supercell_matrix)) - logger.info('FIT_METHOD {}'.format(fit_method)) - logger.info('FINAL INPUT CUTOFFS \n {}'.format(cutoffs)) - fcs, param, cs, fitting_data = fit_force_constants( parent_structure, supercell_matrix, @@ -186,6 +181,12 @@ def run_task(self, fw_spec): fit_method ) + if fcs is None: + # fitting failed for some reason + raise RuntimeError( + "Could not find a force constant solution" + ) + thermal_data, phonopy = harmonic_properties( parent_structure, supercell_matrix, fcs, T_QHA, imaginary_tol ) @@ -199,14 +200,6 @@ def run_task(self, fw_spec): dumpfn(fitting_data, "fitting_data.json") dumpfn(thermal_data, "thermal_data_qha.json") -# if force_constants is None: -# # fitting failed -# raise RuntimeError( -# "Could not find a force constant solution with less than {} " -# "imaginary modes.\n" -# "Fitting results: {}".format(max_n_imaginary, fitting_data) -# ) - logger.info("Writing cluster space and force_constants") logger.info("{}".format(type(fcs))) fcs.write("force_constants.fcs") @@ -218,8 +211,8 @@ def run_task(self, fw_spec): atoms = AseAtomsAdaptor.get_atoms(parent_structure) fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms, order=3) fcs.write_to_phonopy("FORCE_CONSTANTS_2ND", format="text") - elif n_imaginary > 0: - logger.info("Imaginary modes exist! ShengBTE files not written. You may want to perform phonon renormalization.") + else: + logger.info("ShengBTE files not written due to imaginary modes. You may want to perform phonon renormalization.") @@ -371,66 +364,132 @@ def run_task(self, fw_spec): supercell_structure = structure_data["supercell_structure"] supercell_matrix = structure_data["supercell_matrix"] - if renormalized: # FC from renormalization - thermal_data = loadfn("thermal_data_renorm.json") - temperature = thermal_data["temperature"] - for t, T in enumerate(temperature): - ## err should I collect results for all T and push data at once, - ## or push data for each T individually? - fcs = ForceConstants.read("force_constants_{}K.fcs") - phonopy_fc = fcs.get_fc_array(order=2) - dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( - structure, supercell_matrix, phonopy_fc, mesh_density, mmdb - ) - data = { - "thermal_data": thermal_data, - "force_constants_fs_id": fc_fsid, - "tags": fw_spec.get("tags", None), - "phonon_dos_fs_id": dos_fsid, - "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, - "phonon_bandstructure_line_fs_id": lm_bs_fsid, - "created_at": datetime.utcnow(), - } - data.update(self.get("additional_fields", {})) - else: # FC directly from fitting - fitting_data = loadfn("fitting_data.json") - thermal_data = loadfn("thermal_data_qha.json") - fcs = ForceConstants.read("force_constants.fcs") + fitting_data = loadfn("fitting_data.json") + thermal_data = loadfn("thermal_data_qha.json") + fcs = ForceConstants.read("force_constants.fcs") + + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, fcs, mesh_density, mmdb + ) + + data = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix, + "supercell_structure": supercell_structure.as_dict(), + "perturbed_structures": [s.as_dict() for s in structures], + "perturbed_forces": [f.tolist() for f in forces], + "fitting_data": fitting_data, + "thermal_data": thermal_data, + "force_constants_fs_id": fc_fsid, + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + } + data.update(self.get("additional_fields", {})) + + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + data.update(metadata) + data = jsanitize(data,strict=True,allow_bson=True) + + mmdb.db.lattice_dynamics.insert_one(data) + + logger.info("Finished inserting force constants") + + return FWAction(update_spec=metadata) + + + +class ForceConstantsRenormToDb(FiretaskBase): + """ + Add force constants, phonon band structure and density of states + to the database. + + Assumes you are in a directory with the force constants, fitting + data, and structure data written to files. + Required parameters: + db_file (str): Path to DB file for the database that contains the + perturbed structure calculations. + Optional parameters: + renormalized (bool): Whether FC resulted from original fitting (False) + or renormalization process (True) determines how data are stored. + Default is False. mesh_density (float): The density of the q-point mesh used to calculate + the phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + additional_fields (dict): Additional fields added to the document, such + as user-defined tags, name, ids, etc. """ + + required_params = ["db_file"] + optional_params = ["renormalized","mesh_density", "additional_fields"] + + @requires(hiphive, "hiphive is required for lattice dynamics workflow") + def run_task(self, fw_spec): + + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + renormalized = self.get("renormalized", False) + mesh_density = self.get("mesh_density", MESH_DENSITY) + + structure_data = loadfn("structure_data.json") + forces = loadfn("perturbed_forces.json") + structures = loadfn("perturbed_structures.json") + + structure = structure_data["structure"] + supercell_structure = structure_data["supercell_structure"] + supercell_matrix = structure_data["supercell_matrix"] + + thermal_data = loadfn("thermal_data_renorm.json") + temperature = thermal_data["temperature"] + + data = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "structure": structure.as_dict(), + "thermal_data": thermal_data, + } + + temperature_to_keep = [] + renormalized_data = [] + for t, T in enumerate(temperature): + ## err should I collect results for all T and push data at once, + ## or push data for each T individually? + fcs = ForceConstants.read("force_constants_{}K.fcs") + phonopy_fc = fcs.get_fc_array(order=2) dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( - structure, supercell_matrix, fcs, mesh_density, mmdb + structure, supercell_matrix, phonopy_fc, mesh_density, mmdb ) - - data = { - "structure": structure.as_dict(), - "supercell_matrix": supercell_matrix, - "supercell_structure": supercell_structure.as_dict(), - "perturbed_structures": [s.as_dict() for s in structures], - "perturbed_forces": [f.tolist() for f in forces], - "fitting_data": fitting_data, - "thermal_data": thermal_data, + + data_at_T = { "force_constants_fs_id": fc_fsid, - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, "phonon_dos_fs_id": dos_fsid, "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, "phonon_bandstructure_line_fs_id": lm_bs_fsid, - "created_at": datetime.utcnow(), } - data.update(self.get("additional_fields", {})) - - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} - data.update(metadata) - mmdb.db.lattice_dynamics.insert_many(data) # WHAT TO DO HERE? -# mmdb.db.lattice_dynamics.insert_one(data) - - logger.info("Finished inserting force constants") + temperature_to_keep.append(T) + renormalized_data.append(data_at_T) + data["temperatures"] = temperature_to_keep + data["renormalized_data"] = renormalized_data + data.update(self.get("additional_fields", {})) - return FWAction(update_spec=metadata) + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + data.update(metadata) + data = jsanitize(data,strict=True,allow_bson=True) + + mmdb.db.renormalized_lattice_dynamics.insert_one(data) + logger.info("Finished inserting renormalized force constants") + return FWAction(update_spec=metadata) + + @explicit_serialize class RunShengBTE(FiretaskBase): """ @@ -458,12 +517,33 @@ def run_task(self, fw_spec): structure_data = loadfn("structure_data.json") structure = structure_data["structure"] supercell_matrix = structure_data["supercell_matrix"] - + temperature = self.get("temperature", T_KLAT) + + if isinstance(temperature, (int, float)): + self["t"] = temperature + elif isinstance(temperature, (list, np.ndarray)): + t_max = np.max(np.array(temperature)) + t_min = np.min(np.array(temperature)) + if t_min==0: + t_min = np.partition(temperature,1)[1] + t_step = (t_max-t_min)/(len(temperature)-2) + else: + t_step = (t_max-t_min)/(len(temperature)-1) + self["t_min"] = t_min + self["t_max"] = t_max + self["t_step"] = t_step + elif isinstance(temperature, dict): + self["t_min"] = temperature["min"] + self["t_max"] = temperature["max"] + self["t_step"] = temperature["step"] + else: + raise ValueError("Unsupported temperature type, must be float or dict") + control_dict = { "scalebroad": 0.5, "nonanalytic": False, "isotopes": False, - "temperature": self.get("temperature", T_QHA), + "temperature": self.get("temperature", T_KLAT), "scell": np.diag(supercell_matrix).tolist(), } control_kwargs = self.get("control_kwargs") or {} diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index d800076e1..9ced8bb86 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -10,7 +10,7 @@ from atomate.vasp.config import DB_FILE, SHENGBTE_CMD, VASP_CMD from atomate.vasp.firetasks import pass_vasp_result from atomate.vasp.firetasks.lattice_dynamics import T_KLAT, T_RENORM -from atomate.vasp.fireworks.core import TransmuterFW +from atomate.vasp.fireworks.core import TransmuterFW, OptimizeFW from atomate.vasp.fireworks.lattice_dynamics import ( FitForceConstantsFW, LatticeThermalConductivityFW, @@ -31,12 +31,13 @@ logger = get_logger(__name__) _static_user_incar_settings = { + "PREC": "Accurate", "ADDGRID": True, "LCHARG": False, - "ENCUT": 700, + "ENCUT": 520, "ISMEAR": 0, - "EDIFF": 1e-8, - "PREC": "Accurate", + "SIGMA": 0.1, + "EDIFF": 1e-6, "LAECHG": False, "LREAL": False, "LASPH": True, @@ -150,7 +151,7 @@ def get_lattice_dynamics_wf( n_supercells = get_num_supercells(supercell, **num_supercell_kwargs) perturbed_structure_kwargs["n_configs_per_std"] = n_supercells - # 1. Start by pertrubing supercell and calculating forces + # 1. Perturb supercell and calculae forces wf = get_perturbed_structure_wf( structure, supercell_matrix=supercell_matrix, @@ -180,7 +181,7 @@ def get_lattice_dynamics_wf( # Workflow.from_Firework(fw_fw_renormalization), [wf.fws[-1].fw_id] # ) - # 4. Lattice thermal conductivity calculation (optional) + # 4. Lattice thermal conductivity calculation if calculate_lattice_thermal_conductivity: fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 6e98f1194..ab3e57137 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -848,8 +848,10 @@ def wf_nudged_elastic_band(structures, parent, c=None): return wf -def wf_lattice_thermal_conductivity( +def wf_lattice_dynamics( structure: Structure, + separate_fit: bool = False, + bulk_modulus: float = None, c: Optional[dict] = None, **ld_kwargs ) -> Workflow: @@ -870,13 +872,14 @@ def wf_lattice_thermal_conductivity( """ optimize_uis = { "LAECHG": False, - 'ENCUT': 700, + 'ENCUT': 520, 'ADDGRID': True, 'EDIFFG': -5e-4, 'PREC': 'Accurate', "LREAL": False, 'EDIFF': 1e-8, "ISMEAR": 0, + "SIGMA": 0.1, 'LCHARG': False, 'LASPH': True } @@ -896,6 +899,8 @@ def wf_lattice_thermal_conductivity( wf_ld = get_lattice_dynamics_wf( structure, + separate_fit: bool = separate_fit, + bulk_modulus: float = bulk_modulus, common_settings=c, calculate_lattice_thermal_conductivity=True, copy_vasp_outputs=True, From 5d56a502110f5e33c4aea5f9ac924bb2a7edaf53 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 9 Jun 2021 08:23:26 -0700 Subject: [PATCH 118/207] presets --- atomate/vasp/workflows/base/lattice_dynamics.py | 2 +- atomate/vasp/workflows/presets/core.py | 13 ++++++++++++- 2 files changed, 13 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 9ced8bb86..54a5b6fba 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -151,7 +151,7 @@ def get_lattice_dynamics_wf( n_supercells = get_num_supercells(supercell, **num_supercell_kwargs) perturbed_structure_kwargs["n_configs_per_std"] = n_supercells - # 1. Perturb supercell and calculae forces + # 1. Perturb supercell and calculate forces wf = get_perturbed_structure_wf( structure, supercell_matrix=supercell_matrix, diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index ab3e57137..c85d7f2da 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -853,6 +853,12 @@ def wf_lattice_dynamics( separate_fit: bool = False, bulk_modulus: float = None, c: Optional[dict] = None, + supercell_matrix_kwargs: Optional[dict] = None, + num_supercell_kwargs: Optional[dict] = None, + calculate_lattice_thermal_conductivity=True, + thermal_conductivity_temperature=None, + renormalize=False, + renormalization_temperature=None, **ld_kwargs ) -> Workflow: """ @@ -902,7 +908,12 @@ def wf_lattice_dynamics( separate_fit: bool = separate_fit, bulk_modulus: float = bulk_modulus, common_settings=c, - calculate_lattice_thermal_conductivity=True, + supercell_matrix_kwargs: supercell_matrix_kwargs, + num_supercell_kwargs: num_supercell_kwargs, + calculate_lattice_thermal_conductivity=calculate_lattice_thermal_conductivity, + thermal_conductivity_temperature=thermal_conductivity_temperature, + renormalize=renormalize, + renormalization_temperature=renormalization_temperature, copy_vasp_outputs=True, **ld_kwargs ) From 128ff50e3e97d198e50f05fa5da22ce4f59bd0d2 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 9 Jun 2021 08:31:18 -0700 Subject: [PATCH 119/207] preset --- atomate/vasp/workflows/presets/core.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index c85d7f2da..055095914 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -905,8 +905,8 @@ def wf_lattice_dynamics( wf_ld = get_lattice_dynamics_wf( structure, - separate_fit: bool = separate_fit, - bulk_modulus: float = bulk_modulus, + separate_fit = separate_fit, + bulk_modulus = bulk_modulus, common_settings=c, supercell_matrix_kwargs: supercell_matrix_kwargs, num_supercell_kwargs: num_supercell_kwargs, From ef8880f86628b7701917ecded6c148c55d56e8ea Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 9 Jun 2021 08:34:14 -0700 Subject: [PATCH 120/207] preset --- atomate/vasp/workflows/presets/core.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 055095914..21095a194 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -908,8 +908,8 @@ def wf_lattice_dynamics( separate_fit = separate_fit, bulk_modulus = bulk_modulus, common_settings=c, - supercell_matrix_kwargs: supercell_matrix_kwargs, - num_supercell_kwargs: num_supercell_kwargs, + supercell_matrix_kwargs=supercell_matrix_kwargs, + num_supercell_kwargs=num_supercell_kwargs, calculate_lattice_thermal_conductivity=calculate_lattice_thermal_conductivity, thermal_conductivity_temperature=thermal_conductivity_temperature, renormalize=renormalize, From 43cd4fe12cd863df70b5c75e1aa998890176bad8 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 17 Jun 2021 21:54:39 -0700 Subject: [PATCH 121/207] update --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- atomate/vasp/firetasks/lattice_dynamics.py | 47 +++++++------- atomate/vasp/fireworks/lattice_dynamics.py | 60 +++++++++++++----- .../vasp/workflows/base/lattice_dynamics.py | 63 ++++++++++++------- 4 files changed, 111 insertions(+), 61 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index cc6626c26..39bc5e35c 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -43,7 +43,7 @@ T_QHA = [i*100 for i in range(16)] T_RENORM = [0,100,200,300,500,700,1000,1500]#[i*100 for i in range(0,16)] -T_KLAT = [i*100 for i in range(0,11)] +T_KLAT = {"t_min":100,"t_max":1000,"t_step":100} #[i*100 for i in range(0,11)] FIT_METHOD = "rfe" #"least-squares" diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index edf6e26e0..f9fe08811 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -262,7 +262,7 @@ def run_task(self, fw_spec): bulk_modulus = self.get("bulk_modulus") T_renorm = self.get("T_renorm", T_RENORM) - renorm_results = Parallel(n_jobs=2, backend="multiprocessing")(delayed(renormalization)( + renorm_results = Parallel(n_jobs=4, backend="multiprocessing")(delayed(renormalization)( parent_structure, supercell_matrix, cs, fcs, param, T, nconfig, conv_thresh, imaginary_tol ) for t, T in enumerate(T_renorm)) @@ -505,45 +505,50 @@ class RunShengBTE(FiretaskBase): Optional parameters: temperature (float or dict): The temperature to calculate the lattice thermal conductivity for. Can be given as a single float, or a - dictionary with the keys "min", "max", "step". + dictionary with the keys "t_min", "t_max", "t_step". control_kwargs (dict): Options to be included in the ShengBTE control file. """ required_params = ["shengbte_cmd"] - optional_params = ["temperature", "control_kwargs"] + optional_params = ["renormalized","temperature", "control_kwargs"] def run_task(self, fw_spec): structure_data = loadfn("structure_data.json") structure = structure_data["structure"] supercell_matrix = structure_data["supercell_matrix"] temperature = self.get("temperature", T_KLAT) + renormalized = self.get("renormalized", False) - if isinstance(temperature, (int, float)): + if renormalized: + assert isinstance(temperature, (int, float)) self["t"] = temperature - elif isinstance(temperature, (list, np.ndarray)): - t_max = np.max(np.array(temperature)) - t_min = np.min(np.array(temperature)) - if t_min==0: - t_min = np.partition(temperature,1)[1] - t_step = (t_max-t_min)/(len(temperature)-2) - else: - t_step = (t_max-t_min)/(len(temperature)-1) - self["t_min"] = t_min - self["t_max"] = t_max - self["t_step"] = t_step - elif isinstance(temperature, dict): - self["t_min"] = temperature["min"] - self["t_max"] = temperature["max"] - self["t_step"] = temperature["step"] else: - raise ValueError("Unsupported temperature type, must be float or dict") + if isinstance(temperature, (int, float)): + self["t"] = temperature + elif isinstance(temperature, (list, np.ndarray)): + t_max = np.max(np.array(temperature)) + t_min = np.min(np.array(temperature)) + if t_min==0: + t_min = np.partition(temperature,1)[1] + t_step = (t_max-t_min)/(len(temperature)-2) + else: + t_step = (t_max-t_min)/(len(temperature)-1) + self["t_min"] = t_min + self["t_max"] = t_max + self["t_step"] = t_step + elif isinstance(temperature, dict): + self["t_min"] = temperature["t_min"] + self["t_max"] = temperature["t_max"] + self["t_step"] = temperature["t_step"] + else: + raise ValueError("Unsupported temperature type, must be float or dict") control_dict = { "scalebroad": 0.5, "nonanalytic": False, "isotopes": False, - "temperature": self.get("temperature", T_KLAT), + "temperature": temperature, "scell": np.diag(supercell_matrix).tolist(), } control_kwargs = self.get("control_kwargs") or {} diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index a14003177..a03d28d86 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -109,27 +109,53 @@ def __init__( prev_calc_dir: Optional[str] = None, db_file: str = None, shengbte_cmd: str = SHENGBTE_CMD, + renormalized: bool = False, temperature: Union[float, dict] = T_KLAT, shengbte_control_kwargs: Optional[dict] = None, **kwargs ): # files needed to run ShengBTE - files = [ - "structure_data.json", - "FORCE_CONSTANTS_2ND", - "FORCE_CONSTANTS_3RD", - ] - - if prev_calc_dir: - copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) - else: - copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) - - run_shengbte = RunShengBTE( - shengbte_cmd=shengbte_cmd, - temperature=temperature, - control_kwargs=shengbte_control_kwargs, - ) + if renormalized: # must check if FORCE_CONSTANTS_2ND_{T}K can be copied individually + files = [ + "structure_data.json", + "FORCE_CONSTANTS_2ND_{}K".format(temperature), + "FORCE_CONSTANTS_3RD" + ] + if prev_calc_dir: + try: + copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) + except: + raise IOError("FORCE_CONSTANTS_2ND_{}K not found! Abandoning ShengBTE run." + .format(temperature)) + else: + try: + copy_files = CopyFilesFromCalcLoc(calc_loc=True, files_to_copy=files) + except: + raise IOError("FORCE_CONSTANTS_2ND_{}K not found! Abandoning ShengBTE run." + .format(temperature)) + run_shengbte = RunShengBTE( + shengbte_cmd=shengbte_cmd, + temperature=temperature, + renormlized=renormalized, + control_kwargs=shengbte_control_kwargs, + ) + else: # only the default files are needed + files = [ + "structure_data.json", + "FORCE_CONSTANTS_2ND", + "FORCE_CONSTANTS_3RD", + ] + if prev_calc_dir: + copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) + else: + copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + run_shengbte = RunShengBTE( + shengbte_cmd=shengbte_cmd, + renormlized=renormalized, + temperature=temperature, + control_kwargs=shengbte_control_kwargs, + ) + shengbte_to_db = ShengBTEToDb(db_file=db_file, additional_fields={}) tasks = [copy_files, run_shengbte, shengbte_to_db] @@ -158,10 +184,10 @@ class RenormalizationFW(Firework): def __init__( self, + temperature: Union[float, list], name="Renormalization", prev_calc_dir: Optional[str] = None, db_file: str = None, - temperature: Union[float, dict] = T_RENORM, **kwargs ): diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 54a5b6fba..abfe38a8a 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -24,8 +24,8 @@ CubicSupercellTransformation, ) -__author__ = "Alex Ganose, Rees Chang" -__email__ = "aganose@lbl.gov, rc564@cornell.edu" +__author__ = "Alex Ganose, Rees Chang, Junsoo Park" +__email__ = "aganose@lbl.gov, rc564@cornell.edu, jsyony37@lbl.gov" __date__ = "February 2020" logger = get_logger(__name__) @@ -91,7 +91,9 @@ def get_lattice_dynamics_wf( the minimization schemes in hiPhive. 5. Output the interatomic force constants, and phonon band structure and density of states to the database. - 6. Optional: Solve the lattice thermal conductivity using ShengBTE and + 6. Optional: Perform phonon renormalization at finite temperature - useful + when unstable modes exist + 7. Optional: Solve the lattice thermal conductivity using ShengBTE and output to the database. Args: @@ -171,30 +173,47 @@ def get_lattice_dynamics_wf( wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) # 3. RenormalizeFW (pass_inputs like bulk modulus) -# fitting_data = loadfn(fitting_data, "fitting_data.json") -# if fitting_data["n_imaginary"] > 0 and renormalize: -# fw_renormalization = RenormalizationFW( -# db_file=db_file, -# temperature=renormalization_temperature -# ) -# wf.append_wf( -# Workflow.from_Firework(fw_fw_renormalization), [wf.fws[-1].fw_id] -# ) - - # 4. Lattice thermal conductivity calculation - if calculate_lattice_thermal_conductivity: - fw_lattice_conductivity = LatticeThermalConductivityFW( + if renormalize: + fw_renormalization = RenormalizationFW( + temperature=renormalization_temperature, db_file=db_file, - shengbte_cmd=shengbte_cmd, - temperature=thermal_conductivity_temperature, ) - if shengbte_fworker: - fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker - wf.append_wf( - Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-1].fw_id] + Workflow.from_Firework(fw_renormalization), [wf.fws[-1].fw_id] ) + # 4. Lattice thermal conductivity calculation + if calculate_lattice_thermal_conductivity: + if renormalize: + # Because of the way ShengBTE works, a temperature array that is not + # equally spaced out (T_step) requires submission for each temperature + fw_lattice_conductivity = [] + for T in renormalization_temperature: + fw = LatticeThermalConductivityFW( + db_file=db_file, + shengbte_cmd=shengbte_cmd, + renormalized=True, + temperature=T + ) + if shengbte_fworker: + fw.spec["_fworker"] = shengbte_fworker + fw_lattice_conductivity.append(fw) + wf.append_wf( + Workflow.from_Firework(fw_lattice_conductivity), wf.leaf_fw_ids + ) + else: + fw_lattice_conductivity = LatticeThermalConductivityFW( + db_file=db_file, + shengbte_cmd=shengbte_cmd, + renormalized=False, + temperature=thermal_conductivity_temperature, + ) + if shengbte_fworker: + fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker + wf.append_wf( + Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-1].fw_id] + ) + formula = structure.composition.reduced_formula wf.name = "{} - lattice dynamics".format(formula) From 6ad697c528c0cebbe520ac5e6cc178c50a379f06 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 17 Jun 2021 22:11:28 -0700 Subject: [PATCH 122/207] update --- atomate/vasp/workflows/base/lattice_dynamics.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index abfe38a8a..672f42be8 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -67,7 +67,7 @@ def get_lattice_dynamics_wf( calculate_lattice_thermal_conductivity: bool = False, thermal_conductivity_temperature: Union[float, Dict] = T_KLAT, renormalize: bool = False, - renormalization_temperature: Union[float, Dict] = T_RENORM, + renormalization_temperature: Union[float, List, Dict] = T_RENORM, shengbte_cmd: str = SHENGBTE_CMD, shengbte_fworker: Optional[str] = None, ): @@ -123,7 +123,7 @@ def get_lattice_dynamics_wf( lattice thermal conductivity for. Can be given as a single float, or a dictionary with the keys "min", "max", "step". renormalization_temperature: The temperature at which to perform phonon - renormalization. Can be given as a single float, or a dictionary + renormalization. Can be given as a single float, list, or a dictionary with the keys "min", "max", "step". shengbte_cmd: Command to run ShengBTE. Supports env_chk. shengbte_fworker: If None, the ShengBTE firework's fworker will be set From d6b0f7b2218240a8002e9a3f820535a6dac3f9a2 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 17 Jun 2021 22:14:41 -0700 Subject: [PATCH 123/207] update --- atomate/vasp/fireworks/lattice_dynamics.py | 2 ++ 1 file changed, 2 insertions(+) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index a03d28d86..d32af3052 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -95,6 +95,8 @@ class LatticeThermalConductivityFW(Firework): db_file: Path to a db file. shengbte_cmd: The name of the shengbte executable to run. Supports env_chk. + renormalized: boolean to denote whether force constants are from + phonon renormalization (True) or directly from fitting (False) temperature: The temperature to calculate the lattice thermal conductivity for. Can be given as a single float, or a dictionary with the keys "min", "max", "step". From 5a859b3409ca87943932c91911b95e460e0c4ba0 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 17 Jun 2021 22:20:23 -0700 Subject: [PATCH 124/207] update --- atomate/vasp/firetasks/lattice_dynamics.py | 2 ++ atomate/vasp/fireworks/lattice_dynamics.py | 4 ++-- 2 files changed, 4 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index f9fe08811..99822ca8e 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -503,6 +503,8 @@ class RunShengBTE(FiretaskBase): env_chk. Optional parameters: + renormalized: boolean to denote whether force constants are from + phonon renormalization (True) or directly from fitting (False) temperature (float or dict): The temperature to calculate the lattice thermal conductivity for. Can be given as a single float, or a dictionary with the keys "t_min", "t_max", "t_step". diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index d32af3052..44816a534 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -137,8 +137,8 @@ def __init__( .format(temperature)) run_shengbte = RunShengBTE( shengbte_cmd=shengbte_cmd, + renormalized=renormalized, temperature=temperature, - renormlized=renormalized, control_kwargs=shengbte_control_kwargs, ) else: # only the default files are needed @@ -153,7 +153,7 @@ def __init__( copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) run_shengbte = RunShengBTE( shengbte_cmd=shengbte_cmd, - renormlized=renormalized, + renormalized=renormalized, temperature=temperature, control_kwargs=shengbte_control_kwargs, ) From 2be7628a7bc202aedc7fdb2e2f305e2456a936a5 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 1 Jul 2021 22:32:53 -0700 Subject: [PATCH 125/207] fixed cutoff --- atomate/vasp/analysis/lattice_dynamics.py | 44 +++++++++++-------- .../vasp/workflows/base/lattice_dynamics.py | 6 +-- atomate/vasp/workflows/presets/core.py | 2 +- 3 files changed, 29 insertions(+), 23 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 39bc5e35c..588f0fe1a 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -92,10 +92,11 @@ def get_cutoffs(structure: Structure): """ # indexed as min_cutoffs[order][period] min_cutoffs = { - 2: {1: 5.0, 2: 5.5, 3: 6.0, 4: 7.0, 5: 8.0, 6: 9.0, 7: 10.0}, + 2: {1: 5.0, 2: 6.0, 3: 7.0, 4: 8.0, 5: 9.0, 6: 9.0, 7: 10.0}, 3: {1: 3.0, 2: 3.5, 3: 4.0, 4: 4.5, 5: 5.0, 6: 5.5, 7: 6.0}, 4: {1: 2.0, 2: 2.5, 3: 3.0, 4: 3.0, 5: 3.5, 6: 4.0, 7: 4.5}, } +<<<<<<< HEAD <<<<<<< HEAD inc = {2: 3, 3: 1.5, 4: 1} steps = {2: 0.5, 3: 0.25, 4: 0.25} @@ -104,6 +105,10 @@ def get_cutoffs(structure: Structure): ======= inc = {2: 2, 3: 1, 4: 0.5} steps = {2: 1, 3: 0.5, 4: 0.5} +======= + inc = {2: 2, 3: 1.5, 4: 0.5} + steps = {2: 1, 3: 0.75, 4: 0.5} +>>>>>>> c69d0316 (fixed cutoff) row = min([s.row for s in supercell_structure.species]) factor = row/4 @@ -121,8 +126,10 @@ def get_cutoffs(structure: Structure): ======= cutoffs = np.array(list(map(list, product(range_two, range_three, range_four)))) max_cutoff = estimate_maximum_cutoff(AseAtomsAdaptor.get_atoms(supercell_structure)) + logger.info('CUTOFFS \n {}'.format(cutoffs)) logger.info('MAX_CUTOFF \n {}'.format(max_cutoff)) - good_cutoffs = np.all(cutoffs < np.around(max_cutoff, 4) - 0.0001, axis=1) + good_cutoffs = np.all(cutoffs < max_cutoff-0.1, axis=1) + logger.info('GOOD CUTOFFS \n{}'.format(good_cutoffs)) return cutoffs[good_cutoffs].tolist() >>>>>>> c094a175 (cutoff vs cell_size) @@ -197,6 +204,7 @@ def fit_force_constants( # "entropy": [], # "heat_capacity": [], "fit_method": fit_method, + "separate_fit": separate_fit, "imaginary_tol": imaginary_tol, # "max_n_imaginary": max_n_imaginary, } @@ -228,6 +236,7 @@ def fit_force_constants( cutoff_results = Parallel(n_jobs=12, backend="multiprocessing")(delayed(_run_cutoffs)( i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, fit_method, separate_fit, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) +# separate_fit, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) logger.info('CUTOFF RESULTS \n {}'.format(cutoff_results)) @@ -400,14 +409,15 @@ def get_structure_container( opt.train() parameters = opt.parameters logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) - + + logger.info('Memory use: {} %'.format(psutil.virtual_memory().percent)) parameters = enforce_rotational_sum_rules( cs, parameters, ["Huang", "Born-Huang"] ) fcp = ForceConstantPotential(cs, parameters) fcs = fcp.get_force_constants(supercell_atoms) logger.info('FCS generated for cutoff {}, {}'.format(i,cutoffs)) - + try: return { "cutoffs": cutoffs, @@ -441,32 +451,30 @@ def get_structure_container( """ sc = StructureContainer(cs) - saved_strutures = [] - structure_orig = structures[0] + saved_structures = [] for i, structure in enumerate(structures): - if i==0: - continue - displacements = get_displacements(structure_orig, structure) + displacements = structure.get_array('displacements') mean_displacements = np.linalg.norm(displacements,axis=1).mean() + logger.info('Mean displacements: {}'.format(mean_displacements)) if not separate_fit: # fit all sc.add_structure(structure) else: # fit separately if param2 is None: # for harmonic fitting - if mean_displacements <= 0.05: + if mean_displacements < 0.07: sc.add_structure(structure) else: # for anharmonic fitting - if mean_displacements >= 0.15: + if mean_displacements >= 0.07: sc.add_structure(structure) saved_structures.append(structure) if separate_fit and param2 is not None: # do after anharmonic fitting A_mat = sc.get_fit_data()[0] # displacement matrix f_vec = sc.get_fit_data()[1] # force vector - new_force = f_vec - np.dot(A_mat[:,:ncut],param2) # subract harmonic forces + anh_force = f_vec - np.dot(A_mat[:,:ncut],param2) # subtract harmonic forces sc.delete_all_structures() for i, structure in enumerate(saved_structures): - naroms = structure.et_global_number_of_atoms() + natoms = structure.get_global_number_of_atoms() ndisp = natoms*3 - structure.set_array('forces',new_force[i*ndisp:(i+1)*ndisp].reshape(natoms,3)) + structure.set_array('forces',anh_force[i*ndisp:(i+1)*ndisp].reshape(natoms,3)) sc.add_structure(structure) logger.debug(sc.__repr__()) @@ -648,9 +656,7 @@ def gruneisen( gruneisen = Gruneisen(fcs2,fcs3,phonopy.supercell,phonopy.primitive) gruneisen.set_sampling_mesh(phonopy.mesh_numbers,is_gamma_center=True) - logger.info('Memory use before Gruneisen: {} %'.format(psutil.virtual_memory().percent)) gruneisen.run() - logger.info('Memory use after Gruneisen: {} %'.format(psutil.virtual_memory().percent)) grun = gruneisen.get_gruneisen_parameters() # (nptk,nmode,3,3) omega = gruneisen._frequencies qp = gruneisen._qpoints @@ -668,8 +674,8 @@ def gruneisen( vol = phonopy.primitive.get_volume() cte = grun_tot*(Cv.repeat(3).reshape((len(Cv),3)))/(vol/10**30)/(bulk_modulus*10**9)/3 cte = np.nan_to_num(cte) - logger.info('Gruneisen : {}'.format(grun_tot)) - logger.info('CTE : {}'.format(cte)) + logger.info('Gruneisen: \n {}'.format(grun_tot)) + logger.info('CTE: \n {}'.format(cte)) return grun_tot, cte @@ -691,7 +697,7 @@ def thermal_expansion( for t in range(len(temperature)): dLfrac[t,:] = np.trapz(cte[:t+1,:],temperature[:t+1],axis=0) dLfrac = np.nan_to_num(dLfrac) - logger.info('dLfrac : {}'.format(dLfrac)) + logger.info('dLfrac: \n {}'.format(dLfrac)) if T is None: return dLfrac else: diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 672f42be8..eaff6de48 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -34,10 +34,10 @@ "PREC": "Accurate", "ADDGRID": True, "LCHARG": False, - "ENCUT": 520, + "ENCUT": 600, "ISMEAR": 0, "SIGMA": 0.1, - "EDIFF": 1e-6, + "EDIFF": 1e-7, "LAECHG": False, "LREAL": False, "LASPH": True, @@ -200,7 +200,7 @@ def get_lattice_dynamics_wf( fw_lattice_conductivity.append(fw) wf.append_wf( Workflow.from_Firework(fw_lattice_conductivity), wf.leaf_fw_ids - ) + ) else: fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 21095a194..524b049d2 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -878,7 +878,7 @@ def wf_lattice_dynamics( """ optimize_uis = { "LAECHG": False, - 'ENCUT': 520, + 'ENCUT': 600, 'ADDGRID': True, 'EDIFFG': -5e-4, 'PREC': 'Accurate', From aa9d488aefa4333c4a38b961006216e64a33ce8c Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 7 Jul 2021 19:37:32 -0700 Subject: [PATCH 126/207] update --- atomate/vasp/analysis/lattice_dynamics.py | 45 +++++++++++++++-------- 1 file changed, 30 insertions(+), 15 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 588f0fe1a..b815c1ec0 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -53,35 +53,45 @@ def get_cutoffs(structure: Structure): """ +<<<<<<< HEAD Get a list of trial cutoffs based on a structure. +======= + Get a list of trial cutoffs based on a supercell structure for grid search. +>>>>>>> b637d9a8 (update) An initial guess for the lower bound of the cutoffs is made based on the - period of the lightest element in the structure, according to: + average period (row) of the elements in the structure, according to: ====== === === === . Cutoff ------ ----------- Period 2ND 3RD 4TH ====== === === === - 1 5.0 3.0 2.0 - 2 5.5 3.5 2.5 - 3 6.0 4.0 3.0 - 4 7.0 4.5 3.0 - 5 8.0 5.0 3.5 - 6 9.0 5.5 4.0 - 7 10.0 6.0 4.5 + 1 5.0 3.0 2.5 + 2 6.0 3.5 3.0 + 3 7.0 4.5 3.5 + 4 8.0 5.5 4.0 + 5 9.0 6.0 4.5 + 6 10.0 6.5 5.0 + 7 11.0 7.0 5.5 ====== === === === The maximum cutoff for each order is determined by the minimum cutoff and the following table. A full grid of all possible cutoff combinations is - generated based on the step size in the table below + generated based on the step size in the table below times a row factor ====== ==== ===== Cutoff Max Step ====== ==== ===== +<<<<<<< HEAD 2ND +3.0 0.5 3RD +1.5 0.25 4TH +1.0 0.25 +======= + 2ND +2.0 1.0 + 3RD +1.5 0.75 + 4TH +0.6 0.6 +>>>>>>> b637d9a8 (update) ====== ==== ===== Args: @@ -92,11 +102,12 @@ def get_cutoffs(structure: Structure): """ # indexed as min_cutoffs[order][period] min_cutoffs = { - 2: {1: 5.0, 2: 6.0, 3: 7.0, 4: 8.0, 5: 9.0, 6: 9.0, 7: 10.0}, - 3: {1: 3.0, 2: 3.5, 3: 4.0, 4: 4.5, 5: 5.0, 6: 5.5, 7: 6.0}, - 4: {1: 2.0, 2: 2.5, 3: 3.0, 4: 3.0, 5: 3.5, 6: 4.0, 7: 4.5}, + 2: {1: 5.0, 2: 6.0, 3: 7.0, 4: 8.0, 5: 9.0, 6: 10.0, 7: 11.0}, + 3: {1: 3.0, 2: 3.5, 3: 4.5, 4: 5.5, 5: 6.0, 6: 6.5, 7: 7.0}, + 4: {1: 2.5, 2: 3.0, 3: 3.5, 4: 4.0, 5: 4.5, 6: 5.0, 7: 5.5}, } <<<<<<< HEAD +<<<<<<< HEAD <<<<<<< HEAD inc = {2: 3, 3: 1.5, 4: 1} steps = {2: 0.5, 3: 0.25, 4: 0.25} @@ -109,8 +120,12 @@ def get_cutoffs(structure: Structure): inc = {2: 2, 3: 1.5, 4: 0.5} steps = {2: 1, 3: 0.75, 4: 0.5} >>>>>>> c69d0316 (fixed cutoff) +======= + inc = {2: 2, 3: 1.5, 4: 0.6} + steps = {2: 1, 3: 0.75, 4: 0.6} +>>>>>>> b637d9a8 (update) - row = min([s.row for s in supercell_structure.species]) + row = int(np.around(np.array([s.row for s in supercell_structure.species]).mean(),0)) factor = row/4 >>>>>>> cc7520c5 (separate fitting) mins = { @@ -460,10 +475,10 @@ def get_structure_container( sc.add_structure(structure) else: # fit separately if param2 is None: # for harmonic fitting - if mean_displacements < 0.07: + if mean_displacements < 0.04: sc.add_structure(structure) else: # for anharmonic fitting - if mean_displacements >= 0.07: + if mean_displacements >= 0.04: sc.add_structure(structure) saved_structures.append(structure) if separate_fit and param2 is not None: # do after anharmonic fitting From 805071438b79cfe11ded0720588cb35d9e337efa Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 7 Jul 2021 21:44:17 -0700 Subject: [PATCH 127/207] disp_cut --- atomate/vasp/analysis/lattice_dynamics.py | 30 ++++++++++++++----- atomate/vasp/firetasks/lattice_dynamics.py | 5 ++++ atomate/vasp/fireworks/lattice_dynamics.py | 11 ++++--- .../vasp/workflows/base/lattice_dynamics.py | 6 ++++ 4 files changed, 41 insertions(+), 11 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index b815c1ec0..3ec64d673 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -155,6 +155,7 @@ def fit_force_constants( structures: List["Atoms"], all_cutoffs: List[List[float]], separate_fit: bool, + disp_cut: float = None, imaginary_tol: float = IMAGINARY_TOL, fit_method: str = FIT_METHOD, <<<<<<< HEAD @@ -184,6 +185,10 @@ def fit_force_constants( all_cutoffs: A nested list of cutoff values to trial. Each set of cutoffs contains the radii for different orders starting with second order. + separate_fit: Boolean to determine whether harmonic and anharmonic fitting + are to be done separately (True) or in one shot (False) + disp_cut: if separate_fit true, determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, in THz. max_n_imaginary: Maximum number of imaginary modes allowed in the @@ -220,6 +225,7 @@ def fit_force_constants( # "heat_capacity": [], "fit_method": fit_method, "separate_fit": separate_fit, + "disp_cut": disp_cut, "imaginary_tol": imaginary_tol, # "max_n_imaginary": max_n_imaginary, } @@ -250,8 +256,7 @@ def fit_force_constants( logger.info('CPU COUNT: {}'.format(os.cpu_count())) cutoff_results = Parallel(n_jobs=12, backend="multiprocessing")(delayed(_run_cutoffs)( i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, fit_method, - separate_fit, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) -# separate_fit, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) + separate_fit, disp_cut, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) logger.info('CUTOFF RESULTS \n {}'.format(cutoff_results)) @@ -287,6 +292,7 @@ def _run_cutoffs( supercell_matrix, fit_method, separate_fit, + disp_cut, imaginary_tol, fit_kwargs ) -> Dict: @@ -320,7 +326,8 @@ def _run_cutoffs( if separate_fit: logger.info('Fitting harmonic force constants separately') - sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=None) + sc = get_structure_container(cs, structures, separate_fit, disp_cut, + ncut=n2nd, param2=None) opt = Optimizer(sc.get_fit_data(), fit_method, [0,n2nd], @@ -334,7 +341,8 @@ def _run_cutoffs( param_harmonic = opt.parameters # harmonic force constant parameters logger.info('Fitting anharmonic force constants separately') - sc = get_structure_container(cs, structures, separate_fit, ncut=n2nd, param2=param_harmonic) + sc = get_structure_container(cs, structures, separate_fit, disp_cut, + ncut=n2nd, param2=param_harmonic) opt = Optimizer(sc.get_fit_data(), fit_method, [n2nd,nall], @@ -416,7 +424,8 @@ def get_structure_container( else: logger.info('Fitting all force constants in one shot') - sc = get_structure_container(cs, structures, separate_fit, ncut=None, param2=None) + sc = get_structure_container(cs, structures, separate_fit, disp_cut=None, + ncut=None, param2=None) opt = Optimizer(sc.get_fit_data(), fit_method, [0,nall], @@ -449,6 +458,7 @@ def get_structure_container( cs: ClusterSpace, structures: List["Atoms"], separate_fit: bool, + disp_cut: float, ncut: int, param2: np.ndarray >>>>>>> cc7520c5 (separate fitting) @@ -460,6 +470,12 @@ def get_structure_container( cutoffs: Cutoff radii for different orders starting with second order. structures: A list of ase atoms objects with the "forces" and "displacements" arrays included. + separate_fit: Boolean to determine whether harmonic and anharmonic fitting + are to be done separately (True) or in one shot (False) + disp_cut: if separate_fit true, determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + ncut: the parameter index where fitting separation occurs + param2: previously fit parameter array (harmonic only for now, hence 2) Returns: A hiPhive StructureContainer. @@ -475,10 +491,10 @@ def get_structure_container( sc.add_structure(structure) else: # fit separately if param2 is None: # for harmonic fitting - if mean_displacements < 0.04: + if mean_displacements < disp_cut: sc.add_structure(structure) else: # for anharmonic fitting - if mean_displacements >= 0.04: + if mean_displacements >= disp_cut: sc.add_structure(structure) saved_structures.append(structure) if separate_fit and param2 is not None: # do after anharmonic fitting diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 99822ca8e..900e1b710 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -131,6 +131,8 @@ class RunHiPhive(FiretaskBase): separate_fit: If True, harmonic and anharmonic force constants are fit separately and sequentially, harmonic first then anharmonic. If False, then they are all fit in one go. Default is False. + disp_cut: if separate_fit true, determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting imaginary_tol (float): Tolerance used to decide if a phonon mode is imaginary, in THz. fit_method (str): Method used for fitting force constants. This can be @@ -140,6 +142,7 @@ class RunHiPhive(FiretaskBase): optional_params = [ "cutoffs", "separate_fit", + "disp_cut", "bulk_modulus", "imaginary_tol", "fit_method", @@ -151,6 +154,7 @@ def run_task(self, fw_spec): imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) fit_method = self.get("fit_method", FIT_METHOD) separate_fit = self.get('separate_fit', False) + disp_cut = self.get('disp_cut',None) all_structures = loadfn("perturbed_structures.json") all_forces = loadfn("perturbed_forces.json") @@ -177,6 +181,7 @@ def run_task(self, fw_spec): structures, cutoffs, separate_fit, + disp_cut, imaginary_tol, fit_method ) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 44816a534..8f6c10bdd 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -38,10 +38,11 @@ class FitForceConstantsFW(Firework): db_file: Path to a db file. cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs will be generated based on the structure (default). - separate_fit: If True, harmonic and anharmonic force constants are fit - separately and sequentially, harmonic first then anharmonic. If - False, then they are all fit in one go. Default is False. - bulk_modulus: Must be supplied (in GPa) to copute thermal expansion + separate_fit: Boolean to determine whether harmonic and anharmonic fitting + are to be done separately (True) or in one shot (False) + disp_cut: if separate_fit true, determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + bulk_modulus: in GPa, necessary for thermal expansion imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, in THz. fit_method: Method used for fitting force constants. This can be @@ -59,6 +60,7 @@ def __init__( db_file: str = None, cutoffs: Optional[List[List[float]]] = None, separate_fit: bool = False, + disp_cut: float = None, bulk_modulus: float = None, imaginary_tol: float = IMAGINARY_TOL, fit_method: str = FIT_METHOD, @@ -70,6 +72,7 @@ def __init__( fit_force_constants = RunHiPhive( cutoffs=cutoffs, separate_fit=separate_fit, + disp_cut=disp_cut, bulk_modulus=bulk_modulus, imaginary_tol=imaginary_tol, fit_method=fit_method diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index eaff6de48..22fc3b336 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -57,6 +57,7 @@ def get_lattice_dynamics_wf( structure: Structure, separate_fit: bool = False, + disp_cut: float = None, bulk_modulus: float = None, common_settings: Dict = None, vasp_input_set: Optional[VaspInputSet] = None, @@ -98,6 +99,11 @@ def get_lattice_dynamics_wf( Args: structure: Initial structure. + separate_fit: Boolean to determine whether harmonic and anharmonic fitting + are to be done separately (True) or in one shot (False) + disp_cut: if separate_fit true, determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + bulk_modulus: bulk modulus in GPa, necessary for thermal expansion common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", and "user_incar_settings" keys. vasp_input_set: Vasp input set for perturbed structure calculations. From 01695f5a66fc3c0e0b8aa544bc3fc30df6585981 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 8 Jul 2021 00:23:42 -0700 Subject: [PATCH 128/207] disp_cut fix --- atomate/vasp/workflows/presets/core.py | 2 ++ 1 file changed, 2 insertions(+) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 524b049d2..56f95809a 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -851,6 +851,7 @@ def wf_nudged_elastic_band(structures, parent, c=None): def wf_lattice_dynamics( structure: Structure, separate_fit: bool = False, + disp_cut: float = None, bulk_modulus: float = None, c: Optional[dict] = None, supercell_matrix_kwargs: Optional[dict] = None, @@ -906,6 +907,7 @@ def wf_lattice_dynamics( wf_ld = get_lattice_dynamics_wf( structure, separate_fit = separate_fit, + disp_cut = disp_cut, bulk_modulus = bulk_modulus, common_settings=c, supercell_matrix_kwargs=supercell_matrix_kwargs, From 2fcbfcce9ae360f0de7fb7df81efcd34885c6a57 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 8 Jul 2021 16:15:12 -0700 Subject: [PATCH 129/207] disp_cut in FitForceConstantsFW --- atomate/vasp/firetasks/lattice_dynamics.py | 2 +- atomate/vasp/workflows/base/lattice_dynamics.py | 4 ++-- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 900e1b710..ca65a2378 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -154,7 +154,7 @@ def run_task(self, fw_spec): imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) fit_method = self.get("fit_method", FIT_METHOD) separate_fit = self.get('separate_fit', False) - disp_cut = self.get('disp_cut',None) + disp_cut = self.get('disp_cut', None) all_structures = loadfn("perturbed_structures.json") all_forces = loadfn("perturbed_forces.json") diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 22fc3b336..4ff7cb4d1 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -173,8 +173,8 @@ def get_lattice_dynamics_wf( # 2. Fit interatomic force constants from pertrubed structures allow_fizzled = {"_allow_fizzled_parents": True} fw_fit_force_constant = FitForceConstantsFW( - db_file=db_file, spec=allow_fizzled, - separate_fit=separate_fit, bulk_modulus=bulk_modulus + db_file=db_file, spec=allow_fizzled, separate_fit=separate_fit, + disp_cut=disp_cut, bulk_modulus=bulk_modulus ) wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) From a817a0072893667696c68472f18b9a035bdc6e03 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Thu, 27 Oct 2022 11:17:41 -0400 Subject: [PATCH 130/207] renormalization --- atomate/vasp/analysis/lattice_dynamics.py | 46 +- atomate/vasp/firetasks/lattice_dynamics.py | 396 ++++++++---------- atomate/vasp/fireworks/lattice_dynamics.py | 125 +++--- .../vasp/workflows/base/lattice_dynamics.py | 83 ++-- atomate/vasp/workflows/presets/core.py | 29 +- 5 files changed, 352 insertions(+), 327 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 3ec64d673..589f9cab6 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -22,12 +22,14 @@ from hiphive.fitting import Optimizer from hiphive.renormalization import Renormalization from hiphive.utilities import get_displacements +from hiphive.run_tools import FE_correction from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor >>>>>>> 8f4f7e37 (gruneisen and CTE) from pymatgen.io.phonopy import get_phonopy_structure +from ase.atoms import Atoms from ase.cell import Cell from phonopy import Phonopy @@ -39,13 +41,19 @@ logger = get_logger(__name__) +# Define some shared constants IMAGINARY_TOL = 0.025 # in THz +MESH_DENSITY = 100.0 # should always be a float -T_QHA = [i*100 for i in range(16)] -T_RENORM = [0,100,200,300,500,700,1000,1500]#[i*100 for i in range(0,16)] -T_KLAT = {"t_min":100,"t_max":1000,"t_step":100} #[i*100 for i in range(0,11)] +T_QHA = [i*100 for i in range(21)] +T_RENORM = [0,50,100,200,300,500,700,1000,1500]#[i*100 for i in range(0,16)] +T_KLAT = {"t_min":100,"t_max":1500,"t_step":100} #[i*100 for i in range(0,11)] -FIT_METHOD = "rfe" #"least-squares" +FIT_METHOD = "rfe" +RENORM_METHOD = 'pseudoinverse' +RENORM_NCONFIG = 50 +RENORM_CONV_THRESH = 0.1 # meV/atom +RENORM_MAX_ITER = 20 eV2J = 1.602e-19 hbar = sp.constants.hbar @@ -553,7 +561,7 @@ def harmonic_properties( free_energy *= 1000/sp.constants.Avogadro/eV2J/natom # kJ/mol to eV/atom entropy *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom Cv *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom - + freq = phonopy.mesh.frequencies # in THz # find imaginary modes at gamma # phonopy.run_qpoints([0, 0, 0]) @@ -739,25 +747,32 @@ def thermal_expansion( raise ValueError('Designated T does not exist in the temperature array!') -def renormalization( +def run_renormalization( structure: Structure, + supercell: Atoms, supercell_matrix: np.ndarray, cs: ClusterSpace, fcs: ForceConstants, param: np.ndarray, T: float, nconfig: int, + max_iter: int, conv_tresh: float, + renorm_method: str, + fit_method: str, bulk_modulus: float = None, + phonopy_orig: Phonopy = None, imaginary_tol: float = IMAGINARY_TOL, - fit_method: str = None ) -> Dict: """ Uses the force constants to extract phonon properties. Used for comparing the accuracy of force constant fits. Args: - structure: The parent structure. + structure: pymatgen Structure + The parent structure. + supercell : ase Atoms + Original supercell object supercell_matrix: The supercell transformation matrix. fcs: ForceConstants from previous fitting or renormalization imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, @@ -767,14 +782,14 @@ def renormalization( A tuple of the number of imaginary modes at Gamma, the minimum phonon frequency at Gamma, and the free energy, entropy, and heat capacity """ - renorm = Renormalization(cs,fcs,param,T,fit_method) - fcp, fcs, param = renorm.renormalize(nconfig,'pseudoinverse',conv_tresh) + renorm = Renormalization(cs,supercell,fcs,param,T,renorm_method,fit_method) + fcp, fcs, param = renorm.renormalize(nconfig,conv_tresh) renorm_data, phonopy = harmonic_properties( structure, supercell_matrix, fcs, [T], imaginary_tol ) - if renorm_data["n_imaginary"] ==0: + if renorm_data["n_imaginary"] == 0: logger.info('Renormalized phonon is completely real at T = {} K!'.format(T)) anharmonic_data, phonopy = anharmonic_properties( phonopy, fcs, [T], thermal_data["heat_capacity"], n_imaginary, bulk_modulus=bulk_modulus @@ -783,7 +798,14 @@ def renormalization( anharmonic_data = dict() anharmonic_data["gruneisen"] = np.array([[0,0,0]]) anharmonic_data["thermal_expansion"] = np.array([[0,0,0]]) + + omega0 = phonopy_orig.mesh.frequencies # THz + omega_TD = phonopy.mesh.frequencies # THz + natom = phonopy.primitive.get_number_of_atoms() + correction = FE_correction(omega0,omega_TD,T)/natom # eV/atom + renorm_data.update(anharmonic_data) + renorm_data["free_energy_correction"] = correction renorm_data["fcp"] = fcp renorm_data["fcs"] = fcs renorm_data["param"] = param @@ -792,7 +814,7 @@ def renormalization( -def setup_TE_renorm(parent_structure,temperatures,dLfracs): +def setup_TE_iter(cutoffs,parent_structure,temperatures,dLfracs): parent_structure_TE = [] cs_TE = [] fcs_TE = [] diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index ca65a2378..53d87fb2c 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -7,25 +7,26 @@ import numpy as np from joblib import Parallel, delayed +from copy import copy, deepcopy from monty.dev import requires from monty.serialization import dumpfn, loadfn from monty.json import jsanitize from pymongo import ReturnDocument +import phonopy as phpy + from atomate.utils.utils import env_chk, get_logger from atomate.vasp.database import VaspCalcDb from atomate.vasp.drones import VaspDrone from atomate.vasp.analysis.lattice_dynamics import ( - FIT_METHOD, - IMAGINARY_TOL, T_QHA, - T_RENORM, T_KLAT, fit_force_constants, harmonic_properties, anharmonic_properties, - renormalization, + run_renormalization, + setup_TE_iter, get_cutoffs ) @@ -54,9 +55,6 @@ logger = get_logger(__name__) -# define shared constants -MESH_DENSITY = 100.0 # should always be a float - @explicit_serialize class CollectPerturbedStructures(FiretaskBase): @@ -131,12 +129,12 @@ class RunHiPhive(FiretaskBase): separate_fit: If True, harmonic and anharmonic force constants are fit separately and sequentially, harmonic first then anharmonic. If False, then they are all fit in one go. Default is False. - disp_cut: if separate_fit true, determines the mean displacement of perturbed + disp_cut: if separate_fit=True, determines the mean displacement of perturbed structure to be included in harmonic (<) or anharmonic (>) fitting imaginary_tol (float): Tolerance used to decide if a phonon mode is imaginary, in THz. - fit_method (str): Method used for fitting force constants. This can be - any of the values allowed by the hiphive ``Optimizer`` class. + fit_method (str): Method used for fitting force constants. This can + be any of the values allowed by the hiphive ``Optimizer`` class. """ optional_params = [ @@ -151,19 +149,21 @@ class RunHiPhive(FiretaskBase): @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): - imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) - fit_method = self.get("fit_method", FIT_METHOD) separate_fit = self.get('separate_fit', False) disp_cut = self.get('disp_cut', None) - + cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) + T_qha = np.array(self.get("T_qha")) + T_qha.sort() + imaginary_tol = self.get("imaginary_tol") + bulk_modulus = self.get("bulk_modulus") + fit_method = self.get("fit_method") + all_structures = loadfn("perturbed_structures.json") all_forces = loadfn("perturbed_forces.json") structure_data = loadfn("structure_data.json") parent_structure = structure_data["structure"] supercell_structure = structure_data["supercell_structure"] supercell_matrix = np.array(structure_data["supercell_matrix"]) - cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) - bulk_modulus = self.get("bulk_modulus") structures = [] supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) @@ -200,10 +200,11 @@ def run_task(self, fw_spec): thermal_data["n_imaginary"], bulk_modulus ) + phonopy.save("phonopy_params.yaml") fitting_data["n_imaginary"] = thermal_data.pop("n_imaginary") thermal_data.update(anharmonic_data) dumpfn(fitting_data, "fitting_data.json") - dumpfn(thermal_data, "thermal_data_qha.json") + dumpfn(thermal_data, "thermal_data.json") logger.info("Writing cluster space and force_constants") logger.info("{}".format(type(fcs))) @@ -217,7 +218,8 @@ def run_task(self, fw_spec): fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms, order=3) fcs.write_to_phonopy("FORCE_CONSTANTS_2ND", format="text") else: - logger.info("ShengBTE files not written due to imaginary modes. You may want to perform phonon renormalization.") + logger.info("ShengBTE files not written due to imaginary modes.") + logger.info("You may want to perform phonon renormalization.") @@ -228,102 +230,114 @@ class RunHiPhiveRenorm(FiretaskBase): using hiPhive. Requires "structure_data.json" to be present in the current working directory. - cs,supercell,fcs,param,T, - Required parameters: - cs (hiphive.ClusterSpace): A list of cutoffs to trial. If None, - a set of trial cutoffs will be generated based on the structure - (default). - fcs (hiphive.ForceConstants): Maximum number of imaginary modes allowed in the - the final fitted force constant solution. If this criteria is not - reached by any cutoff combination this FireTask will fizzle. - param (np.ndarray): array of force constant parameters - cutoffs (np.ndarray): cutoffs used for best fitting Optional parameter: - T_renorm (List): list of temperatures to perform renormalization - default is T_RENORM - bulk_modulus (float): manually input bulk modulus - necessary for thermal expansion - renorm_with_te (bool): if True, + renorm_temp (List): list of temperatures to perform renormalization - defaults to T_RENORM + renorm_with_te (bool): if True, perform outer iteration over thermally expanded volumes + bulk_modulus (float): input bulk modulus - required for thermal expansion iterations """ - required_params = ["cs","fcs","param","cutoff"] - optional_params = ["T_renorm","bulk_modulus","renorm_with_te","fit_method"] + optional_params = ["renorm_method","renorm_temp","nconfig","conv_thresh","max_iter", + "renorm_TE_iter","bulk_modulus","imaginary_tol"] @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): - imaginary_tol = self.get("imaginary_tol", IMAGINARY_TOL) - fit_method = self.get("fit_method", FIT_METHOD) - + cs = ClusterSpace.read('cluster_space.cs') + fcs = ForceConstants.read('force_constants.fcs') + param = np.loadtxt('parameters.txt') + fitting_data = loadfn("fitting_data.json") structure_data = loadfn("structure_data.json") + phonopy_orig = phpy.load("phonopy_params.yaml") + + cutoffs = fitting_data["cutoffs"] + fit_method = fitting_data["fit_method"] + imaginary_tol = fitting_data["imaginary_tol"] + parent_structure = structure_data["structure"] supercell_structure = structure_data["supercell_structure"] supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) supercell_matrix = np.array(structure_data["supercell_matrix"]) - cs = self.get("cs") - fcs = self.get("fcs") - param = self.get("param") + renorm_temp = np.array(self.get("renorm_temp")) + renorm_temp.sort() + renorm_method = self.get("renorm_method") + nconfig = self.get("nconfig") + conv_thresh = self.get("conv_thresh") + max_iter = self.get("max_iter") + renorm_TE_iter = self.get("renorm_TE_iter") bulk_modulus = self.get("bulk_modulus") - T_renorm = self.get("T_renorm", T_RENORM) - - renorm_results = Parallel(n_jobs=4, backend="multiprocessing")(delayed(renormalization)( - parent_structure, supercell_matrix, cs, fcs, param, T, nconfig, conv_thresh, imaginary_tol - ) for t, T in enumerate(T_renorm)) - - T_real = [] - cte_real = [] - fcs_real = [] - param_real = [] - for result in renorm_results: - if result is None: - continue - elif result["n_imaginary"] > 0 or bulk_modulus is None: - fcs = result["fcs"][0] - fcs.write("force_constants_{}K.fcs".format(T)) - np.savetxt('parameters_{}K.txt'.format(T),result["param"][0]) - else: - T_real = T_real + result["temperature"] - cte_real = cte_real + result["thermal_expansion"] - fcs_real = fcs_real + result["fcs"] - param_real = param_real + result["param"] - if len(T_real)==0: - pass - elif len(T_real)==1 and T_real[0]==0: - fcs = result["fcs"][0] - fcs.write("force_constants_{}K.fcs".format(T)) - np.savetxt('parameters_{}K.txt'.format(T),result["param"][0]) - else: - ind = np.argsort(np.array(T_real)) - T_real = list(np.array(T_real)[ind]) - cte_real = list(np.array(cte_real)[ind]) - dLfrac_real = thermal_expansion(T_real,cte_real) - parent_structure_TE, cs_TE, fcs_TE = setup_TE_renorm(parent_structure,T_real,dLfrac_real) - renorm_results = Parallel(n_jobs=2, backend="multiprocessing")(delayed(renormalization)( - parent_structure_TE[t], supercell_matrix, cs_TE[t], fcs_TE[t], param, T, nconfig, conv_thresh, imaginary_tol - ) for t, T in enumerate(T_real)) - - logger.info("Writing renormalized results") - thermal_keys = ["temperature","free_energy","entropy","heat_capacity", - "gruneisen","thermal_expansion","expansion_ratio"] - thermal_data = {key: [] for key in thermal_keys} - for t, result in enumerate(renorm_results): - T = result["temperature"][0] - fcs = result["fcs"][0] - fcs.write("force_constants_{}K.fcs".format(T)) - np.savetxt('parameters_{}K.txt'.format(T),result["param"][0]) - for key in thermal_keys: - thermal_data[key].append(result[key][0]) - if result["n_imaginary"] > 0: - logger.warning('Imaginary modes generated for {} K!'.format(T)) - logger.warning('Renormalization with thermal expansion may have failed') - logger.warning('ShengBTE files not written') + + # First renormalization with DFT lattice + renorm_data = Parallel(n_jobs=4, backend="multiprocessing")(delayed(run_renormalization)( + parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, max_iter, + conv_thresh, bulk_modulus, phonopy_orig) for t, T in enumerate(renorm_temp)) + + # Additional renormalization with thermal expansion - optional - just single "iteration" for now + if renorm_TE_iter: + n_TE_iter = 1 + for i in range(n_TE_iter): + logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) + + if i==0: # first iteration - pull only cases where phonon is all real and order by temperature + T_real = [] + dLfrac_real = [] + param_real = [] + for result in renorm_data: + if result is None: # failed or incomplete + continue + elif result["n_imaginary"] < 0: # still imaginary + continue + else: + T_real = T_real + result["temperature"] + dLfrac_real = dLfrac_real + result["expansion_ratio"] + param_real = param_real + result["param"] + if len(T_real)==0: + logger.info("No cases with real phonons - cannot do thermal expansion for any temperature") + break else: - logger.info("No imaginary modes! Writing ShengBTE files") - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(T), format="text") + for t,result in enumerate(renorm_data): + dLfrac_real[t] = result["expansion_ratio"] + param_real[t] = result["param"] + + parent_structure_TE, cs_TE, fcs_TE = setup_TE_iter(cutoffs,parent_structure,T_real,dLfrac_real) + param_TE = copy(param_real) + + renorm_data = Parallel(n_jobs=4, backend="multiprocessing")(delayed(run_renormalization)( + parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, cs_TE[t], fcs_TE[t], param_TE[t], + T, nconfig, max_iter, conv_thresh, bulk_modulus + ) for t, T in enumerate(T_real) + ) + + if len(T_real) > 0: + for t, result in enumerate(renorm_data): + temp_index = np.where(renorm_temp==T_real[t])[0][0] + renorm_data[temp_index] = result + + # write results + logger.info("Writing renormalized results") + thermal_keys = ["temperature","free_energy","entropy","heat_capacity", + "gruneisen","thermal_expansion","expansion_ratio","free_energy_correction"] + renorm_thermal_data = {key: [] for key in thermal_keys} + for t, result in enumerate(renorm_data): + logger.info("DEBUG: ",result) + T = result["temperature"] + fcs = result["fcs"] + fcs.write("force_constants_{}K.fcs".format(T)) + np.savetxt('parameters_{}K.txt'.format(T),result["param"]) + for key in thermal_keys: + renorm_thermal_data[key].append(result[key]) + if result["n_imaginary"] > 0: + logger.warning('Imaginary modes exist for {} K!'.format(T)) + logger.warning('ShengBTE files not written') + logger.warning('No renormalization with thermal expansion') + else: + logger.info("No imaginary modes! Writing ShengBTE files") + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(T), format="text") - thermal_data.pop("n_imaginary") - dumpfn(thermal_data, "thermal_data_renorm.json") + renorm_thermal_data.pop("n_imaginary") + dumpfn(thermal_data, "renorm_thermal_data.json") @explicit_serialize @@ -359,138 +373,89 @@ def run_task(self, fw_spec): db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) renormalized = self.get("renormalized", False) - mesh_density = self.get("mesh_density", MESH_DENSITY) + mesh_density = self.get("mesh_density", 100.0) structure_data = loadfn("structure_data.json") forces = loadfn("perturbed_forces.json") structures = loadfn("perturbed_structures.json") - - structure = structure_data["structure"] - supercell_structure = structure_data["supercell_structure"] - supercell_matrix = structure_data["supercell_matrix"] - - fitting_data = loadfn("fitting_data.json") - thermal_data = loadfn("thermal_data_qha.json") - fcs = ForceConstants.read("force_constants.fcs") - - dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( - structure, supercell_matrix, fcs, mesh_density, mmdb - ) - - data = { - "created_at": datetime.utcnow(), - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, - "structure": structure.as_dict(), - "supercell_matrix": supercell_matrix, - "supercell_structure": supercell_structure.as_dict(), - "perturbed_structures": [s.as_dict() for s in structures], - "perturbed_forces": [f.tolist() for f in forces], - "fitting_data": fitting_data, - "thermal_data": thermal_data, - "force_constants_fs_id": fc_fsid, - "phonon_dos_fs_id": dos_fsid, - "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, - "phonon_bandstructure_line_fs_id": lm_bs_fsid, - } - data.update(self.get("additional_fields", {})) - - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} - data.update(metadata) - data = jsanitize(data,strict=True,allow_bson=True) - mmdb.db.lattice_dynamics.insert_one(data) - - logger.info("Finished inserting force constants") - - return FWAction(update_spec=metadata) - - - -class ForceConstantsRenormToDb(FiretaskBase): - """ - Add force constants, phonon band structure and density of states - to the database. - - Assumes you are in a directory with the force constants, fitting - data, and structure data written to files. - - Required parameters: - db_file (str): Path to DB file for the database that contains the - perturbed structure calculations. - Optional parameters: - renormalized (bool): Whether FC resulted from original fitting (False) - or renormalization process (True) determines how data are stored. - Default is False. mesh_density (float): The density of the q-point mesh used to calculate - the phonon density of states. See the docstring for the ``mesh`` - argument in Phonopy.init_mesh() for more details. - additional_fields (dict): Additional fields added to the document, such - as user-defined tags, name, ids, etc. """ - - required_params = ["db_file"] - optional_params = ["renormalized","mesh_density", "additional_fields"] - - @requires(hiphive, "hiphive is required for lattice dynamics workflow") - def run_task(self, fw_spec): - - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - renormalized = self.get("renormalized", False) - mesh_density = self.get("mesh_density", MESH_DENSITY) - - structure_data = loadfn("structure_data.json") - forces = loadfn("perturbed_forces.json") - structures = loadfn("perturbed_structures.json") - structure = structure_data["structure"] supercell_structure = structure_data["supercell_structure"] supercell_matrix = structure_data["supercell_matrix"] - thermal_data = loadfn("thermal_data_renorm.json") - temperature = thermal_data["temperature"] - - data = { - "created_at": datetime.utcnow(), - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, - "structure": structure.as_dict(), - "thermal_data": thermal_data, - } - - temperature_to_keep = [] - renormalized_data = [] - for t, T in enumerate(temperature): - ## err should I collect results for all T and push data at once, - ## or push data for each T individually? - fcs = ForceConstants.read("force_constants_{}K.fcs") - phonopy_fc = fcs.get_fc_array(order=2) - dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( - structure, supercell_matrix, phonopy_fc, mesh_density, mmdb - ) + if not renormalized: + + fitting_data = loadfn("fitting_data.json") + thermal_data = loadfn("thermal_data.json") + fcs = ForceConstants.read("force_constants.fcs") - data_at_T = { + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, fcs, mesh_density, mmdb + ) + + data = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix, + "supercell_structure": supercell_structure.as_dict(), + "perturbed_structures": [s.as_dict() for s in structures], + "perturbed_forces": [f.tolist() for f in forces], + "fitting_data": fitting_data, + "thermal_data": thermal_data, "force_constants_fs_id": fc_fsid, "phonon_dos_fs_id": dos_fsid, "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, "phonon_bandstructure_line_fs_id": lm_bs_fsid, - } - temperature_to_keep.append(T) - renormalized_data.append(data_at_T) - data["temperatures"] = temperature_to_keep - data["renormalized_data"] = renormalized_data - data.update(self.get("additional_fields", {})) + } + data.update(self.get("additional_fields", {})) + + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + data.update(metadata) + data = jsanitize(data,strict=True,allow_bson=True) + + mmdb.db.lattice_dynamics.insert_one(data) + + logger.info("Finished inserting force constants and phonon data") - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} - data.update(metadata) - data = jsanitize(data,strict=True,allow_bson=True) + else: + renorm_thermal_data = loadfn("renorm_thermal_data.json") + temperature = renorm_thermal_data["temperature"] + + # pushing data for individual temperature + for t, T in enumerate(temperature): + fcs = ForceConstants.read("force_constants_{}K.fcs".format(T)) + phonopy_fc = fcs.get_fc_array(order=2) + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, phonopy_fc, mesh_density, mmdb + ) + + data_at_T = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "renormalized": renormalized, + "temperature": T, + "force_constants_fs_id": fc_fsid, + "thermal_data": renorm_thermal_data[t], + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + } + data_at_T.update(self.get("additional_fields", {})) + + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + data_at_T.update(metadata) + data_at_T = jsanitize(data,strict=True,allow_bson=True) - mmdb.db.renormalized_lattice_dynamics.insert_one(data) + mmdb.db.renormalized_lattice_dynamics.insert_one(data_at_T) - logger.info("Finished inserting renormalized force constants") + logger.info("Finished inserting renormalized force constants and phonon data at {} K".format(T)) return FWAction(update_spec=metadata) @@ -533,17 +498,6 @@ def run_task(self, fw_spec): else: if isinstance(temperature, (int, float)): self["t"] = temperature - elif isinstance(temperature, (list, np.ndarray)): - t_max = np.max(np.array(temperature)) - t_min = np.min(np.array(temperature)) - if t_min==0: - t_min = np.partition(temperature,1)[1] - t_step = (t_max-t_min)/(len(temperature)-2) - else: - t_step = (t_max-t_min)/(len(temperature)-1) - self["t_min"] = t_min - self["t_max"] = t_max - self["t_step"] = t_step elif isinstance(temperature, dict): self["t_min"] = temperature["t_min"] self["t_max"] = temperature["t_max"] diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 8f6c10bdd..fe9648232 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -1,17 +1,11 @@ -from typing import List, Optional, Union +from typing import List, Optional, Union, Dict from atomate.common.firetasks.glue_tasks import ( CopyFiles, CopyFilesFromCalcLoc, PassCalcLocs, ) -from atomate.vasp.analysis.lattice_dynamics import ( - FIT_METHOD, - IMAGINARY_TOL, - T_QHA, - T_RENORM, - T_KLAT -) + from atomate.vasp.config import SHENGBTE_CMD from atomate.vasp.firetasks.lattice_dynamics import ( CollectPerturbedStructures, @@ -19,10 +13,13 @@ RunHiPhive, RunHiPhiveRenorm, RunShengBTE, - ShengBTEToDb, - MESH_DENSITY) + ShengBTEToDb + ) + from fireworks import Firework +from hiphive import ClusterSpace, ForceConstants + __author__ = "Alex Ganose, Junsoo Park" __email__ = "aganose@lbl.gov, jsyony37@lbl.gov" @@ -55,16 +52,16 @@ class FitForceConstantsFW(Firework): def __init__( self, + fit_method: str, + separate_fit: bool, + disp_cut: float, + bulk_modulus: float, + imaginary_tol: float, + mesh_density: float, + cutoffs: Optional[List[List[float]]] = None, name="Fit Force Constants", parents: Optional[Union[Firework, List[Firework]]] = None, db_file: str = None, - cutoffs: Optional[List[List[float]]] = None, - separate_fit: bool = False, - disp_cut: float = None, - bulk_modulus: float = None, - imaginary_tol: float = IMAGINARY_TOL, - fit_method: str = FIT_METHOD, - mesh_density: float = MESH_DENSITY, **kwargs ): collect_structures = CollectPerturbedStructures() @@ -72,10 +69,10 @@ def __init__( fit_force_constants = RunHiPhive( cutoffs=cutoffs, separate_fit=separate_fit, + fit_method=fit_method, disp_cut=disp_cut, bulk_modulus=bulk_modulus, imaginary_tol=imaginary_tol, - fit_method=fit_method ) to_db = ForceConstantsToDb( db_file=db_file, renormalized=False, mesh_density=mesh_density, additional_fields={} @@ -110,40 +107,38 @@ class LatticeThermalConductivityFW(Firework): def __init__( self, + shengbte_cmd: str, + temperature: Union[float, dict], + renormalized: bool, name="Lattice Thermal Conductivity", prev_calc_dir: Optional[str] = None, db_file: str = None, - shengbte_cmd: str = SHENGBTE_CMD, - renormalized: bool = False, - temperature: Union[float, dict] = T_KLAT, shengbte_control_kwargs: Optional[dict] = None, **kwargs - ): + ): + # files needed to run ShengBTE if renormalized: # must check if FORCE_CONSTANTS_2ND_{T}K can be copied individually + assert type(temperature) in [float,int] files = [ "structure_data.json", "FORCE_CONSTANTS_2ND_{}K".format(temperature), "FORCE_CONSTANTS_3RD" ] +# temperature_copy = temperature[:] +# for t,T in enumerate(temperature_copy): +# try: +# files = files.append("FORCE_CONSTANTS_2ND_{}K".format(T)) +# except: +# logger.info("FORCE_CONSTANTS_2ND_{}K is missing".format(T)) +# logger.info("Renormalization must have failed at {} K".format(T)) +# logger.info("Cannot calculate thermal conductivity at {} K".format(T)) +# temperature.remove(T) if prev_calc_dir: - try: - copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) - except: - raise IOError("FORCE_CONSTANTS_2ND_{}K not found! Abandoning ShengBTE run." - .format(temperature)) + copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: - try: - copy_files = CopyFilesFromCalcLoc(calc_loc=True, files_to_copy=files) - except: - raise IOError("FORCE_CONSTANTS_2ND_{}K not found! Abandoning ShengBTE run." - .format(temperature)) - run_shengbte = RunShengBTE( - shengbte_cmd=shengbte_cmd, - renormalized=renormalized, - temperature=temperature, - control_kwargs=shengbte_control_kwargs, - ) + copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + else: # only the default files are needed files = [ "structure_data.json", @@ -151,20 +146,24 @@ def __init__( "FORCE_CONSTANTS_3RD", ] if prev_calc_dir: - copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) + copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) - run_shengbte = RunShengBTE( - shengbte_cmd=shengbte_cmd, - renormalized=renormalized, - temperature=temperature, - control_kwargs=shengbte_control_kwargs, + + run_shengbte = RunShengBTE( + shengbte_cmd=shengbte_cmd, + renormalized=renormalized, + temperature=temperature, + control_kwargs=shengbte_control_kwargs, ) shengbte_to_db = ShengBTEToDb(db_file=db_file, additional_fields={}) tasks = [copy_files, run_shengbte, shengbte_to_db] - super().__init__(tasks, name=name, **kwargs) + if renormalized: + super().__init__(tasks, name=name+' at {}K'.format(temperature), **kwargs) + else: + super().__init__(tasks, name=name, **kwargs) @@ -189,31 +188,39 @@ class RenormalizationFW(Firework): def __init__( self, - temperature: Union[float, list], + temperature: Union[float, Dict], + renorm_method: str, + renorm_nconfig: int, + renorm_conv_thresh: float, + renorm_max_iter: float, + renorm_TE_iter: bool, + bulk_modulus: float, + mesh_density: float, name="Renormalization", prev_calc_dir: Optional[str] = None, db_file: str = None, **kwargs - ): - + ): + # files needed to run renormalization - files = ["cluster_space.cs","parameters.txt","force_constants.fcs"] + files = ["cluster_space.cs","parameters.txt","force_constants.fcs", + "structure_data.json","fitting_data.json","phonopy_params.yaml"] if prev_calc_dir: - copy_files = CopyFiles(from_dir=prev_calc_dir, files_to_copy=files) + copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) - cs = ClusterSpace.read('cluster_space.cs') - fcs = ForceConstants.read('force_constants.fcs') - param = np.loadtxt('parameters.txt') - renorm_force_constants = RunHiPhiveRenorm( - cs=cs, - param=param, - fcs=fcs, - T_renorm=T_renorm - ) + renorm_temp=temperature, + renorm_method=renorm_method, + nconfig=renorm_nconfig, + conv_thresh=renorm_conv_thresh, + max_iter=renorm_max_iter, + renorm_TE_iter=renorm_TE_iter, + bulk_modulus=bulk_modulus, + **kwargs + ) to_db = ForceConstantsToDb( db_file=db_file, renormalized=True, mesh_density=mesh_density, additional_fields={} diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 4ff7cb4d1..535d5f5be 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -9,11 +9,23 @@ from atomate.utils.utils import get_logger from atomate.vasp.config import DB_FILE, SHENGBTE_CMD, VASP_CMD from atomate.vasp.firetasks import pass_vasp_result -from atomate.vasp.firetasks.lattice_dynamics import T_KLAT, T_RENORM +from atomate.vasp.analysis.lattice_dynamics import ( + FIT_METHOD, + MESH_DENSITY, + IMAGINARY_TOL, + T_QHA, + T_KLAT, + T_RENORM, + RENORM_METHOD, + RENORM_NCONFIG, + RENORM_MAX_ITER, + RENORM_CONV_THRESH, +) from atomate.vasp.fireworks.core import TransmuterFW, OptimizeFW from atomate.vasp.fireworks.lattice_dynamics import ( FitForceConstantsFW, LatticeThermalConductivityFW, + RenormalizationFW, ) from atomate.vasp.powerups import add_additional_fields_to_taskdocs from fireworks import Workflow @@ -37,6 +49,7 @@ "ENCUT": 600, "ISMEAR": 0, "SIGMA": 0.1, + "ISPIN": 2, "EDIFF": 1e-7, "LAECHG": False, "LREAL": False, @@ -56,6 +69,7 @@ def get_lattice_dynamics_wf( structure: Structure, + fit_method:str = FIT_METHOD, separate_fit: bool = False, disp_cut: float = None, bulk_modulus: float = None, @@ -65,10 +79,16 @@ def get_lattice_dynamics_wf( supercell_matrix_kwargs: Optional[dict] = None, num_supercell_kwargs: Optional[dict] = None, perturbed_structure_kwargs: Optional[dict] = None, - calculate_lattice_thermal_conductivity: bool = False, + calculate_lattice_thermal_conductivity: bool = True, thermal_conductivity_temperature: Union[float, Dict] = T_KLAT, renormalize: bool = False, - renormalization_temperature: Union[float, List, Dict] = T_RENORM, + renormalize_temperature: Union[float, List, Dict] = T_RENORM, + renormalize_method: str = RENORM_METHOD, + renormalize_nconfig: int = RENORM_NCONFIG, + renormalize_conv_thresh: float = RENORM_CONV_THRESH, + renormalize_max_iter: int = RENORM_MAX_ITER, + renormalize_thermal_expansion_iter: bool = False, + mesh_density: float = MESH_DENSITY, shengbte_cmd: str = SHENGBTE_CMD, shengbte_fworker: Optional[str] = None, ): @@ -128,7 +148,7 @@ def get_lattice_dynamics_wf( thermal_conductivity_temperature: The temperature at which to calculate lattice thermal conductivity for. Can be given as a single float, or a dictionary with the keys "min", "max", "step". - renormalization_temperature: The temperature at which to perform phonon + renormalize_temperature: The temperature at which to perform phonon renormalization. Can be given as a single float, list, or a dictionary with the keys "min", "max", "step". shengbte_cmd: Command to run ShengBTE. Supports env_chk. @@ -143,12 +163,12 @@ def get_lattice_dynamics_wf( db_file = common_settings["DB_FILE"] - if calculate_lattice_thermal_conductivity: + if calculate_lattice_thermal_conductivity or renormalize: if supercell_matrix_kwargs.get("force_diagonal", False): warnings.warn( "Diagonal transformation required to calculate lattice thermal " "conductivity using ShengBTE. Forcing diagonal matrix." - ) + ) supercell_matrix_kwargs["force_diagonal"] = True st = CubicSupercellTransformation(**supercell_matrix_kwargs) @@ -168,58 +188,69 @@ def get_lattice_dynamics_wf( copy_vasp_outputs=copy_vasp_outputs, pass_forces=True, **perturbed_structure_kwargs, - ) + ) # 2. Fit interatomic force constants from pertrubed structures allow_fizzled = {"_allow_fizzled_parents": True} fw_fit_force_constant = FitForceConstantsFW( - db_file=db_file, spec=allow_fizzled, separate_fit=separate_fit, - disp_cut=disp_cut, bulk_modulus=bulk_modulus - ) + db_file=db_file, + spec=allow_fizzled, + separate_fit=separate_fit, + fit_method=fit_method, + disp_cut=disp_cut, + bulk_modulus=bulk_modulus, + mesh_density=mesh_density, + imaginary_tol=IMAGINARY_TOL, + ) wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) - # 3. RenormalizeFW (pass_inputs like bulk modulus) + # 3. Renormalization FW (pass_inputs like bulk modulus) if renormalize: fw_renormalization = RenormalizationFW( - temperature=renormalization_temperature, db_file=db_file, - ) + temperature=renormalize_temperature, + renorm_method=renormalize_method, + renorm_nconfig=renormalize_nconfig, + renorm_conv_thresh=renormalize_conv_thresh, + renorm_max_iter=renormalize_max_iter, + renorm_TE_iter=renormalize_thermal_expansion_iter, + bulk_modulus=bulk_modulus, + mesh_density=mesh_density, + ) wf.append_wf( Workflow.from_Firework(fw_renormalization), [wf.fws[-1].fw_id] - ) + ) # 4. Lattice thermal conductivity calculation if calculate_lattice_thermal_conductivity: if renormalize: # Because of the way ShengBTE works, a temperature array that is not # equally spaced out (T_step) requires submission for each temperature - fw_lattice_conductivity = [] - for T in renormalization_temperature: - fw = LatticeThermalConductivityFW( + for T in renormalize_temperature: + fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, shengbte_cmd=shengbte_cmd, renormalized=True, temperature=T - ) + ) if shengbte_fworker: - fw.spec["_fworker"] = shengbte_fworker - fw_lattice_conductivity.append(fw) - wf.append_wf( - Workflow.from_Firework(fw_lattice_conductivity), wf.leaf_fw_ids - ) + fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker + wf.append_wf( + Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-1].fw_id] + ) else: fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, shengbte_cmd=shengbte_cmd, renormalized=False, temperature=thermal_conductivity_temperature, - ) + ) if shengbte_fworker: fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker wf.append_wf( Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-1].fw_id] - ) - + ) + formula = structure.composition.reduced_formula wf.name = "{} - lattice dynamics".format(formula) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 56f95809a..2b5aa70b8 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -851,6 +851,7 @@ def wf_nudged_elastic_band(structures, parent, c=None): def wf_lattice_dynamics( structure: Structure, separate_fit: bool = False, + fit_method: str = False, disp_cut: float = None, bulk_modulus: float = None, c: Optional[dict] = None, @@ -859,7 +860,8 @@ def wf_lattice_dynamics( calculate_lattice_thermal_conductivity=True, thermal_conductivity_temperature=None, renormalize=False, - renormalization_temperature=None, + renormalize_temperature=None, + renormalize_thermal_expansion_iter=False, **ld_kwargs ) -> Workflow: """ @@ -877,18 +879,22 @@ def wf_lattice_dynamics( Returns: A workflow to calculate lattice thermal conductivity. """ + + # start with defining the relaxation workflow optimize_uis = { "LAECHG": False, 'ENCUT': 600, 'ADDGRID': True, + 'EDIFF': 1e-8, 'EDIFFG': -5e-4, 'PREC': 'Accurate', "LREAL": False, - 'EDIFF': 1e-8, - "ISMEAR": 0, - "SIGMA": 0.1, + 'LASPH': True, + 'ISPIN': 2, + 'ISMEAR': 0, + 'SIGMA': 0.1, 'LCHARG': False, - 'LASPH': True + 'LWAVE': False } c = c if c is not None else {} if "USER_INCAR_SETTINGS" not in c: @@ -904,21 +910,26 @@ def wf_lattice_dynamics( if "VaspToDb" in str(task): task.update(vasp_to_db_params) + # define lattice dynamics workflow wf_ld = get_lattice_dynamics_wf( structure, - separate_fit = separate_fit, - disp_cut = disp_cut, - bulk_modulus = bulk_modulus, + fit_method=fit_method, + separate_fit=separate_fit, + disp_cut=disp_cut, + bulk_modulus=bulk_modulus, common_settings=c, supercell_matrix_kwargs=supercell_matrix_kwargs, num_supercell_kwargs=num_supercell_kwargs, calculate_lattice_thermal_conductivity=calculate_lattice_thermal_conductivity, thermal_conductivity_temperature=thermal_conductivity_temperature, renormalize=renormalize, - renormalization_temperature=renormalization_temperature, + renormalize_temperature=renormalize_temperature, + renormalize_thermal_expansion_iter=bool(renormalize_thermal_expansion_iter and bulk_modulus), copy_vasp_outputs=True, **ld_kwargs ) + + # join the workflows wf.append_wf(wf_ld, wf.leaf_fw_ids) formula = structure.composition.reduced_formula From f2c5dc2e6310858f5b70397150355107dc61d79d Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Tue, 1 Nov 2022 10:17:27 -0400 Subject: [PATCH 131/207] any changes? --- atomate/vasp/analysis/lattice_dynamics.py | 8 ++++++-- 1 file changed, 6 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 589f9cab6..dfb226973 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -45,8 +45,12 @@ IMAGINARY_TOL = 0.025 # in THz MESH_DENSITY = 100.0 # should always be a float +# Temperature for straight-up phonopy calculation of thermodynamic properties (free energy etc.) T_QHA = [i*100 for i in range(21)] +# Temperature at which renormalization is to be performed T_RENORM = [0,50,100,200,300,500,700,1000,1500]#[i*100 for i in range(0,16)] +# Temperature at which lattice thermal conductivity is calculated +# If renormalization is performed, T_RENORM overrides T_KLAT for lattice thermal conductivity T_KLAT = {"t_min":100,"t_max":1500,"t_step":100} #[i*100 for i in range(0,11)] FIT_METHOD = "rfe" @@ -56,8 +60,8 @@ RENORM_MAX_ITER = 20 eV2J = 1.602e-19 -hbar = sp.constants.hbar -kB = sp.constants.Boltzmann +hbar = sp.constants.hbar # J-s +kB = sp.constants.Boltzmann # J/K def get_cutoffs(structure: Structure): """ From f81a71804774ef962eaf1f10a43bffb1335faf1c Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Tue, 1 Nov 2022 10:53:38 -0400 Subject: [PATCH 132/207] workflow name --- atomate/vasp/workflows/presets/core.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 2b5aa70b8..d301c20bf 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -933,7 +933,7 @@ def wf_lattice_dynamics( wf.append_wf(wf_ld, wf.leaf_fw_ids) formula = structure.composition.reduced_formula - wf_name = "{} - lattice thermal conductivity".format(formula) + wf_name = "{} - lattice dynamics".format(formula) wf.name = wf_name wf = add_common_powerups(wf, c) From 6792750adec3fba3251f2ac1638592942ab696d1 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Wed, 2 Nov 2022 09:21:18 -0400 Subject: [PATCH 133/207] firetask error fix --- atomate/vasp/firetasks/lattice_dynamics.py | 14 +++++++------- 1 file changed, 7 insertions(+), 7 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 53d87fb2c..b3e1e1a00 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -149,6 +149,13 @@ class RunHiPhive(FiretaskBase): @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): + all_structures = loadfn("perturbed_structures.json") + all_forces = loadfn("perturbed_forces.json") + structure_data = loadfn("structure_data.json") + parent_structure = structure_data["structure"] + supercell_structure = structure_data["supercell_structure"] + supercell_matrix = np.array(structure_data["supercell_matrix"]) + separate_fit = self.get('separate_fit', False) disp_cut = self.get('disp_cut', None) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) @@ -158,13 +165,6 @@ def run_task(self, fw_spec): bulk_modulus = self.get("bulk_modulus") fit_method = self.get("fit_method") - all_structures = loadfn("perturbed_structures.json") - all_forces = loadfn("perturbed_forces.json") - structure_data = loadfn("structure_data.json") - parent_structure = structure_data["structure"] - supercell_structure = structure_data["supercell_structure"] - supercell_matrix = np.array(structure_data["supercell_matrix"]) - structures = [] supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) for structure, forces in zip(all_structures, all_forces): From eba90589f724b0c285a98d0abcd1b459bfe673c9 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Fri, 4 Nov 2022 14:33:19 -0400 Subject: [PATCH 134/207] T_qha --- atomate/vasp/firetasks/lattice_dynamics.py | 2 +- atomate/vasp/fireworks/lattice_dynamics.py | 2 ++ atomate/vasp/workflows/base/lattice_dynamics.py | 1 + 3 files changed, 4 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index b3e1e1a00..b99df0ad5 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -159,7 +159,7 @@ def run_task(self, fw_spec): separate_fit = self.get('separate_fit', False) disp_cut = self.get('disp_cut', None) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) - T_qha = np.array(self.get("T_qha")) + T_qha = np.array(self.get("temperature_qha")) T_qha.sort() imaginary_tol = self.get("imaginary_tol") bulk_modulus = self.get("bulk_modulus") diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index fe9648232..c1bfc7534 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -58,6 +58,7 @@ def __init__( bulk_modulus: float, imaginary_tol: float, mesh_density: float, + temperature_qha: float, cutoffs: Optional[List[List[float]]] = None, name="Fit Force Constants", parents: Optional[Union[Firework, List[Firework]]] = None, @@ -72,6 +73,7 @@ def __init__( fit_method=fit_method, disp_cut=disp_cut, bulk_modulus=bulk_modulus, + temperature_qha=temperature_qha, imaginary_tol=imaginary_tol, ) to_db = ForceConstantsToDb( diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 535d5f5be..04a4f79fb 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -199,6 +199,7 @@ def get_lattice_dynamics_wf( fit_method=fit_method, disp_cut=disp_cut, bulk_modulus=bulk_modulus, + temperature_qha=T_QHA, mesh_density=mesh_density, imaginary_tol=IMAGINARY_TOL, ) From 5660096b5fd98842d5ed780ad6f674d612011987 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 6 Nov 2022 20:13:23 -0800 Subject: [PATCH 135/207] T_qha --- atomate/vasp/firetasks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index b99df0ad5..99af4b775 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -159,7 +159,7 @@ def run_task(self, fw_spec): separate_fit = self.get('separate_fit', False) disp_cut = self.get('disp_cut', None) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) - T_qha = np.array(self.get("temperature_qha")) + T_qha = self.get("temperature_qha") T_qha.sort() imaginary_tol = self.get("imaginary_tol") bulk_modulus = self.get("bulk_modulus") From bca664297b78ae17da30052e8d76bac2f199eab0 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Sun, 6 Nov 2022 23:16:31 -0500 Subject: [PATCH 136/207] T_qha --- atomate/vasp/firetasks/lattice_dynamics.py | 1 + 1 file changed, 1 insertion(+) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 99af4b775..10d6b45fb 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -141,6 +141,7 @@ class RunHiPhive(FiretaskBase): "cutoffs", "separate_fit", "disp_cut", + "temperature_qha", "bulk_modulus", "imaginary_tol", "fit_method", From e3e5347911644550036dd699a9baca24c21068d3 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 7 Nov 2022 16:54:24 -0500 Subject: [PATCH 137/207] max cutoff --- atomate/vasp/analysis/lattice_dynamics.py | 2 ++ atomate/vasp/firetasks/lattice_dynamics.py | 6 +++--- 2 files changed, 5 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index dfb226973..aacea0d18 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -113,6 +113,7 @@ def get_cutoffs(structure: Structure): A list of trial cutoffs. """ # indexed as min_cutoffs[order][period] + # DO NOT CHANGE unless you know what you are doing min_cutoffs = { 2: {1: 5.0, 2: 6.0, 3: 7.0, 4: 8.0, 5: 9.0, 6: 10.0, 7: 11.0}, 3: {1: 3.0, 2: 3.5, 3: 4.5, 4: 5.5, 5: 6.0, 6: 6.5, 7: 7.0}, @@ -153,6 +154,7 @@ def get_cutoffs(structure: Structure): ======= cutoffs = np.array(list(map(list, product(range_two, range_three, range_four)))) max_cutoff = estimate_maximum_cutoff(AseAtomsAdaptor.get_atoms(supercell_structure)) + cutoffs[cutoffs>max_cutoff] = max_cutoff logger.info('CUTOFFS \n {}'.format(cutoffs)) logger.info('MAX_CUTOFF \n {}'.format(max_cutoff)) good_cutoffs = np.all(cutoffs < max_cutoff-0.1, axis=1) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 10d6b45fb..09316fb12 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -160,7 +160,7 @@ def run_task(self, fw_spec): separate_fit = self.get('separate_fit', False) disp_cut = self.get('disp_cut', None) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) - T_qha = self.get("temperature_qha") + T_qha = self.get("temperature_qha", T_QHA) T_qha.sort() imaginary_tol = self.get("imaginary_tol") bulk_modulus = self.get("bulk_modulus") @@ -194,10 +194,10 @@ def run_task(self, fw_spec): ) thermal_data, phonopy = harmonic_properties( - parent_structure, supercell_matrix, fcs, T_QHA, imaginary_tol + parent_structure, supercell_matrix, fcs, T_qha, imaginary_tol ) anharmonic_data, phonopy = anharmonic_properties( - phonopy, fcs, T_QHA, thermal_data["heat_capacity"], + phonopy, fcs, T_qha, thermal_data["heat_capacity"], thermal_data["n_imaginary"], bulk_modulus ) From 3a6bdde3cf466333783becc2bbe1ee7145932316 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Tue, 15 Nov 2022 00:29:15 -0500 Subject: [PATCH 138/207] file copy --- atomate/vasp/fireworks/lattice_dynamics.py | 3 +++ atomate/vasp/workflows/base/lattice_dynamics.py | 6 +++--- 2 files changed, 6 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index c1bfc7534..bb26644e7 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -1,5 +1,7 @@ from typing import List, Optional, Union, Dict +import os + from atomate.common.firetasks.glue_tasks import ( CopyFiles, CopyFilesFromCalcLoc, @@ -140,6 +142,7 @@ def __init__( copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + os.system('mv FORCE_CONSTANTS_2ND_{}K FORCE_CONSTANTS_2ND'.format(temperature)) else: # only the default files are needed files = [ diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 04a4f79fb..fa9acb534 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -163,7 +163,7 @@ def get_lattice_dynamics_wf( db_file = common_settings["DB_FILE"] - if calculate_lattice_thermal_conductivity or renormalize: + if calculate_lattice_thermal_conductivity: if supercell_matrix_kwargs.get("force_diagonal", False): warnings.warn( "Diagonal transformation required to calculate lattice thermal " @@ -227,7 +227,7 @@ def get_lattice_dynamics_wf( if renormalize: # Because of the way ShengBTE works, a temperature array that is not # equally spaced out (T_step) requires submission for each temperature - for T in renormalize_temperature: + for t,T in enumerate(renormalize_temperature): fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, shengbte_cmd=shengbte_cmd, @@ -237,7 +237,7 @@ def get_lattice_dynamics_wf( if shengbte_fworker: fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker wf.append_wf( - Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-1].fw_id] + Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-(t+1)].fw_id] ) else: fw_lattice_conductivity = LatticeThermalConductivityFW( From 54acf2af57ef09ac3300124ae7f59845366e0cfc Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Sun, 20 Nov 2022 21:34:49 -0500 Subject: [PATCH 139/207] clusterspace --- atomate/vasp/firetasks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 09316fb12..2d10f3a2c 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -43,7 +43,7 @@ try: import hiphive - from hiphive import ForceConstants + from hiphive import ForceConstants, ClusterSpace from hiphive.utilities import get_displacements except ImportError: logger.info('Could not import hiphive!') From 43db85f44a9274f152eefd47395945c2252339df Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Tue, 22 Nov 2022 22:54:02 -0500 Subject: [PATCH 140/207] calc_loc --- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index bb26644e7..24a60f0de 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -214,7 +214,7 @@ def __init__( if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: - copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + copy_files = CopyFilesFromCalcLoc(calc_loc="Fit Force Constants", filenames=files) renorm_force_constants = RunHiPhiveRenorm( renorm_temp=temperature, From c9fc23293e8c3d7c1ced01b218ea66f0f52e025e Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Thu, 1 Dec 2022 15:40:08 -0500 Subject: [PATCH 141/207] renormalization calc_loc --- atomate/vasp/firetasks/lattice_dynamics.py | 3 ++- atomate/vasp/fireworks/lattice_dynamics.py | 14 +++++++------- atomate/vasp/workflows/base/lattice_dynamics.py | 2 ++ 3 files changed, 11 insertions(+), 8 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 2d10f3a2c..ad11a39dd 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -414,7 +414,7 @@ def run_task(self, fw_spec): # Get an id for the force constants fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + metadata = {"fc_fitting_id": fitting_id, "renormalization_dir": os.getcwd()} data.update(metadata) data = jsanitize(data,strict=True,allow_bson=True) @@ -599,6 +599,7 @@ def run_task(self, fw_spec): "shengbte_dir": os.getcwd(), "fc_fitting_id": fw_spec.get("fc_fitting_id", None), "fc_fitting_dir": fw_spec.get("fc_fitting_dir", None), + "renormalization_dir": fw_spec.get("renormalization_dir", None), "created_at": datetime.utcnow(), } data.update(self.get("additional_fields", {})) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 24a60f0de..14ad484dc 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -112,7 +112,7 @@ class LatticeThermalConductivityFW(Firework): def __init__( self, shengbte_cmd: str, - temperature: Union[float, dict], + temperature: Union[float, int, dict], renormalized: bool, name="Lattice Thermal Conductivity", prev_calc_dir: Optional[str] = None, @@ -141,7 +141,7 @@ def __init__( if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: - copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + copy_files = CopyFilesFromCalcLoc(calc_loc='Renormalization', filenames=files) os.system('mv FORCE_CONSTANTS_2ND_{}K FORCE_CONSTANTS_2ND'.format(temperature)) else: # only the default files are needed @@ -153,7 +153,7 @@ def __init__( if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: - copy_files = CopyFilesFromCalcLoc(calc_loc=True, filenames=files) + copy_files = CopyFilesFromCalcLoc(calc_loc='Fit Force Constants', filenames=files) run_shengbte = RunShengBTE( shengbte_cmd=shengbte_cmd, @@ -211,10 +211,10 @@ def __init__( files = ["cluster_space.cs","parameters.txt","force_constants.fcs", "structure_data.json","fitting_data.json","phonopy_params.yaml"] - if prev_calc_dir: - copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) - else: - copy_files = CopyFilesFromCalcLoc(calc_loc="Fit Force Constants", filenames=files) +# if prev_calc_dir: +# copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) +# else: + copy_files = CopyFilesFromCalcLoc(calc_loc="Fit Force Constants", filenames=files) renorm_force_constants = RunHiPhiveRenorm( renorm_temp=temperature, diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index fa9acb534..9ab230816 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -228,6 +228,8 @@ def get_lattice_dynamics_wf( # Because of the way ShengBTE works, a temperature array that is not # equally spaced out (T_step) requires submission for each temperature for t,T in enumerate(renormalize_temperature): + if T == 0: + continue fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, shengbte_cmd=shengbte_cmd, From 388e7adf2df532b4e1e55aa8f0117cfa6424c890 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Mon, 27 Feb 2023 12:54:01 -0800 Subject: [PATCH 142/207] copy_files --- atomate/vasp/fireworks/lattice_dynamics.py | 12 ++++++------ 1 file changed, 6 insertions(+), 6 deletions(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 14ad484dc..530643973 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -210,11 +210,11 @@ def __init__( # files needed to run renormalization files = ["cluster_space.cs","parameters.txt","force_constants.fcs", "structure_data.json","fitting_data.json","phonopy_params.yaml"] - -# if prev_calc_dir: -# copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) -# else: - copy_files = CopyFilesFromCalcLoc(calc_loc="Fit Force Constants", filenames=files) + + if prev_calc_dir: + copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) + else: + copy_files = CopyFilesFromCalcLoc(calc_loc="Fit Force Constants", filenames=files) renorm_force_constants = RunHiPhiveRenorm( renorm_temp=temperature, @@ -232,5 +232,5 @@ def __init__( ) pass_locs = PassCalcLocs(name=name) - tasks = [renorm_force_constants, to_db, pass_locs] + tasks = [copy_files, renorm_force_constants, to_db, pass_locs] super().__init__(tasks, name=name, **kwargs) From 38a60c27e80b3ab1fc4cab419fa6452e475b0095 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 27 Feb 2023 16:32:04 -0500 Subject: [PATCH 143/207] add_attiaional_fields_to_taskdocs --- atomate/vasp/workflows/base/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 9ab230816..e42345741 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -27,7 +27,7 @@ LatticeThermalConductivityFW, RenormalizationFW, ) -from atomate.vasp.powerups import add_additional_fields_to_taskdocs +from atomate.common.powerups import add_additional_fields_to_taskdocs from fireworks import Workflow from pymatgen.core.structure import Structure from pymatgen.io.vasp.sets import MPStaticSet, VaspInputSet From b5b7e7e4b1e4f4f3597e40799fbb56e156ef8cfb Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 27 Feb 2023 23:03:17 -0500 Subject: [PATCH 144/207] RunHiPhiveRenorm --- atomate/vasp/firetasks/lattice_dynamics.py | 9 ++++++--- 1 file changed, 6 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index ad11a39dd..842c843eb 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -273,7 +273,7 @@ def run_task(self, fw_spec): # First renormalization with DFT lattice renorm_data = Parallel(n_jobs=4, backend="multiprocessing")(delayed(run_renormalization)( parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, max_iter, - conv_thresh, bulk_modulus, phonopy_orig) for t, T in enumerate(renorm_temp)) + conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) for t, T in enumerate(renorm_temp)) # Additional renormalization with thermal expansion - optional - just single "iteration" for now if renorm_TE_iter: @@ -304,10 +304,13 @@ def run_task(self, fw_spec): parent_structure_TE, cs_TE, fcs_TE = setup_TE_iter(cutoffs,parent_structure,T_real,dLfrac_real) param_TE = copy(param_real) - + prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) + prim_phonopy_TE = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), + scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) + phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) renorm_data = Parallel(n_jobs=4, backend="multiprocessing")(delayed(run_renormalization)( parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, cs_TE[t], fcs_TE[t], param_TE[t], - T, nconfig, max_iter, conv_thresh, bulk_modulus + T, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE ) for t, T in enumerate(T_real) ) From 346a86fb04affb3cfb8dc59db8d8112f53dc9bf7 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Wed, 1 Mar 2023 11:11:39 -0500 Subject: [PATCH 145/207] revert to structure container for fitting --- atomate/vasp/analysis/lattice_dynamics.py | 89 ++++++++++++++++++++-- atomate/vasp/firetasks/lattice_dynamics.py | 41 +++++++--- 2 files changed, 115 insertions(+), 15 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index aacea0d18..32f9248b1 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -17,12 +17,16 @@ from hiphive import (ForceConstants, ForceConstantPotential, enforce_rotational_sum_rules, ClusterSpace, StructureContainer) +<<<<<<< HEAD >>>>>>> 1e75a82a (imports) +======= +from hiphive.force_constant_model import ForceConstantModel +>>>>>>> 0d613579 (revert to structure container for fitting) from hiphive.cutoffs import is_cutoff_allowed, estimate_maximum_cutoff from hiphive.fitting import Optimizer from hiphive.renormalization import Renormalization from hiphive.utilities import get_displacements -from hiphive.run_tools import FE_correction +from hiphive.run_tools import _clean_data, FE_correction from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor @@ -297,6 +301,75 @@ def fit_force_constants( return best_fit["force_constants"], best_fit["parameters"], best_fit["cluster_space"], fitting_data +def _get_fit_data( + cs: ClusterSpace, + supercell: Atoms, + structures: List["Atoms"], + separate_fit: bool, + disp_cut: float, + ncut: int, + param2: np.ndarray = None +) -> "List": + """ Constructs structure container of atom-displaced supercells + Args: + cs: ClusterSpace + supercell: Atoms + Original undisplaced supercell + structures: A list of ase atoms objects with the "forces" and + "displacements" arrays included. + separate_fit: Boolean to determine whether harmonic and anharmonic fitting + are to be done separately (True) or in one shot (False) + disp_cut: if separate_fit true, determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + ncut: the parameter index where fitting separation occurs + param2: previously fit parameter array (harmonic only for now, hence 2) + + Returns: + fit_data: List[A_mat,f_vec] + """ + + saved_structures = [] + fcm = ForceConstantModel(supercell,cs) + natom = supercell.get_global_number_of_atoms() + nrow_per = natom*3 + nrow_all = nrow_per*len(saved_structures) + A_mat = np.memmap('A_mat_memmap', dtype=float, shape=(nrow_all,cs.n_dofs), mode='w+') + f_vec = np.memmap('f_vec_memmap', dtype=float, shape=(nrow_all), mode='w+') + + for i, structure in enumerate(structures): + displacements = structure.get_array('displacements') + mean_displacements = np.linalg.norm(displacements,axis=1).mean() + logger.info('Mean displacements: {}'.format(mean_displacements)) + if not separate_fit: # fit all + saved_structures.append(structure) + else: # fit separately + if param2 is None: # for harmonic fitting + if mean_displacements < disp_cut: + saved_structures.append(structure) + else: # for anharmonic fitting + if mean_displacements >= disp_cut: + saved_structures.append(structure) + + Parallel(n_jobs=min(os.cpu_count(),max(1,len(saved_structures))))(#,prefer="threads")( + delayed(construct_fit_data)(fcm,structure,A_mat,f_vec,nrow_per,s,param=None) + for s,structure in enumerate(saved_structures) + ) + + if param2 is not None: + force_anh = f_vec - np.dot(A_mat[:,:ncut],param2) # subtract harmonic force from total + for i, structure in enumerate(saved_structures): + structure.set_array('forces', force_anh[i*nrow_per:(i+1)*nrow_per].reshape(natom,3)) + Parallel(n_jobs=min(os.cpu_count(),max(1,len(saved_structures))))(#,prefer="threads")( + delayed(construct_fit_data)(fcm,structure,A_mat,f_vec,nrow_per,s,param=None) + for s,structure in enumerate(saved_structures) + ) + os.remove('A_mat_memmap') + os.remove('f_vec_memmap') + logger.info('Fit_data dimensions: {}'.format(A_mat.shape)) + fit_data = _clean_data(A_mat,f_vec,nrow_per) + return fit_data + + def _run_cutoffs( i, cutoffs, @@ -340,6 +413,8 @@ def _run_cutoffs( if separate_fit: logger.info('Fitting harmonic force constants separately') +# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, +# disp_cut, ncut=n2nd, param2=None) sc = get_structure_container(cs, structures, separate_fit, disp_cut, ncut=n2nd, param2=None) opt = Optimizer(sc.get_fit_data(), @@ -355,6 +430,8 @@ def _run_cutoffs( param_harmonic = opt.parameters # harmonic force constant parameters logger.info('Fitting anharmonic force constants separately') +# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, +# disp_cut, ncut=n2nd, param2=param_harmonic) sc = get_structure_container(cs, structures, separate_fit, disp_cut, ncut=n2nd, param2=param_harmonic) opt = Optimizer(sc.get_fit_data(), @@ -438,6 +515,8 @@ def get_structure_container( else: logger.info('Fitting all force constants in one shot') +# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, +# disp_cut=None, ncut=None, param2=None) sc = get_structure_container(cs, structures, separate_fit, disp_cut=None, ncut=None, param2=None) opt = Optimizer(sc.get_fit_data(), @@ -481,7 +560,7 @@ def get_structure_container( Get a hiPhive StructureContainer from cutoffs and a list of atoms objects. Args: - cutoffs: Cutoff radii for different orders starting with second order. + cs: ClusterSpace structures: A list of ase atoms objects with the "forces" and "displacements" arrays included. separate_fit: Boolean to determine whether harmonic and anharmonic fitting @@ -807,11 +886,11 @@ def run_renormalization( omega0 = phonopy_orig.mesh.frequencies # THz omega_TD = phonopy.mesh.frequencies # THz - natom = phonopy.primitive.get_number_of_atoms() - correction = FE_correction(omega0,omega_TD,T)/natom # eV/atom +# natom = phonopy.primitive.get_number_of_atoms() + correction_S, correction_4 = FE_correction(omega0,omega_TD,T) # eV/atom renorm_data.update(anharmonic_data) - renorm_data["free_energy_correction"] = correction + renorm_data["free_energy_correction_S"] = correction_S[0] renorm_data["fcp"] = fcp renorm_data["fcs"] = fcs renorm_data["param"] = param diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 842c843eb..07db589f8 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -270,10 +270,21 @@ def run_task(self, fw_spec): renorm_TE_iter = self.get("renorm_TE_iter") bulk_modulus = self.get("bulk_modulus") - # First renormalization with DFT lattice - renorm_data = Parallel(n_jobs=4, backend="multiprocessing")(delayed(run_renormalization)( - parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, max_iter, - conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) for t, T in enumerate(renorm_temp)) + # Renormalization with DFT lattice + + # Parallel version +# renorm_data = Parallel(n_jobs=len(renorm_temp), backend="multiprocessing")(delayed(run_renormalization)( +# parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, max_iter, +# conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) for t, T in enumerate(renorm_temp)) + + # Serial version - likely better because it allows parallelization over A matrix construction, + # which takes most of the time during renormalization, and leaves no process idling around when + # low temperature renormalizations finish early + renorm_data = [] + for t, T in enumerate(renorm_temp): + data_T = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, + max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) + renorm_data.append(data_T) # Additional renormalization with thermal expansion - optional - just single "iteration" for now if renorm_TE_iter: @@ -308,14 +319,24 @@ def run_task(self, fw_spec): prim_phonopy_TE = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) - renorm_data = Parallel(n_jobs=4, backend="multiprocessing")(delayed(run_renormalization)( - parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, cs_TE[t], fcs_TE[t], param_TE[t], - T, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE - ) for t, T in enumerate(T_real) - ) + # Parallel +# renorm_data = Parallel(n_jobs=len(T_real), backend="multiprocessing")(delayed(run_renormalization)( +# parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, cs_TE[t], fcs_TE[t], param_TE[t], +# T, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE +# ) for t, T in enumerate(T_real) +# ) + + # Serial + renorm_data_TE = [] + for t, T in enumerate(T_real): + data_T = run_renormalization(parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, + cs_TE[t], fcs_TE[t], param_TE[t], T, nconfig, max_iter, conv_thresh, + renorm_method, fit_method, bulk_modulus, phonopy_TE) + renorm_data_TE.append(data_T) + if len(T_real) > 0: - for t, result in enumerate(renorm_data): + for t, result in enumerate(renorm_data_TE): temp_index = np.where(renorm_temp==T_real[t])[0][0] renorm_data[temp_index] = result From ff4921282bca128e59f46ff52564b98896b4bb8d Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Wed, 8 Mar 2023 11:29:11 -0500 Subject: [PATCH 146/207] fit_data parallel --- atomate/vasp/analysis/lattice_dynamics.py | 73 +++++++++++------------ 1 file changed, 34 insertions(+), 39 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 32f9248b1..7f1eb5a74 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -301,7 +301,7 @@ def fit_force_constants( return best_fit["force_constants"], best_fit["parameters"], best_fit["cluster_space"], fitting_data -def _get_fit_data( +def get_fit_data( cs: ClusterSpace, supercell: Atoms, structures: List["Atoms"], @@ -315,14 +315,14 @@ def _get_fit_data( cs: ClusterSpace supercell: Atoms Original undisplaced supercell - structures: A list of ase atoms objects with the "forces" and - "displacements" arrays included. - separate_fit: Boolean to determine whether harmonic and anharmonic fitting - are to be done separately (True) or in one shot (False) - disp_cut: if separate_fit true, determines the mean displacement of perturbed - structure to be included in harmonic (<) or anharmonic (>) fitting - ncut: the parameter index where fitting separation occurs - param2: previously fit parameter array (harmonic only for now, hence 2) + structures: A list of ase atoms objects with the "forces" and + "displacements" arrays included. + separate_fit: Boolean to determine whether harmonic and anharmonic fitting + are to be done separately (True) or in one shot (False) + disp_cut: if separate_fit true, determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + ncut: the parameter index where fitting separation occurs + param2: previously fit parameter array (harmonic only for now, hence 2) Returns: fit_data: List[A_mat,f_vec] @@ -333,8 +333,8 @@ def _get_fit_data( natom = supercell.get_global_number_of_atoms() nrow_per = natom*3 nrow_all = nrow_per*len(saved_structures) - A_mat = np.memmap('A_mat_memmap', dtype=float, shape=(nrow_all,cs.n_dofs), mode='w+') - f_vec = np.memmap('f_vec_memmap', dtype=float, shape=(nrow_all), mode='w+') + A_mat = np.zeros((nrow_all,cs.n_dofs)) + f_vec = np.zeros(nrow_all) for i, structure in enumerate(structures): displacements = structure.get_array('displacements') @@ -350,21 +350,16 @@ def _get_fit_data( if mean_displacements >= disp_cut: saved_structures.append(structure) - Parallel(n_jobs=min(os.cpu_count(),max(1,len(saved_structures))))(#,prefer="threads")( - delayed(construct_fit_data)(fcm,structure,A_mat,f_vec,nrow_per,s,param=None) + fit_data_tmp = Parallel(n_jobs=min(os.cpu_count(),max(1,len(saved_structures))))(#,prefer="threads")( + delayed(construct_fit_data)(fcm,structure,s) for s,structure in enumerate(saved_structures) ) + for s,data in enumerate(fit_data_tmp) + A_mat[s*nrow_per:(s+1)*nrow_per] = data[0] + f_vec[s*nrow_per:(s+1)*nrow_per] = data[1] if param2 is not None: - force_anh = f_vec - np.dot(A_mat[:,:ncut],param2) # subtract harmonic force from total - for i, structure in enumerate(saved_structures): - structure.set_array('forces', force_anh[i*nrow_per:(i+1)*nrow_per].reshape(natom,3)) - Parallel(n_jobs=min(os.cpu_count(),max(1,len(saved_structures))))(#,prefer="threads")( - delayed(construct_fit_data)(fcm,structure,A_mat,f_vec,nrow_per,s,param=None) - for s,structure in enumerate(saved_structures) - ) - os.remove('A_mat_memmap') - os.remove('f_vec_memmap') + f_vec -= np.dot(A_mat[:,:ncut],param2) # subtract harmonic force from total logger.info('Fit_data dimensions: {}'.format(A_mat.shape)) fit_data = _clean_data(A_mat,f_vec,nrow_per) return fit_data @@ -413,11 +408,11 @@ def _run_cutoffs( if separate_fit: logger.info('Fitting harmonic force constants separately') -# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, -# disp_cut, ncut=n2nd, param2=None) - sc = get_structure_container(cs, structures, separate_fit, disp_cut, - ncut=n2nd, param2=None) - opt = Optimizer(sc.get_fit_data(), + fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, + disp_cut, ncut=n2nd, param2=None) +# sc = get_structure_container(cs, structures, separate_fit, disp_cut, +# ncut=n2nd, param2=None) + opt = Optimizer(fit_data,#sc.get_fit_data(), fit_method, [0,n2nd], **fit_kwargs) @@ -430,11 +425,11 @@ def _run_cutoffs( param_harmonic = opt.parameters # harmonic force constant parameters logger.info('Fitting anharmonic force constants separately') -# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, -# disp_cut, ncut=n2nd, param2=param_harmonic) - sc = get_structure_container(cs, structures, separate_fit, disp_cut, - ncut=n2nd, param2=param_harmonic) - opt = Optimizer(sc.get_fit_data(), + fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, + disp_cut, ncut=n2nd, param2=param_harmonic) +# sc = get_structure_container(cs, structures, separate_fit, disp_cut, +# ncut=n2nd, param2=param_harmonic) + opt = Optimizer(fit_data,#sc.get_fit_data(), fit_method, [n2nd,nall], **fit_kwargs) @@ -515,11 +510,11 @@ def get_structure_container( else: logger.info('Fitting all force constants in one shot') -# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, -# disp_cut=None, ncut=None, param2=None) - sc = get_structure_container(cs, structures, separate_fit, disp_cut=None, - ncut=None, param2=None) - opt = Optimizer(sc.get_fit_data(), + fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, + disp_cut=None, ncut=None, param2=None) +# sc = get_structure_container(cs, structures, separate_fit, disp_cut=None, +# ncut=None, param2=None) + opt = Optimizer(fit_data,#sc.get_fit_data(), fit_method, [0,nall], **fit_kwargs) @@ -593,7 +588,7 @@ def get_structure_container( if separate_fit and param2 is not None: # do after anharmonic fitting A_mat = sc.get_fit_data()[0] # displacement matrix f_vec = sc.get_fit_data()[1] # force vector - anh_force = f_vec - np.dot(A_mat[:,:ncut],param2) # subtract harmonic forces + f_vec -= np.dot(A_mat[:,:ncut],param2) # subtract harmonic forces sc.delete_all_structures() for i, structure in enumerate(saved_structures): natoms = structure.get_global_number_of_atoms() @@ -861,7 +856,7 @@ def run_renormalization( supercell_matrix: The supercell transformation matrix. fcs: ForceConstants from previous fitting or renormalization imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, - in THz. + in THz. Returns: A tuple of the number of imaginary modes at Gamma, the minimum phonon From a26f235aa6ed14f325d44588f0970113fba646d7 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Wed, 8 Mar 2023 11:30:28 -0500 Subject: [PATCH 147/207] typo --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 7f1eb5a74..7c41de133 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -354,7 +354,7 @@ def get_fit_data( delayed(construct_fit_data)(fcm,structure,s) for s,structure in enumerate(saved_structures) ) - for s,data in enumerate(fit_data_tmp) + for s,data in enumerate(fit_data_tmp): A_mat[s*nrow_per:(s+1)*nrow_per] = data[0] f_vec[s*nrow_per:(s+1)*nrow_per] = data[1] From 6671b07993fd51d465765489b2a29f2db89a823c Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Wed, 8 Mar 2023 14:11:48 -0500 Subject: [PATCH 148/207] BTE.KappaTotalTensorVsT_CONV --- atomate/vasp/firetasks/lattice_dynamics.py | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 07db589f8..7aa27c033 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -597,7 +597,9 @@ def run_task(self, fw_spec): structure = control.get_structure() supercell_matrix = np.diag(control["scell"]) - if Path("BTE.KappaTensorVsT_CONV").exists(): + if Path("BTE.KappaTotalTensorVsT_CONV").exists(): + filename = "BTE.KappaTotalTensorVsT_CONV" + elif Path("BTE.KappaTensorVsT_CONV").exists(): filename = "BTE.KappaTensorVsT_CONV" elif Path("BTE.KappaTensorVsT_RTA").exists(): filename = "BTE.KappaTensorVsT_RTA" From 0b8d0b9aa1d2aec44a9cc688653f023c712ee99e Mon Sep 17 00:00:00 2001 From: Zhuoying Zhu Date: Fri, 10 Mar 2023 15:31:51 -0800 Subject: [PATCH 149/207] small fix for cutoffs and fit_method --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- atomate/vasp/workflows/presets/core.py | 6 +++++- 2 files changed, 6 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 7c41de133..41025e18e 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -158,7 +158,7 @@ def get_cutoffs(structure: Structure): ======= cutoffs = np.array(list(map(list, product(range_two, range_three, range_four)))) max_cutoff = estimate_maximum_cutoff(AseAtomsAdaptor.get_atoms(supercell_structure)) - cutoffs[cutoffs>max_cutoff] = max_cutoff + cutoffs[cutoffs>max_cutoff] = max_cutoff-0.2 logger.info('CUTOFFS \n {}'.format(cutoffs)) logger.info('MAX_CUTOFF \n {}'.format(max_cutoff)) good_cutoffs = np.all(cutoffs < max_cutoff-0.1, axis=1) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index d301c20bf..6f206ef52 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -33,7 +33,11 @@ add_stability_check, add_wf_metadata, ) +<<<<<<< HEAD from atomate.vasp.workflows.base.bulk_modulus import get_wf_bulk_modulus +======= +from atomate.vasp.analysis.lattice_dynamics import FIT_METHOD +>>>>>>> 0da85957 (small fix for cutoffs and fit_method) from atomate.vasp.workflows.base.core import get_wf from atomate.vasp.workflows.base.elastic import get_wf_elastic_constant from atomate.vasp.workflows.base.gibbs import get_wf_gibbs_free_energy @@ -851,7 +855,7 @@ def wf_nudged_elastic_band(structures, parent, c=None): def wf_lattice_dynamics( structure: Structure, separate_fit: bool = False, - fit_method: str = False, + fit_method: str = FIT_METHOD, disp_cut: float = None, bulk_modulus: float = None, c: Optional[dict] = None, From 5ced537706f8f14a1dadb52ba158ef8b06a1c6c8 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Tue, 14 Mar 2023 14:56:46 -0400 Subject: [PATCH 150/207] construct_fit_data --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 41025e18e..eb1a5309a 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -26,7 +26,7 @@ from hiphive.fitting import Optimizer from hiphive.renormalization import Renormalization from hiphive.utilities import get_displacements -from hiphive.run_tools import _clean_data, FE_correction +from hiphive.run_tools import _clean_data, FE_correction, construct_fit_data from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor From 22fb19d26170d37b96f2cd4b96a7ccda8c2d306d Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Thu, 16 Mar 2023 21:00:50 -0400 Subject: [PATCH 151/207] fit_data unpack : --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index eb1a5309a..b0f68c8ef 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -355,7 +355,7 @@ def get_fit_data( for s,structure in enumerate(saved_structures) ) for s,data in enumerate(fit_data_tmp): - A_mat[s*nrow_per:(s+1)*nrow_per] = data[0] + A_mat[s*nrow_per:(s+1)*nrow_per,:] = data[0] f_vec[s*nrow_per:(s+1)*nrow_per] = data[1] if param2 is not None: From b65529548e1d2eca0a65d4d6ba8370b88b15b908 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Fri, 17 Mar 2023 18:05:46 -0400 Subject: [PATCH 152/207] debug --- atomate/vasp/analysis/lattice_dynamics.py | 11 ++++++----- 1 file changed, 6 insertions(+), 5 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index b0f68c8ef..78ff34979 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -331,8 +331,8 @@ def get_fit_data( saved_structures = [] fcm = ForceConstantModel(supercell,cs) natom = supercell.get_global_number_of_atoms() - nrow_per = natom*3 - nrow_all = nrow_per*len(saved_structures) + ndim = natom*3 + nrow_all = ndim*len(saved_structures) A_mat = np.zeros((nrow_all,cs.n_dofs)) f_vec = np.zeros(nrow_all) @@ -355,13 +355,14 @@ def get_fit_data( for s,structure in enumerate(saved_structures) ) for s,data in enumerate(fit_data_tmp): - A_mat[s*nrow_per:(s+1)*nrow_per,:] = data[0] - f_vec[s*nrow_per:(s+1)*nrow_per] = data[1] + print(s,ndim) + A_mat[s*ndim:(s+1)*ndim] = data[0] + f_vec[s*ndim:(s+1)*ndim] = data[1] if param2 is not None: f_vec -= np.dot(A_mat[:,:ncut],param2) # subtract harmonic force from total logger.info('Fit_data dimensions: {}'.format(A_mat.shape)) - fit_data = _clean_data(A_mat,f_vec,nrow_per) + fit_data = _clean_data(A_mat,f_vec,ndim) return fit_data From 7f0e8581058061e3bc8d23143a0d89846bd93304 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Fri, 17 Mar 2023 18:12:15 -0400 Subject: [PATCH 153/207] debug --- atomate/vasp/analysis/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 78ff34979..491adc23b 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -355,7 +355,7 @@ def get_fit_data( for s,structure in enumerate(saved_structures) ) for s,data in enumerate(fit_data_tmp): - print(s,ndim) + print(s,data) A_mat[s*ndim:(s+1)*ndim] = data[0] f_vec[s*ndim:(s+1)*ndim] = data[1] From 510d9f1a97c6d63dfb15bf8ab837a2851f558dbf Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 17 Mar 2023 20:06:55 -0700 Subject: [PATCH 154/207] sc --- atomate/vasp/analysis/lattice_dynamics.py | 34 +++++++++++------------ 1 file changed, 17 insertions(+), 17 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 491adc23b..d0fbfbfda 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -355,7 +355,7 @@ def get_fit_data( for s,structure in enumerate(saved_structures) ) for s,data in enumerate(fit_data_tmp): - print(s,data) + logger.info('DEBUG: {}, {}'.format(s,data[0])) A_mat[s*ndim:(s+1)*ndim] = data[0] f_vec[s*ndim:(s+1)*ndim] = data[1] @@ -409,11 +409,11 @@ def _run_cutoffs( if separate_fit: logger.info('Fitting harmonic force constants separately') - fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, - disp_cut, ncut=n2nd, param2=None) -# sc = get_structure_container(cs, structures, separate_fit, disp_cut, -# ncut=n2nd, param2=None) - opt = Optimizer(fit_data,#sc.get_fit_data(), +# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, +# disp_cut, ncut=n2nd, param2=None) + sc = get_structure_container(cs, structures, separate_fit, disp_cut, + ncut=n2nd, param2=None) + opt = Optimizer(sc.get_fit_data(), fit_method, [0,n2nd], **fit_kwargs) @@ -426,11 +426,11 @@ def _run_cutoffs( param_harmonic = opt.parameters # harmonic force constant parameters logger.info('Fitting anharmonic force constants separately') - fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, - disp_cut, ncut=n2nd, param2=param_harmonic) -# sc = get_structure_container(cs, structures, separate_fit, disp_cut, -# ncut=n2nd, param2=param_harmonic) - opt = Optimizer(fit_data,#sc.get_fit_data(), +# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, +# disp_cut, ncut=n2nd, param2=param_harmonic) + sc = get_structure_container(cs, structures, separate_fit, disp_cut, + ncut=n2nd, param2=param_harmonic) + opt = Optimizer(sc.get_fit_data(), fit_method, [n2nd,nall], **fit_kwargs) @@ -511,11 +511,11 @@ def get_structure_container( else: logger.info('Fitting all force constants in one shot') - fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, - disp_cut=None, ncut=None, param2=None) -# sc = get_structure_container(cs, structures, separate_fit, disp_cut=None, -# ncut=None, param2=None) - opt = Optimizer(fit_data,#sc.get_fit_data(), +# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, +# disp_cut=None, ncut=None, param2=None) + sc = get_structure_container(cs, structures, separate_fit, disp_cut=None, + ncut=None, param2=None) + opt = Optimizer(sc.get_fit_data(), fit_method, [0,nall], **fit_kwargs) @@ -594,7 +594,7 @@ def get_structure_container( for i, structure in enumerate(saved_structures): natoms = structure.get_global_number_of_atoms() ndisp = natoms*3 - structure.set_array('forces',anh_force[i*ndisp:(i+1)*ndisp].reshape(natoms,3)) + structure.set_array('forces',f_vec[i*ndisp:(i+1)*ndisp].reshape(natoms,3)) sc.add_structure(structure) logger.debug(sc.__repr__()) From 351010c505ee7cda445132ca6e340ac9d94cef8c Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 19 Mar 2023 20:17:34 -0700 Subject: [PATCH 155/207] changes --- atomate/vasp/analysis/lattice_dynamics.py | 13 ++++++++----- atomate/vasp/firetasks/lattice_dynamics.py | 4 ++-- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 3 files changed, 11 insertions(+), 8 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index d0fbfbfda..2fc79b40a 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -877,16 +877,19 @@ def run_renormalization( ) else: anharmonic_data = dict() - anharmonic_data["gruneisen"] = np.array([[0,0,0]]) - anharmonic_data["thermal_expansion"] = np.array([[0,0,0]]) - +# anharmonic_data["temperature"] = T +# anharmonic_data["gruneisen"] = np.array([[0,0,0]]) +# anharmonic_data["thermal_expansion"] = np.array([[0,0,0]]) +# anharmonic_data["expansion_ratio"] = np.array([[0,0,0]]) + renorm_data.update(anharmonic_data) + omega0 = phonopy_orig.mesh.frequencies # THz omega_TD = phonopy.mesh.frequencies # THz # natom = phonopy.primitive.get_number_of_atoms() - correction_S, correction_4 = FE_correction(omega0,omega_TD,T) # eV/atom + correction_S, correction_SC = FE_correction(omega0,omega_TD,T) # eV/atom - renorm_data.update(anharmonic_data) renorm_data["free_energy_correction_S"] = correction_S[0] + renorm_data["free_energy_correction_SC"] = correction_SC[0] renorm_data["fcp"] = fcp renorm_data["fcs"] = fcs renorm_data["param"] = param diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 7aa27c033..72483b8e8 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -201,7 +201,7 @@ def run_task(self, fw_spec): thermal_data["n_imaginary"], bulk_modulus ) - phonopy.save("phonopy_params.yaml") + phonopy.save("phonopy_orig.yaml") fitting_data["n_imaginary"] = thermal_data.pop("n_imaginary") thermal_data.update(anharmonic_data) dumpfn(fitting_data, "fitting_data.json") @@ -250,7 +250,7 @@ def run_task(self, fw_spec): param = np.loadtxt('parameters.txt') fitting_data = loadfn("fitting_data.json") structure_data = loadfn("structure_data.json") - phonopy_orig = phpy.load("phonopy_params.yaml") + phonopy_orig = phpy.load("phonopy_orig.yaml") cutoffs = fitting_data["cutoffs"] fit_method = fitting_data["fit_method"] diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 530643973..a0f62bd9b 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -209,7 +209,7 @@ def __init__( # files needed to run renormalization files = ["cluster_space.cs","parameters.txt","force_constants.fcs", - "structure_data.json","fitting_data.json","phonopy_params.yaml"] + "structure_data.json","fitting_data.json","phonopy_orig.yaml"] if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) From 8a2e573f65690941aab6ff949d96d52044d95713 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Sun, 19 Mar 2023 23:15:33 -0400 Subject: [PATCH 156/207] anharmonic properties return --- atomate/vasp/analysis/lattice_dynamics.py | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 2fc79b40a..2d286665b 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -671,7 +671,7 @@ def anharmonic_properties( Cv: np.ndarray, n_imaginary: float, bulk_modulus: float = None -) -> Tuple[Dict, Phonopy]: +) -> Dict: if n_imaginary == 0: logger.info('Evaluating anharmonic properties...') @@ -695,7 +695,7 @@ def anharmonic_properties( "gruneisen": grun, "thermal_expansion": cte, "expansion_ratio": dLfrac, - }, phonopy + } def get_total_grun( @@ -872,7 +872,7 @@ def run_renormalization( if renorm_data["n_imaginary"] == 0: logger.info('Renormalized phonon is completely real at T = {} K!'.format(T)) - anharmonic_data, phonopy = anharmonic_properties( + anharmonic_data = anharmonic_properties( phonopy, fcs, [T], thermal_data["heat_capacity"], n_imaginary, bulk_modulus=bulk_modulus ) else: From f15af74bcf365571d757470ddbe67655ca2ca0b8 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sun, 19 Mar 2023 20:42:45 -0700 Subject: [PATCH 157/207] anharmonic properties return --- atomate/vasp/firetasks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 72483b8e8..3336857be 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -196,7 +196,7 @@ def run_task(self, fw_spec): thermal_data, phonopy = harmonic_properties( parent_structure, supercell_matrix, fcs, T_qha, imaginary_tol ) - anharmonic_data, phonopy = anharmonic_properties( + anharmonic_data = anharmonic_properties( phonopy, fcs, T_qha, thermal_data["heat_capacity"], thermal_data["n_imaginary"], bulk_modulus ) From 13856745ba16a959eea3b20071dd65deecab408d Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 20 Mar 2023 00:05:59 -0400 Subject: [PATCH 158/207] nconfig0 nconfig --- atomate/vasp/analysis/lattice_dynamics.py | 4 ++-- atomate/vasp/firetasks/lattice_dynamics.py | 3 ++- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 3 files changed, 5 insertions(+), 4 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 2d286665b..535f55d88 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -59,9 +59,9 @@ FIT_METHOD = "rfe" RENORM_METHOD = 'pseudoinverse' -RENORM_NCONFIG = 50 +RENORM_NCONFIG = 5 RENORM_CONV_THRESH = 0.1 # meV/atom -RENORM_MAX_ITER = 20 +RENORM_MAX_ITER = 30 eV2J = 1.602e-19 hbar = sp.constants.hbar # J-s diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 3336857be..e5a9b1b2b 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -264,7 +264,7 @@ def run_task(self, fw_spec): renorm_temp = np.array(self.get("renorm_temp")) renorm_temp.sort() renorm_method = self.get("renorm_method") - nconfig = self.get("nconfig") + nconfig0 = self.get("nconfig") conv_thresh = self.get("conv_thresh") max_iter = self.get("max_iter") renorm_TE_iter = self.get("renorm_TE_iter") @@ -282,6 +282,7 @@ def run_task(self, fw_spec): # low temperature renormalizations finish early renorm_data = [] for t, T in enumerate(renorm_temp): + nconfig = nconfig0*(1+np.mod(T,100)) data_T = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) renorm_data.append(data_T) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index a0f62bd9b..d18d1cc23 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -219,7 +219,7 @@ def __init__( renorm_force_constants = RunHiPhiveRenorm( renorm_temp=temperature, renorm_method=renorm_method, - nconfig=renorm_nconfig, + nconfig0=renorm_nconfig, conv_thresh=renorm_conv_thresh, max_iter=renorm_max_iter, renorm_TE_iter=renorm_TE_iter, From 04419a98de4da0cf3049f4a8acd21935f6080724 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 20 Mar 2023 00:35:34 -0400 Subject: [PATCH 159/207] parallel renormalization fireworks for each T --- atomate/vasp/firetasks/lattice_dynamics.py | 121 ++++++------------ atomate/vasp/fireworks/lattice_dynamics.py | 2 +- .../vasp/workflows/base/lattice_dynamics.py | 26 ++-- 3 files changed, 56 insertions(+), 93 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index e5a9b1b2b..8c9d6be5e 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -264,103 +264,64 @@ def run_task(self, fw_spec): renorm_temp = np.array(self.get("renorm_temp")) renorm_temp.sort() renorm_method = self.get("renorm_method") - nconfig0 = self.get("nconfig") + nconfig = self.get("nconfig") conv_thresh = self.get("conv_thresh") max_iter = self.get("max_iter") renorm_TE_iter = self.get("renorm_TE_iter") bulk_modulus = self.get("bulk_modulus") # Renormalization with DFT lattice - - # Parallel version -# renorm_data = Parallel(n_jobs=len(renorm_temp), backend="multiprocessing")(delayed(run_renormalization)( -# parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, max_iter, -# conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) for t, T in enumerate(renorm_temp)) - - # Serial version - likely better because it allows parallelization over A matrix construction, - # which takes most of the time during renormalization, and leaves no process idling around when - # low temperature renormalizations finish early - renorm_data = [] - for t, T in enumerate(renorm_temp): - nconfig = nconfig0*(1+np.mod(T,100)) - data_T = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, - max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) - renorm_data.append(data_T) + renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, + max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) # Additional renormalization with thermal expansion - optional - just single "iteration" for now if renorm_TE_iter: - n_TE_iter = 1 - for i in range(n_TE_iter): - logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) - - if i==0: # first iteration - pull only cases where phonon is all real and order by temperature - T_real = [] - dLfrac_real = [] - param_real = [] - for result in renorm_data: - if result is None: # failed or incomplete + n_TE_iter = 1 + if renorm_data is None: # failed or incomplete + pass + elif result["n_imaginary"] > 0: # still has imaginary frequencies + pass + else: + for i in range(n_TE_iter): + logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) + if i==0: # first iteration - pull only cases where phonon is all real and order by temperature + if renorm_data is None: # failed or incomplete continue elif result["n_imaginary"] < 0: # still imaginary continue - else: - T_real = T_real + result["temperature"] - dLfrac_real = dLfrac_real + result["expansion_ratio"] - param_real = param_real + result["param"] - if len(T_real)==0: - logger.info("No cases with real phonons - cannot do thermal expansion for any temperature") - break - else: - for t,result in enumerate(renorm_data): - dLfrac_real[t] = result["expansion_ratio"] - param_real[t] = result["param"] - - parent_structure_TE, cs_TE, fcs_TE = setup_TE_iter(cutoffs,parent_structure,T_real,dLfrac_real) - param_TE = copy(param_real) - prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) - prim_phonopy_TE = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), - scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) - phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) - - # Parallel -# renorm_data = Parallel(n_jobs=len(T_real), backend="multiprocessing")(delayed(run_renormalization)( -# parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, cs_TE[t], fcs_TE[t], param_TE[t], -# T, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE -# ) for t, T in enumerate(T_real) -# ) - - # Serial - renorm_data_TE = [] - for t, T in enumerate(T_real): - data_T = run_renormalization(parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, - cs_TE[t], fcs_TE[t], param_TE[t], T, nconfig, max_iter, conv_thresh, - renorm_method, fit_method, bulk_modulus, phonopy_TE) - renorm_data_TE.append(data_T) - - if len(T_real) > 0: - for t, result in enumerate(renorm_data_TE): - temp_index = np.where(renorm_temp==T_real[t])[0][0] - renorm_data[temp_index] = result - + if i > 0: + dLfrac = renorm_data["expansion_ratio"] + param = renorm_data["param"] + + parent_structure_TE, cs_TE, fcs_TE = setup_TE_iter(cutoffs,parent_structure,T,dLfrac) + param_TE = copy(param) + prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) + prim_phonopy_TE = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), + scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) + phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) + + renorm_data = run_renormalization(parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, + cs_TE[t], fcs_TE[t], param_TE[t], T, nconfig, max_iter, conv_thresh, + renorm_method, fit_method, bulk_modulus, phonopy_TE) + # write results logger.info("Writing renormalized results") thermal_keys = ["temperature","free_energy","entropy","heat_capacity", "gruneisen","thermal_expansion","expansion_ratio","free_energy_correction"] renorm_thermal_data = {key: [] for key in thermal_keys} - for t, result in enumerate(renorm_data): - logger.info("DEBUG: ",result) - T = result["temperature"] - fcs = result["fcs"] - fcs.write("force_constants_{}K.fcs".format(T)) - np.savetxt('parameters_{}K.txt'.format(T),result["param"]) - for key in thermal_keys: - renorm_thermal_data[key].append(result[key]) - if result["n_imaginary"] > 0: - logger.warning('Imaginary modes exist for {} K!'.format(T)) - logger.warning('ShengBTE files not written') - logger.warning('No renormalization with thermal expansion') - else: - logger.info("No imaginary modes! Writing ShengBTE files") - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(T), format="text") + logger.info("DEBUG: ",renorm_data) + fcs = renorm_data["fcs"] + fcs.write("force_constants_{}K.fcs".format(T)) + np.savetxt('parameters_{}K.txt'.format(T),renorm_data["param"]) + for key in thermal_keys: + renorm_thermal_data[key].append(renorm_data[key]) + if renorm_data["n_imaginary"] > 0: + logger.warning('Imaginary modes exist for {} K!'.format(T)) + logger.warning('ShengBTE files not written') + logger.warning('No renormalization with thermal expansion') + else: + logger.info("No imaginary modes! Writing ShengBTE files") + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(T), format="text") renorm_thermal_data.pop("n_imaginary") dumpfn(thermal_data, "renorm_thermal_data.json") diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index d18d1cc23..a0f62bd9b 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -219,7 +219,7 @@ def __init__( renorm_force_constants = RunHiPhiveRenorm( renorm_temp=temperature, renorm_method=renorm_method, - nconfig0=renorm_nconfig, + nconfig=renorm_nconfig, conv_thresh=renorm_conv_thresh, max_iter=renorm_max_iter, renorm_TE_iter=renorm_TE_iter, diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index e42345741..c1b995960 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -207,19 +207,21 @@ def get_lattice_dynamics_wf( # 3. Renormalization FW (pass_inputs like bulk modulus) if renormalize: - fw_renormalization = RenormalizationFW( - db_file=db_file, - temperature=renormalize_temperature, - renorm_method=renormalize_method, - renorm_nconfig=renormalize_nconfig, - renorm_conv_thresh=renormalize_conv_thresh, - renorm_max_iter=renormalize_max_iter, - renorm_TE_iter=renormalize_thermal_expansion_iter, - bulk_modulus=bulk_modulus, - mesh_density=mesh_density, + for T in renormalize_temperature: + nconfig = renormalize_nconfig*(1+np.mod(T,100)) + fw_renormalization = RenormalizationFW( + db_file=db_file, + temperature=temp, + renorm_method=renormalize_method, + renorm_nconfig=nconfig, + renorm_conv_thresh=renormalize_conv_thresh, + renorm_max_iter=renormalize_max_iter, + renorm_TE_iter=renormalize_thermal_expansion_iter, + bulk_modulus=bulk_modulus, + mesh_density=mesh_density, ) - wf.append_wf( - Workflow.from_Firework(fw_renormalization), [wf.fws[-1].fw_id] + wf.append_wf( + Workflow.from_Firework(fw_renormalization), [wf.fws[-1].fw_id] ) # 4. Lattice thermal conductivity calculation From 7737ba7225a1b09dc44ee17383ccb69096d99779 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 20 Mar 2023 00:37:01 -0400 Subject: [PATCH 160/207] parallel renormalization fireworks for each T --- atomate/vasp/workflows/base/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index c1b995960..eac66ed05 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -211,7 +211,7 @@ def get_lattice_dynamics_wf( nconfig = renormalize_nconfig*(1+np.mod(T,100)) fw_renormalization = RenormalizationFW( db_file=db_file, - temperature=temp, + temperature=T, renorm_method=renormalize_method, renorm_nconfig=nconfig, renorm_conv_thresh=renormalize_conv_thresh, From c1981f106a6b6bbf1045d61005e2856aef15761a Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 20 Mar 2023 00:39:46 -0400 Subject: [PATCH 161/207] parallel renormalization fireworks name --- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index a0f62bd9b..658d1695b 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -233,4 +233,4 @@ def __init__( pass_locs = PassCalcLocs(name=name) tasks = [copy_files, renorm_force_constants, to_db, pass_locs] - super().__init__(tasks, name=name, **kwargs) + super().__init__(tasks, name="{}_{}K".format(name,temperature), **kwargs) From 2ffa1c7fa8fb61c6848215132f196ea5566741c5 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Mon, 20 Mar 2023 00:41:21 -0400 Subject: [PATCH 162/207] renormalization klat dir link --- atomate/vasp/fireworks/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 658d1695b..f7f20ee2f 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -141,7 +141,7 @@ def __init__( if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: - copy_files = CopyFilesFromCalcLoc(calc_loc='Renormalization', filenames=files) + copy_files = CopyFilesFromCalcLoc(calc_loc='Renormalization_{}K'.format(temperature), filenames=files) os.system('mv FORCE_CONSTANTS_2ND_{}K FORCE_CONSTANTS_2ND'.format(temperature)) else: # only the default files are needed From 72de4a9cfd6b4f7f54e1482529d7bd9e5bd218a8 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Mon, 20 Mar 2023 07:53:18 -0700 Subject: [PATCH 163/207] TE iter fix --- atomate/vasp/analysis/lattice_dynamics.py | 43 +++++++--------- atomate/vasp/firetasks/lattice_dynamics.py | 57 ++++++++++------------ 2 files changed, 43 insertions(+), 57 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 535f55d88..77f954cf3 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -898,28 +898,21 @@ def run_renormalization( -def setup_TE_iter(cutoffs,parent_structure,temperatures,dLfracs): - parent_structure_TE = [] - cs_TE = [] - fcs_TE = [] - for t, (T,dLfrac) in enumerate(zip(temperatures,dLfracs)): - new_atoms = AseAtomsAdaptor.get_atoms(parent_structure) - new_cell = Cell(np.transpose([new_atoms.get_cell()[:,i]*(1+dLfrac[0,i]) for i in range(3)])) - new_atoms.set_cell(new_cell,scale_atoms=True) - new_parent_structure = AseAtomsAdaptor.get_structure(new_atoms) - new_supercell_atoms = AseAtomsAdaptor.get_atoms(new_parent_structure*supercell_matrix) - new_cutoffs = [i*(1+np.linalg.norm(dLfrac)) for i in cutoffs] - while True: - new_cs = ClusterSpace(atoms,new_cutoffs,1e-3,acoustic_sum_rules=True) - if cs_TD.n_dofs == cs.n_dofs: - break - elif cs_TD.n_dofs > cs.n_dofs: - new_cutoffs = [i*0.999 for i in new_cutoffs] - elif cs_TD.n_dofs < cs.n_dofs: - new_cutoffs = [i*1.001 for i in new_cutoffs] - cs_TE.append(new_cs) - parent_structure_TE.append(new_parent_structure) - new_fcp = ForceConstantsPotential(new_cs,param_real[t]) - fcs_TE.append(new_fcp.get_force_constants(new_supercell_atoms)) - - return parent_structure_TE, cs_TE, fcs_TE +def setup_TE_iter(cs,cutoffs,parent_structure,param,temperatures,dLfrac): + new_atoms = AseAtomsAdaptor.get_atoms(parent_structure) + new_cell = Cell(np.transpose([new_atoms.get_cell()[:,i]*(1+dLfrac[0,i]) for i in range(3)])) + new_atoms.set_cell(new_cell,scale_atoms=True) + parent_structure_TE = AseAtomsAdaptor.get_structure(new_atoms) + supercell_atoms_TE = AseAtomsAdaptor.get_atoms(parent_structure_TE*supercell_matrix) + new_cutoffs = [i*(1+np.linalg.norm(dLfrac)) for i in cutoffs] + while True: + cs_TE = ClusterSpace(atoms,new_cutoffs,1e-3,acoustic_sum_rules=True) + if cs_TE.n_dofs == cs.n_dofs: + break + elif cs_TE.n_dofs > cs.n_dofs: + new_cutoffs = [i*0.999 for i in new_cutoffs] + elif cs_TE.n_dofs < cs.n_dofs: + new_cutoffs = [i*1.001 for i in new_cutoffs] + new_fcp = ForceConstantsPotential(cs_TE,param) + fcs_TE.append(new_fcp.get_force_constants(supercell_atoms_TE)) + return parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 8c9d6be5e..a7ef4a594 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -262,7 +262,6 @@ def run_task(self, fw_spec): supercell_matrix = np.array(structure_data["supercell_matrix"]) renorm_temp = np.array(self.get("renorm_temp")) - renorm_temp.sort() renorm_method = self.get("renorm_method") nconfig = self.get("nconfig") conv_thresh = self.get("conv_thresh") @@ -271,38 +270,32 @@ def run_task(self, fw_spec): bulk_modulus = self.get("bulk_modulus") # Renormalization with DFT lattice - renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, T, nconfig, - max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) + renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, renorm_temp, + nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) # Additional renormalization with thermal expansion - optional - just single "iteration" for now if renorm_TE_iter: n_TE_iter = 1 - if renorm_data is None: # failed or incomplete - pass - elif result["n_imaginary"] > 0: # still has imaginary frequencies - pass - else: - for i in range(n_TE_iter): + for i in range(n_TE_iter): + if renorm_data is None: # failed or incomplete + break + elif result["n_imaginary"] < 0: # still imaginary + break + else: logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) - if i==0: # first iteration - pull only cases where phonon is all real and order by temperature - if renorm_data is None: # failed or incomplete - continue - elif result["n_imaginary"] < 0: # still imaginary - continue - if i > 0: - dLfrac = renorm_data["expansion_ratio"] - param = renorm_data["param"] - - parent_structure_TE, cs_TE, fcs_TE = setup_TE_iter(cutoffs,parent_structure,T,dLfrac) - param_TE = copy(param) - prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) - prim_phonopy_TE = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), - scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) - phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) - - renorm_data = run_renormalization(parent_structure_TE[t], supercell_atoms_TE[t], supercell_matrix, - cs_TE[t], fcs_TE[t], param_TE[t], T, nconfig, max_iter, conv_thresh, - renorm_method, fit_method, bulk_modulus, phonopy_TE) + + dLfrac = renorm_data["expansion_ratio"] + param = renorm_data["param"] + + parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE = setup_TE_iter(cs,cutoffs,parent_structure,param,renorm_temp,dLfrac) + prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) + prim_TE_phonopy = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), + scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) + phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) + + renorm_data = run_renormalization(parent_structure_TE, supercell_atoms_TE, supercell_matrix, + cs_TE, fcs_TE, param, renorm_temp, nconfig, max_iter, + conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE) # write results logger.info("Writing renormalized results") @@ -311,17 +304,17 @@ def run_task(self, fw_spec): renorm_thermal_data = {key: [] for key in thermal_keys} logger.info("DEBUG: ",renorm_data) fcs = renorm_data["fcs"] - fcs.write("force_constants_{}K.fcs".format(T)) - np.savetxt('parameters_{}K.txt'.format(T),renorm_data["param"]) + fcs.write("force_constants_{}K.fcs".format(renorm_temp)) + np.savetxt('parameters_{}K.txt'.format(renorm_temp),renorm_data["param"]) for key in thermal_keys: renorm_thermal_data[key].append(renorm_data[key]) if renorm_data["n_imaginary"] > 0: - logger.warning('Imaginary modes exist for {} K!'.format(T)) + logger.warning('Imaginary modes exist for {} K!'.format(renorm_temp)) logger.warning('ShengBTE files not written') logger.warning('No renormalization with thermal expansion') else: logger.info("No imaginary modes! Writing ShengBTE files") - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(T), format="text") + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(renorm_temp), format="text") renorm_thermal_data.pop("n_imaginary") dumpfn(thermal_data, "renorm_thermal_data.json") From a1e43e4859bfa952f3786e894d27c0e57d0dce9c Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Mon, 20 Mar 2023 09:11:03 -0700 Subject: [PATCH 164/207] anything? --- atomate/vasp/analysis/lattice_dynamics.py | 4 +++ atomate/vasp/firetasks/lattice_dynamics.py | 27 ++++++++++--------- atomate/vasp/fireworks/lattice_dynamics.py | 15 ++++++----- .../vasp/workflows/base/lattice_dynamics.py | 7 ++--- 4 files changed, 30 insertions(+), 23 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 77f954cf3..5a5fe1329 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -863,6 +863,10 @@ def run_renormalization( A tuple of the number of imaginary modes at Gamma, the minimum phonon frequency at Gamma, and the free energy, entropy, and heat capacity """ + + print("nconfig ANAL",type(nconfig),nconfig) + print('T ANAL',T) + nconfig = int(nconfig) renorm = Renormalization(cs,supercell,fcs,param,T,renorm_method,fit_method) fcp, fcs, param = renorm.renormalize(nconfig,conv_tresh) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index a7ef4a594..45d8eadec 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -227,19 +227,19 @@ def run_task(self, fw_spec): @explicit_serialize class RunHiPhiveRenorm(FiretaskBase): """ - Perform phonon renormalization to obtain temperature-dependent force constants + Perform phonon renormalization to obtain dependent-temperature force constants using hiPhive. Requires "structure_data.json" to be present in the current working directory. Required parameters: Optional parameter: - renorm_temp (List): list of temperatures to perform renormalization - defaults to T_RENORM - renorm_with_te (bool): if True, perform outer iteration over thermally expanded volumes + temperature (List): list of temperatures to perform renormalization - defaults to T_RENORM + renorm_TE_iter (bool): if True, perform outer iteration over thermally expanded volumes bulk_modulus (float): input bulk modulus - required for thermal expansion iterations """ - optional_params = ["renorm_method","renorm_temp","nconfig","conv_thresh","max_iter", + optional_params = ["renorm_method","temperature","nconfig","conv_thresh","max_iter", "renorm_TE_iter","bulk_modulus","imaginary_tol"] @requires(hiphive, "hiphive is required for lattice dynamics workflow") @@ -261,7 +261,7 @@ def run_task(self, fw_spec): supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) supercell_matrix = np.array(structure_data["supercell_matrix"]) - renorm_temp = np.array(self.get("renorm_temp")) + temperature = np.array(self.get("temperature")) renorm_method = self.get("renorm_method") nconfig = self.get("nconfig") conv_thresh = self.get("conv_thresh") @@ -269,8 +269,9 @@ def run_task(self, fw_spec): renorm_TE_iter = self.get("renorm_TE_iter") bulk_modulus = self.get("bulk_modulus") - # Renormalization with DFT lattice - renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, renorm_temp, + # Renormalization with DFT lattice + print("nconfig FT",type(nconfig),nconfig) + renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, temperature, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) # Additional renormalization with thermal expansion - optional - just single "iteration" for now @@ -287,14 +288,14 @@ def run_task(self, fw_spec): dLfrac = renorm_data["expansion_ratio"] param = renorm_data["param"] - parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE = setup_TE_iter(cs,cutoffs,parent_structure,param,renorm_temp,dLfrac) + parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE = setup_TE_iter(cs,cutoffs,parent_structure,param,temperature,dLfrac) prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) prim_TE_phonopy = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) renorm_data = run_renormalization(parent_structure_TE, supercell_atoms_TE, supercell_matrix, - cs_TE, fcs_TE, param, renorm_temp, nconfig, max_iter, + cs_TE, fcs_TE, param, temperature, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE) # write results @@ -304,17 +305,17 @@ def run_task(self, fw_spec): renorm_thermal_data = {key: [] for key in thermal_keys} logger.info("DEBUG: ",renorm_data) fcs = renorm_data["fcs"] - fcs.write("force_constants_{}K.fcs".format(renorm_temp)) - np.savetxt('parameters_{}K.txt'.format(renorm_temp),renorm_data["param"]) + fcs.write("force_constants_{}K.fcs".format(temperature)) + np.savetxt('parameters_{}K.txt'.format(temperature),renorm_data["param"]) for key in thermal_keys: renorm_thermal_data[key].append(renorm_data[key]) if renorm_data["n_imaginary"] > 0: - logger.warning('Imaginary modes exist for {} K!'.format(renorm_temp)) + logger.warning('Imaginary modes exist for {} K!'.format(temperature)) logger.warning('ShengBTE files not written') logger.warning('No renormalization with thermal expansion') else: logger.info("No imaginary modes! Writing ShengBTE files") - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(renorm_temp), format="text") + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(temperature), format="text") renorm_thermal_data.pop("n_imaginary") dumpfn(thermal_data, "renorm_thermal_data.json") diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index f7f20ee2f..147dff8e5 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -195,9 +195,9 @@ def __init__( self, temperature: Union[float, Dict], renorm_method: str, - renorm_nconfig: int, - renorm_conv_thresh: float, - renorm_max_iter: float, + nconfig: int, + conv_thresh: float, + max_iter: float, renorm_TE_iter: bool, bulk_modulus: float, mesh_density: float, @@ -216,12 +216,13 @@ def __init__( else: copy_files = CopyFilesFromCalcLoc(calc_loc="Fit Force Constants", filenames=files) + print('nconfig in FW',type(nconfig),nconfig) renorm_force_constants = RunHiPhiveRenorm( - renorm_temp=temperature, + temperature=temperature, renorm_method=renorm_method, - nconfig=renorm_nconfig, - conv_thresh=renorm_conv_thresh, - max_iter=renorm_max_iter, + nconfig=nconfig, + conv_thresh=conv_thresh, + max_iter=max_iter, renorm_TE_iter=renorm_TE_iter, bulk_modulus=bulk_modulus, **kwargs diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index eac66ed05..14077683f 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -209,13 +209,14 @@ def get_lattice_dynamics_wf( if renormalize: for T in renormalize_temperature: nconfig = renormalize_nconfig*(1+np.mod(T,100)) + print("nconfig in WF",type(nconfig),nconfig) fw_renormalization = RenormalizationFW( db_file=db_file, temperature=T, renorm_method=renormalize_method, - renorm_nconfig=nconfig, - renorm_conv_thresh=renormalize_conv_thresh, - renorm_max_iter=renormalize_max_iter, + nconfig=nconfig, + conv_thresh=renormalize_conv_thresh, + max_iter=renormalize_max_iter, renorm_TE_iter=renormalize_thermal_expansion_iter, bulk_modulus=bulk_modulus, mesh_density=mesh_density, From cb039d220b451840e36262bcef4a1251c9448be9 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Mon, 20 Mar 2023 13:58:53 -0700 Subject: [PATCH 165/207] ToDB --- atomate/vasp/analysis/lattice_dynamics.py | 20 ++-- atomate/vasp/firetasks/lattice_dynamics.py | 95 ++++++++++--------- atomate/vasp/fireworks/lattice_dynamics.py | 7 +- .../vasp/workflows/base/lattice_dynamics.py | 5 +- 4 files changed, 64 insertions(+), 63 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 5a5fe1329..ab0f2bc25 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -271,8 +271,7 @@ def fit_force_constants( if fit_method == "rfe" and n_jobs == -1: fit_kwargs["n_jobs"] = 1 - logger.info('CPU COUNT: {}'.format(os.cpu_count())) - cutoff_results = Parallel(n_jobs=12, backend="multiprocessing")(delayed(_run_cutoffs)( + cutoff_results = Parallel(n_jobs=min(os.cpu_count(),len(all_cutoffs)), backend="multiprocessing")(delayed(_run_cutoffs)( i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, fit_method, separate_fit, disp_cut, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) @@ -864,8 +863,6 @@ def run_renormalization( frequency at Gamma, and the free energy, entropy, and heat capacity """ - print("nconfig ANAL",type(nconfig),nconfig) - print('T ANAL',T) nconfig = int(nconfig) renorm = Renormalization(cs,supercell,fcs,param,T,renorm_method,fit_method) fcp, fcs, param = renorm.renormalize(nconfig,conv_tresh) @@ -881,16 +878,19 @@ def run_renormalization( ) else: anharmonic_data = dict() -# anharmonic_data["temperature"] = T -# anharmonic_data["gruneisen"] = np.array([[0,0,0]]) -# anharmonic_data["thermal_expansion"] = np.array([[0,0,0]]) -# anharmonic_data["expansion_ratio"] = np.array([[0,0,0]]) + anharmonic_data["temperature"] = T + anharmonic_data["gruneisen"] = np.array([[0,0,0]]) + anharmonic_data["thermal_expansion"] = np.array([[0,0,0]]) + anharmonic_data["expansion_ratio"] = np.array([[0,0,0]]) renorm_data.update(anharmonic_data) - + + phonopy_orig.run_mesh() + phonopy.run_mesh() omega0 = phonopy_orig.mesh.frequencies # THz omega_TD = phonopy.mesh.frequencies # THz + evec = phonopy.mesh.eigenvectors # natom = phonopy.primitive.get_number_of_atoms() - correction_S, correction_SC = FE_correction(omega0,omega_TD,T) # eV/atom + correction_S, correction_SC = FE_correction(omega0,omega_TD,evec,[T]) # eV/atom renorm_data["free_energy_correction_S"] = correction_S[0] renorm_data["free_energy_correction_SC"] = correction_SC[0] diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 45d8eadec..be8b4b48c 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -234,7 +234,7 @@ class RunHiPhiveRenorm(FiretaskBase): Required parameters: Optional parameter: - temperature (List): list of temperatures to perform renormalization - defaults to T_RENORM + temperature (float): temperature to perform renormalization renorm_TE_iter (bool): if True, perform outer iteration over thermally expanded volumes bulk_modulus (float): input bulk modulus - required for thermal expansion iterations """ @@ -261,7 +261,7 @@ def run_task(self, fw_spec): supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) supercell_matrix = np.array(structure_data["supercell_matrix"]) - temperature = np.array(self.get("temperature")) + temperature = self.get("temperature") renorm_method = self.get("renorm_method") nconfig = self.get("nconfig") conv_thresh = self.get("conv_thresh") @@ -270,7 +270,6 @@ def run_task(self, fw_spec): bulk_modulus = self.get("bulk_modulus") # Renormalization with DFT lattice - print("nconfig FT",type(nconfig),nconfig) renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, temperature, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) @@ -297,11 +296,14 @@ def run_task(self, fw_spec): renorm_data = run_renormalization(parent_structure_TE, supercell_atoms_TE, supercell_matrix, cs_TE, fcs_TE, param, temperature, nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE) + structure_data["structure"] = parent_structure_TE + structure_data["supercell_structure"] = AseAtomsAdaptor.get_structure(supercell_atoms_TE) # write results logger.info("Writing renormalized results") thermal_keys = ["temperature","free_energy","entropy","heat_capacity", - "gruneisen","thermal_expansion","expansion_ratio","free_energy_correction"] + "gruneisen","thermal_expansion","expansion_ratio", + "free_energy_correction_S","free_energy_correction_SC"] renorm_thermal_data = {key: [] for key in thermal_keys} logger.info("DEBUG: ",renorm_data) fcs = renorm_data["fcs"] @@ -310,15 +312,15 @@ def run_task(self, fw_spec): for key in thermal_keys: renorm_thermal_data[key].append(renorm_data[key]) if renorm_data["n_imaginary"] > 0: - logger.warning('Imaginary modes exist for {} K!'.format(temperature)) + logger.warning('Imaginary modes remain for {} K!'.format(temperature)) logger.warning('ShengBTE files not written') logger.warning('No renormalization with thermal expansion') else: logger.info("No imaginary modes! Writing ShengBTE files") fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(temperature), format="text") - renorm_thermal_data.pop("n_imaginary") - dumpfn(thermal_data, "renorm_thermal_data.json") + dumpfn(structure_data, "structure_data_{}K.json".format(temperature)) + dumpfn(renorm_thermal_data, "renorm_thermal_data_{}K.json".format(temperature)) @explicit_serialize @@ -346,7 +348,7 @@ class ForceConstantsToDb(FiretaskBase): """ required_params = ["db_file"] - optional_params = ["renormalized","mesh_density", "additional_fields"] + optional_params = ["renormalized","renorm_temperature","mesh_density", "additional_fields"] @requires(hiphive, "hiphive is required for lattice dynamics workflow") def run_task(self, fw_spec): @@ -354,18 +356,17 @@ def run_task(self, fw_spec): db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) renormalized = self.get("renormalized", False) + renorm_temperature = self.get("renorm_temperature", None) mesh_density = self.get("mesh_density", 100.0) - structure_data = loadfn("structure_data.json") - forces = loadfn("perturbed_forces.json") - structures = loadfn("perturbed_structures.json") - + structure_data = loadfn("structure_data.json") structure = structure_data["structure"] supercell_structure = structure_data["supercell_structure"] supercell_matrix = structure_data["supercell_matrix"] if not renormalized: - + perturbed_structures = loadfn("perturbed_structures.json") + forces = loadfn("perturbed_forces.json") fitting_data = loadfn("fitting_data.json") thermal_data = loadfn("thermal_data.json") fcs = ForceConstants.read("force_constants.fcs") @@ -381,7 +382,7 @@ def run_task(self, fw_spec): "structure": structure.as_dict(), "supercell_matrix": supercell_matrix, "supercell_structure": supercell_structure.as_dict(), - "perturbed_structures": [s.as_dict() for s in structures], + "perturbed_structures": [s.as_dict() for s in perturbed_structures], "perturbed_forces": [f.tolist() for f in forces], "fitting_data": fitting_data, "thermal_data": thermal_data, @@ -403,41 +404,41 @@ def run_task(self, fw_spec): logger.info("Finished inserting force constants and phonon data") else: - renorm_thermal_data = loadfn("renorm_thermal_data.json") - temperature = renorm_thermal_data["temperature"] - - # pushing data for individual temperature - for t, T in enumerate(temperature): - fcs = ForceConstants.read("force_constants_{}K.fcs".format(T)) - phonopy_fc = fcs.get_fc_array(order=2) - dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( - structure, supercell_matrix, phonopy_fc, mesh_density, mmdb - ) + T = renorm_temperature + renorm_thermal_data = loadfn("renorm_thermal_data_{}.json".format(T)) + fcs = ForceConstants.read("force_constants_{}K.fcs".format(T)) + + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, fcs, mesh_density, mmdb + ) - data_at_T = { - "created_at": datetime.utcnow(), - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, - "renormalized": renormalized, - "temperature": T, - "force_constants_fs_id": fc_fsid, - "thermal_data": renorm_thermal_data[t], - "phonon_dos_fs_id": dos_fsid, - "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, - "phonon_bandstructure_line_fs_id": lm_bs_fsid, - } - data_at_T.update(self.get("additional_fields", {})) + data_at_T = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix, + "supercell_structure": supercell_structure.as_dict(), + "renormalized": renormalized, + "temperature": T, + "thermal_data": renorm_thermal_data, + "force_constants_fs_id": fc_fsid, + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + } + data_at_T.update(self.get("additional_fields", {})) - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} - data_at_T.update(metadata) - data_at_T = jsanitize(data,strict=True,allow_bson=True) - - mmdb.db.renormalized_lattice_dynamics.insert_one(data_at_T) - - logger.info("Finished inserting renormalized force constants and phonon data at {} K".format(T)) - + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + data_at_T.update(metadata) + data_at_T = jsanitize(data,strict=True,allow_bson=True) + + mmdb.db.renormalized_lattice_dynamics.insert_one(data_at_T) + + logger.info("Finished inserting renormalized force constants and phonon data at {} K".format(T)) + return FWAction(update_spec=metadata) diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 147dff8e5..827f495f2 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -211,12 +211,12 @@ def __init__( files = ["cluster_space.cs","parameters.txt","force_constants.fcs", "structure_data.json","fitting_data.json","phonopy_orig.yaml"] + name = name+"_{}K".format(temperature) if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: copy_files = CopyFilesFromCalcLoc(calc_loc="Fit Force Constants", filenames=files) - print('nconfig in FW',type(nconfig),nconfig) renorm_force_constants = RunHiPhiveRenorm( temperature=temperature, renorm_method=renorm_method, @@ -229,9 +229,10 @@ def __init__( ) to_db = ForceConstantsToDb( - db_file=db_file, renormalized=True, mesh_density=mesh_density, additional_fields={} + db_file=db_file, renormalized=True, renorm_temperature = temperature, + mesh_density=mesh_density, additional_fields={} ) pass_locs = PassCalcLocs(name=name) tasks = [copy_files, renorm_force_constants, to_db, pass_locs] - super().__init__(tasks, name="{}_{}K".format(name,temperature), **kwargs) + super().__init__(tasks, name=name, **kwargs) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 14077683f..5ccf75b17 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -207,12 +207,11 @@ def get_lattice_dynamics_wf( # 3. Renormalization FW (pass_inputs like bulk modulus) if renormalize: - for T in renormalize_temperature: + for temperature in renormalize_temperature: nconfig = renormalize_nconfig*(1+np.mod(T,100)) - print("nconfig in WF",type(nconfig),nconfig) fw_renormalization = RenormalizationFW( db_file=db_file, - temperature=T, + temperature=temperature, renorm_method=renormalize_method, nconfig=nconfig, conv_thresh=renormalize_conv_thresh, From 6b8f0b77c6ae58a0a9ff33509bd7580d396731cc Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Mon, 20 Mar 2023 14:00:25 -0700 Subject: [PATCH 166/207] error fix --- atomate/vasp/workflows/base/lattice_dynamics.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 5ccf75b17..b73f59fc2 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -208,7 +208,7 @@ def get_lattice_dynamics_wf( # 3. Renormalization FW (pass_inputs like bulk modulus) if renormalize: for temperature in renormalize_temperature: - nconfig = renormalize_nconfig*(1+np.mod(T,100)) + nconfig = renormalize_nconfig*(1+np.mod(temperature,100)) fw_renormalization = RenormalizationFW( db_file=db_file, temperature=temperature, From ff3c44029b5660c5fbb9bd7897420735e7f8a680 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Mon, 20 Mar 2023 18:41:45 -0700 Subject: [PATCH 167/207] renormalization works --- atomate/vasp/firetasks/lattice_dynamics.py | 4 ++-- atomate/vasp/workflows/base/lattice_dynamics.py | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index be8b4b48c..ad301b192 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -405,7 +405,7 @@ def run_task(self, fw_spec): else: T = renorm_temperature - renorm_thermal_data = loadfn("renorm_thermal_data_{}.json".format(T)) + renorm_thermal_data = loadfn("renorm_thermal_data_{}K.json".format(T)) fcs = ForceConstants.read("force_constants_{}K.fcs".format(T)) dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( @@ -433,7 +433,7 @@ def run_task(self, fw_spec): fitting_id = _get_fc_fitting_id(mmdb) metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} data_at_T.update(metadata) - data_at_T = jsanitize(data,strict=True,allow_bson=True) + data_at_T = jsanitize(data_at_T,strict=True,allow_bson=True) mmdb.db.renormalized_lattice_dynamics.insert_one(data_at_T) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index b73f59fc2..a42bb962b 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -208,7 +208,7 @@ def get_lattice_dynamics_wf( # 3. Renormalization FW (pass_inputs like bulk modulus) if renormalize: for temperature in renormalize_temperature: - nconfig = renormalize_nconfig*(1+np.mod(temperature,100)) + nconfig = renormalize_nconfig*(1+temperature//100) fw_renormalization = RenormalizationFW( db_file=db_file, temperature=temperature, From 95e2b23626092c09a798c09ae74981bfe09e53ee Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Tue, 21 Mar 2023 08:47:45 -0700 Subject: [PATCH 168/207] anything? --- atomate/vasp/analysis/lattice_dynamics.py | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index ab0f2bc25..69bafa131 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -63,7 +63,7 @@ RENORM_CONV_THRESH = 0.1 # meV/atom RENORM_MAX_ITER = 30 -eV2J = 1.602e-19 +eV2J = sp.constants.elementary_charge hbar = sp.constants.hbar # J-s kB = sp.constants.Boltzmann # J/K @@ -864,6 +864,7 @@ def run_renormalization( """ nconfig = int(nconfig) + nconfig *= 8 renorm = Renormalization(cs,supercell,fcs,param,T,renorm_method,fit_method) fcp, fcs, param = renorm.renormalize(nconfig,conv_tresh) From 7cfbba78db6da2c248194fed1c58e3db72719939 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Tue, 21 Mar 2023 12:26:27 -0700 Subject: [PATCH 169/207] renorm data push --- atomate/vasp/analysis/lattice_dynamics.py | 1 - atomate/vasp/firetasks/lattice_dynamics.py | 29 +++++++++------------- 2 files changed, 12 insertions(+), 18 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 69bafa131..02f4dc409 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -864,7 +864,6 @@ def run_renormalization( """ nconfig = int(nconfig) - nconfig *= 8 renorm = Renormalization(cs,supercell,fcs,param,T,renorm_method,fit_method) fcp, fcs, param = renorm.renormalize(nconfig,conv_tresh) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index ad301b192..2286f7d87 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -301,16 +301,7 @@ def run_task(self, fw_spec): # write results logger.info("Writing renormalized results") - thermal_keys = ["temperature","free_energy","entropy","heat_capacity", - "gruneisen","thermal_expansion","expansion_ratio", - "free_energy_correction_S","free_energy_correction_SC"] - renorm_thermal_data = {key: [] for key in thermal_keys} logger.info("DEBUG: ",renorm_data) - fcs = renorm_data["fcs"] - fcs.write("force_constants_{}K.fcs".format(temperature)) - np.savetxt('parameters_{}K.txt'.format(temperature),renorm_data["param"]) - for key in thermal_keys: - renorm_thermal_data[key].append(renorm_data[key]) if renorm_data["n_imaginary"] > 0: logger.warning('Imaginary modes remain for {} K!'.format(temperature)) logger.warning('ShengBTE files not written') @@ -320,7 +311,7 @@ def run_task(self, fw_spec): fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(temperature), format="text") dumpfn(structure_data, "structure_data_{}K.json".format(temperature)) - dumpfn(renorm_thermal_data, "renorm_thermal_data_{}K.json".format(temperature)) + dumpfn(renorm_thermal_data, "renorm_data_{}K.json".format(temperature)) @explicit_serialize @@ -395,7 +386,7 @@ def run_task(self, fw_spec): # Get an id for the force constants fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "renormalization_dir": os.getcwd()} + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} data.update(metadata) data = jsanitize(data,strict=True,allow_bson=True) @@ -405,9 +396,15 @@ def run_task(self, fw_spec): else: T = renorm_temperature - renorm_thermal_data = loadfn("renorm_thermal_data_{}K.json".format(T)) - fcs = ForceConstants.read("force_constants_{}K.fcs".format(T)) - + renorm_data = loadfn("renorm_data_{}K.json".format(T)) + fcs = renorm_data["fcs"] + thermal_keys = ["temperature","free_energy","entropy","heat_capacity", + "gruneisen","thermal_expansion","expansion_ratio", + "free_energy_correction_S","free_energy_correction_SC"] + renorm_thermal_data = {key: [] for key in thermal_keys} + for key in thermal_keys: + renorm_thermal_data[key].append(renorm_data[key]) + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( structure, supercell_matrix, fcs, mesh_density, mmdb ) @@ -419,8 +416,6 @@ def run_task(self, fw_spec): "structure": structure.as_dict(), "supercell_matrix": supercell_matrix, "supercell_structure": supercell_structure.as_dict(), - "renormalized": renormalized, - "temperature": T, "thermal_data": renorm_thermal_data, "force_constants_fs_id": fc_fsid, "phonon_dos_fs_id": dos_fsid, @@ -431,7 +426,7 @@ def run_task(self, fw_spec): # Get an id for the force constants fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + metadata = {"fc_fitting_id": fitting_id, "renormalization_dir": os.getcwd()} data_at_T.update(metadata) data_at_T = jsanitize(data_at_T,strict=True,allow_bson=True) From f97213e973176da695c33bfe30f57b7c6cc48e04 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Wed, 22 Mar 2023 20:36:15 -0700 Subject: [PATCH 170/207] renorm_thermal_data --- atomate/vasp/firetasks/lattice_dynamics.py | 22 +++++++++++++--------- 1 file changed, 13 insertions(+), 9 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 2286f7d87..4ee629ad4 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -301,6 +301,16 @@ def run_task(self, fw_spec): # write results logger.info("Writing renormalized results") + renorm_thermal_data = dict() + fcs = renorm_data['fcs'] + fcs.write("force_constants_{}K.fcs".format(temperature)) + thermal_keys = ["temperature","free_energy","entropy","heat_capacity", + "gruneisen","thermal_expansion","expansion_ratio", + "free_energy_correction_S","free_energy_correction_SC"] + renorm_thermal_data = {key: [] for key in thermal_keys} + for key in thermal_keys: + renorm_thermal_data[key].append(renorm_data[key]) + logger.info("DEBUG: ",renorm_data) if renorm_data["n_imaginary"] > 0: logger.warning('Imaginary modes remain for {} K!'.format(temperature)) @@ -311,7 +321,7 @@ def run_task(self, fw_spec): fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(temperature), format="text") dumpfn(structure_data, "structure_data_{}K.json".format(temperature)) - dumpfn(renorm_thermal_data, "renorm_data_{}K.json".format(temperature)) + dumpfn(renorm_thermal_data, "renorm_thermal_data_{}K.json".format(temperature)) @explicit_serialize @@ -396,14 +406,8 @@ def run_task(self, fw_spec): else: T = renorm_temperature - renorm_data = loadfn("renorm_data_{}K.json".format(T)) - fcs = renorm_data["fcs"] - thermal_keys = ["temperature","free_energy","entropy","heat_capacity", - "gruneisen","thermal_expansion","expansion_ratio", - "free_energy_correction_S","free_energy_correction_SC"] - renorm_thermal_data = {key: [] for key in thermal_keys} - for key in thermal_keys: - renorm_thermal_data[key].append(renorm_data[key]) + renorm_thermal_data = loadfn("renorm_thermal_data_{}K.json".format(T)) + fcs = ForceConstants.read("force_constants_{}K.fcs".format(T)) dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( structure, supercell_matrix, fcs, mesh_density, mmdb From 940bae9b7ae6d42f19574758ad589a9b774ccfd9 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Thu, 23 Mar 2023 00:24:39 -0400 Subject: [PATCH 171/207] dependencies --- atomate/vasp/firetasks/lattice_dynamics.py | 14 ++--- atomate/vasp/fireworks/lattice_dynamics.py | 40 ++++-------- .../vasp/workflows/base/lattice_dynamics.py | 62 ++++++++++++------- 3 files changed, 59 insertions(+), 57 deletions(-) diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 4ee629ad4..4a571b51f 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -303,7 +303,7 @@ def run_task(self, fw_spec): logger.info("Writing renormalized results") renorm_thermal_data = dict() fcs = renorm_data['fcs'] - fcs.write("force_constants_{}K.fcs".format(temperature)) + fcs.write("force_constants.fcs") thermal_keys = ["temperature","free_energy","entropy","heat_capacity", "gruneisen","thermal_expansion","expansion_ratio", "free_energy_correction_S","free_energy_correction_SC"] @@ -318,10 +318,10 @@ def run_task(self, fw_spec): logger.warning('No renormalization with thermal expansion') else: logger.info("No imaginary modes! Writing ShengBTE files") - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND_{}K".format(temperature), format="text") + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND".format(temperature), format="text") - dumpfn(structure_data, "structure_data_{}K.json".format(temperature)) - dumpfn(renorm_thermal_data, "renorm_thermal_data_{}K.json".format(temperature)) + dumpfn(structure_data, "structure_data.json".format(temperature)) + dumpfn(renorm_thermal_data, "renorm_thermal_data.json".format(temperature)) @explicit_serialize @@ -405,9 +405,9 @@ def run_task(self, fw_spec): logger.info("Finished inserting force constants and phonon data") else: - T = renorm_temperature - renorm_thermal_data = loadfn("renorm_thermal_data_{}K.json".format(T)) - fcs = ForceConstants.read("force_constants_{}K.fcs".format(T)) + renorm_thermal_data = loadfn("renorm_thermal_data.json") + fcs = ForceConstants.read("force_constants.fcs") + T = renorm_thermal_data["temperature"] dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( structure, supercell_matrix, fcs, mesh_density, mmdb diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 827f495f2..4adb1b157 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -122,34 +122,22 @@ def __init__( ): # files needed to run ShengBTE - if renormalized: # must check if FORCE_CONSTANTS_2ND_{T}K can be copied individually + + files = [ + "structure_data.json", + "FORCE_CONSTANTS_2ND", + "FORCE_CONSTANTS_3RD" + ] + + if renormalized: assert type(temperature) in [float,int] - files = [ - "structure_data.json", - "FORCE_CONSTANTS_2ND_{}K".format(temperature), - "FORCE_CONSTANTS_3RD" - ] -# temperature_copy = temperature[:] -# for t,T in enumerate(temperature_copy): -# try: -# files = files.append("FORCE_CONSTANTS_2ND_{}K".format(T)) -# except: -# logger.info("FORCE_CONSTANTS_2ND_{}K is missing".format(T)) -# logger.info("Renormalization must have failed at {} K".format(T)) -# logger.info("Cannot calculate thermal conductivity at {} K".format(T)) -# temperature.remove(T) + name = '{} at {}K'.format(name,temperature) if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: copy_files = CopyFilesFromCalcLoc(calc_loc='Renormalization_{}K'.format(temperature), filenames=files) - os.system('mv FORCE_CONSTANTS_2ND_{}K FORCE_CONSTANTS_2ND'.format(temperature)) - - else: # only the default files are needed - files = [ - "structure_data.json", - "FORCE_CONSTANTS_2ND", - "FORCE_CONSTANTS_3RD", - ] + + else: if prev_calc_dir: copy_files = CopyFiles(from_dir=prev_calc_dir, filenames=files) else: @@ -165,10 +153,8 @@ def __init__( shengbte_to_db = ShengBTEToDb(db_file=db_file, additional_fields={}) tasks = [copy_files, run_shengbte, shengbte_to_db] - if renormalized: - super().__init__(tasks, name=name+' at {}K'.format(temperature), **kwargs) - else: - super().__init__(tasks, name=name, **kwargs) + + super().__init__(tasks, name=name, **kwargs) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index a42bb962b..8dd9f6c4c 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -171,10 +171,13 @@ def get_lattice_dynamics_wf( ) supercell_matrix_kwargs["force_diagonal"] = True + logger.debug('Transforming supercell!') + logger.debug('KWARGS: \n {}'.format(supercell_matrix_kwargs)) st = CubicSupercellTransformation(**supercell_matrix_kwargs) supercell = st.apply_transformation(structure) supercell_matrix = st.transformation_matrix - + logger.debug('SUPERCELL MATRIX: \n {}'.format(supercell_matrix)) + if "n_configs_per_std" not in perturbed_structure_kwargs: n_supercells = get_num_supercells(supercell, **num_supercell_kwargs) perturbed_structure_kwargs["n_configs_per_std"] = n_supercells @@ -204,7 +207,8 @@ def get_lattice_dynamics_wf( imaginary_tol=IMAGINARY_TOL, ) wf.append_wf(Workflow.from_Firework(fw_fit_force_constant), wf.leaf_fw_ids) - + fitting_fw_id = wf.fws[-1].fw_id + # 3. Renormalization FW (pass_inputs like bulk modulus) if renormalize: for temperature in renormalize_temperature: @@ -221,40 +225,52 @@ def get_lattice_dynamics_wf( mesh_density=mesh_density, ) wf.append_wf( - Workflow.from_Firework(fw_renormalization), [wf.fws[-1].fw_id] + Workflow.from_Firework(fw_renormalization), [fitting_fw_id] ) # 4. Lattice thermal conductivity calculation if calculate_lattice_thermal_conductivity: if renormalize: - # Because of the way ShengBTE works, a temperature array that is not - # equally spaced out (T_step) requires submission for each temperature - for t,T in enumerate(renormalize_temperature): + temperatures = renormalize_temperature + else: + temperatures = thermal_conductivity_temperature + # Because of the way ShengBTE works, a temperature array that is not + # evenly spaced out (T_step) requires submission for each temperature + even_spacing = all(np.diff(temperatures)==np.diff(temperatures)[0]) + if even_spacing and not renormalize: + fw_lattice_conductivity = LatticeThermalConductivityFW( + db_file=db_file, + shengbte_cmd=shengbte_cmd, + renormalized=renormalize, + temperature=temperatures + ) + if shengbte_fworker: + fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker + wf.append_wf( + Workflow.from_Firework(fw_lattice_conductivity), [fitting_fw_id] + ) + else: + push = 1 + for t,T in enumerate(temperatures): if T == 0: + push = 0 continue fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, shengbte_cmd=shengbte_cmd, - renormalized=True, + renormalized=renormalize, temperature=T - ) + ) if shengbte_fworker: fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker - wf.append_wf( - Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-(t+1)].fw_id] + if renormalize: + wf.append_wf( + Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-(len(temperatures)+push)].fw_id] ) - else: - fw_lattice_conductivity = LatticeThermalConductivityFW( - db_file=db_file, - shengbte_cmd=shengbte_cmd, - renormalized=False, - temperature=thermal_conductivity_temperature, - ) - if shengbte_fworker: - fw_lattice_conductivity.spec["_fworker"] = shengbte_fworker - wf.append_wf( - Workflow.from_Firework(fw_lattice_conductivity), [wf.fws[-1].fw_id] - ) + else: + wf.append_wf( + Workflow.from_Firework(fw_lattice_conductivity), [fitting_fw_id] + ) formula = structure.composition.reduced_formula wf.name = "{} - lattice dynamics".format(formula) @@ -318,7 +334,7 @@ def get_perturbed_structure_wf( natoms = len(structure * supercell_matrix) if rattle_stds is None: - rattle_stds = np.linspace(0.008, 0.08, 5) + rattle_stds = np.linspace(0.005, 0.1, 5) if vasp_input_set is None: vasp_input_set = MPStaticSet(structure) From dfc7d7d7b2228bf3ecfb7e12950e26fd8e8972a5 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Thu, 23 Mar 2023 07:10:45 -0700 Subject: [PATCH 172/207] len(temperature)=1 --- atomate/vasp/analysis/lattice_dynamics.py | 52 ++++++++++++++--------- 1 file changed, 32 insertions(+), 20 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 02f4dc409..5b43d9211 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -605,7 +605,7 @@ def harmonic_properties( structure: Structure, supercell_matrix: np.ndarray, fcs: ForceConstants, - T: List, + temperature: List, imaginary_tol: float = IMAGINARY_TOL ) -> Tuple[Dict,Phonopy]: """ @@ -634,13 +634,13 @@ def harmonic_properties( phonopy.set_force_constants(fcs2) phonopy.set_mesh(mesh,is_eigenvectors=True,is_mesh_symmetry=False) #run_mesh(is_gamma_center=True) - phonopy.run_thermal_properties(temperatures=T) + phonopy.run_thermal_properties(temperatures=temperature) logger.info('Thermal properties successfully run!') - _, free_energy, entropy, Cv = phonopy.get_thermal_properties() + _, free_energy, entropy, heat_capacity = phonopy.get_thermal_properties() free_energy *= 1000/sp.constants.Avogadro/eV2J/natom # kJ/mol to eV/atom entropy *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom - Cv *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom + heat_capacity *= 1/sp.constants.Avogadro/eV2J/natom # J/K/mol to eV/K/atom freq = phonopy.mesh.frequencies # in THz # find imaginary modes at gamma @@ -654,11 +654,17 @@ def harmonic_properties( else: # do not calculate these if imaginary modes exist logger.warning('Imaginary modes found!') + if len(temperature)==1: + temperature = temperature[0] + free_energy = free_energy[0] + entropy = entropy[0] + heat_capacity = heat_capacity[0] + return { - "temperature": T, + "temperature": temperature, "free_energy": free_energy, "entropy": entropy, - "heat_capacity": Cv, + "heat_capacity": heat_capacity, "n_imaginary": n_imaginary }, phonopy @@ -666,8 +672,8 @@ def harmonic_properties( def anharmonic_properties( phonopy: Phonopy, fcs: ForceConstants, - T: List, - Cv: np.ndarray, + temperature: List, + heat_capacity: np.ndarray, n_imaginary: float, bulk_modulus: float = None ) -> Dict: @@ -676,21 +682,27 @@ def anharmonic_properties( logger.info('Evaluating anharmonic properties...') fcs2 = fcs.get_fc_array(2) fcs3 = fcs.get_fc_array(3) - grun, cte = gruneisen(phonopy,fcs2,fcs3,T,Cv,bulk_modulus=bulk_modulus) + grun, cte = gruneisen(phonopy,fcs2,fcs3,temperature,heat_capacity,bulk_modulus=bulk_modulus) if type(bulk_modulus) is float or int: - dLfrac = thermal_expansion(T,cte) + dLfrac = thermal_expansion(temperature,cte) else: logger.warning('Thermal expansion cannot be calculated without bulk modulus input. Set to 0.') - cte = np.zeros((len(T),3)) - dLfrac = np.zeros((len(T),3)) + cte = np.zeros((len(temperature),3)) + dLfrac = np.zeros((len(temperature),3)) else: # do not calculate these if imaginary modes exist logger.warning('Gruneisen and thermal expansion cannot be calculated with imaginary modes. All set to 0.') - grun = np.zeros((len(T),3)) - cte = np.zeros((len(T),3)) - dLfrac = np.zeros((len(T),3)) - + grun = np.zeros((len(temperature),3)) + cte = np.zeros((len(temperature),3)) + dLfrac = np.zeros((len(temperature),3)) + + if len(temperature)==1: + temperature = temperature[0] + grun = grun[0] + cte = cte[0] + dLfrac = dLfrac[0] + return { - "temperature": T, + "temperature": temperature, "gruneisen": grun, "thermal_expansion": cte, "expansion_ratio": dLfrac, @@ -879,9 +891,9 @@ def run_renormalization( else: anharmonic_data = dict() anharmonic_data["temperature"] = T - anharmonic_data["gruneisen"] = np.array([[0,0,0]]) - anharmonic_data["thermal_expansion"] = np.array([[0,0,0]]) - anharmonic_data["expansion_ratio"] = np.array([[0,0,0]]) + anharmonic_data["gruneisen"] = np.array([0,0,0]) + anharmonic_data["thermal_expansion"] = np.array([0,0,0]) + anharmonic_data["expansion_ratio"] = np.array([0,0,0]) renorm_data.update(anharmonic_data) phonopy_orig.run_mesh() From d28e087e9179270bd37b5d46472b565a9552ea19 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Tue, 4 Apr 2023 09:32:46 -0700 Subject: [PATCH 173/207] everything works? --- atomate/vasp/analysis/lattice_dynamics.py | 57 ++++++++++------------ atomate/vasp/firetasks/lattice_dynamics.py | 4 +- 2 files changed, 27 insertions(+), 34 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 5b43d9211..15b17beec 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -630,7 +630,7 @@ def harmonic_properties( parent_phonopy = get_phonopy_structure(structure) phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) natom = phonopy.primitive.get_number_of_atoms() - mesh = supercell_matrix.diagonal()*4 + mesh = supercell_matrix.diagonal()*2 phonopy.set_force_constants(fcs2) phonopy.set_mesh(mesh,is_eigenvectors=True,is_mesh_symmetry=False) #run_mesh(is_gamma_center=True) @@ -682,30 +682,17 @@ def anharmonic_properties( logger.info('Evaluating anharmonic properties...') fcs2 = fcs.get_fc_array(2) fcs3 = fcs.get_fc_array(3) - grun, cte = gruneisen(phonopy,fcs2,fcs3,temperature,heat_capacity,bulk_modulus=bulk_modulus) - if type(bulk_modulus) is float or int: - dLfrac = thermal_expansion(temperature,cte) - else: - logger.warning('Thermal expansion cannot be calculated without bulk modulus input. Set to 0.') - cte = np.zeros((len(temperature),3)) - dLfrac = np.zeros((len(temperature),3)) + grun, cte, dLfrac = gruneisen(phonopy,fcs2,fcs3,temperature,heat_capacity,bulk_modulus=bulk_modulus) else: # do not calculate these if imaginary modes exist logger.warning('Gruneisen and thermal expansion cannot be calculated with imaginary modes. All set to 0.') grun = np.zeros((len(temperature),3)) cte = np.zeros((len(temperature),3)) dLfrac = np.zeros((len(temperature),3)) - if len(temperature)==1: - temperature = temperature[0] - grun = grun[0] - cte = cte[0] - dLfrac = dLfrac[0] - return { - "temperature": temperature, "gruneisen": grun, "thermal_expansion": cte, - "expansion_ratio": dLfrac, + "expansion_fraction": dLfrac, } @@ -781,7 +768,7 @@ def gruneisen( fcs2: np.ndarray, fcs3: np.ndarray, temperature: List, - Cv: np.ndarray, # in eV/K/atom + heat_capacity: np.ndarray, # in eV/K/atom bulk_modulus: float = None # in GPa ) -> Tuple[List,List]: @@ -797,17 +784,21 @@ def gruneisen( grun_tot.append(get_total_grun(omega,grun,kweight,temp)) grun_tot = np.nan_to_num(np.array(grun_tot)) - # linear thermal expansion coefficient + # linear thermal expansion coefficeint and fraction if bulk_modulus is None: cte = None + dLfrac = None else: - Cv *= eV2J*phonopy.primitive.get_number_of_atoms() # eV/K/atom to J/K + heat_capacity *= eV2J*phonopy.primitive.get_number_of_atoms() # eV/K/atom to J/K vol = phonopy.primitive.get_volume() - cte = grun_tot*(Cv.repeat(3).reshape((len(Cv),3)))/(vol/10**30)/(bulk_modulus*10**9)/3 - cte = np.nan_to_num(cte) + cte = grun_tot*heat_capacity.repeat(3)/(vol/10**30)/(bulk_modulus*10**9)/3 + cte = np.nan_to_num(cte) + dLfrac = thermal_expansion(temperature,list(cte)) logger.info('Gruneisen: \n {}'.format(grun_tot)) - logger.info('CTE: \n {}'.format(cte)) - return grun_tot, cte + logger.info('Coefficient of Thermal Expansion: \n {}'.format(cte)) + logger.info('Linear Expansion Fraction: \n {}'.format(dLfrac)) + + return grun_tot, cte, dLfrac def thermal_expansion( @@ -819,6 +810,8 @@ def thermal_expansion( if 0 not in temperature: temperature = [0] + temperature cte = [[0,0,0]] + cte + logger.info('CTE: {}'.format(cte)) + logger.info('T_array: {}'.format(temperature)) temperature = np.array(temperature) ind = np.argsort(temperature) temperature = temperature[ind] @@ -885,15 +878,15 @@ def run_renormalization( if renorm_data["n_imaginary"] == 0: logger.info('Renormalized phonon is completely real at T = {} K!'.format(T)) - anharmonic_data = anharmonic_properties( - phonopy, fcs, [T], thermal_data["heat_capacity"], n_imaginary, bulk_modulus=bulk_modulus - ) - else: - anharmonic_data = dict() - anharmonic_data["temperature"] = T - anharmonic_data["gruneisen"] = np.array([0,0,0]) - anharmonic_data["thermal_expansion"] = np.array([0,0,0]) - anharmonic_data["expansion_ratio"] = np.array([0,0,0]) + anharmonic_data = anharmonic_properties( + phonopy, fcs, [T], renorm_data["heat_capacity"], renorm_data["n_imaginary"], bulk_modulus=bulk_modulus + ) +# else: +# anharmonic_data = dict() +# anharmonic_data["temperature"] = T +# anharmonic_data["gruneisen"] = np.array([0,0,0]) +# anharmonic_data["thermal_expansion"] = np.array([0,0,0]) +# anharmonic_data["expansion_fraction"] = np.array([0,0,0]) renorm_data.update(anharmonic_data) phonopy_orig.run_mesh() diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 4a571b51f..789073c3b 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -284,7 +284,7 @@ def run_task(self, fw_spec): else: logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) - dLfrac = renorm_data["expansion_ratio"] + dLfrac = renorm_data["expansion_fraction"] param = renorm_data["param"] parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE = setup_TE_iter(cs,cutoffs,parent_structure,param,temperature,dLfrac) @@ -305,7 +305,7 @@ def run_task(self, fw_spec): fcs = renorm_data['fcs'] fcs.write("force_constants.fcs") thermal_keys = ["temperature","free_energy","entropy","heat_capacity", - "gruneisen","thermal_expansion","expansion_ratio", + "gruneisen","thermal_expansion","expansion_fraction", "free_energy_correction_S","free_energy_correction_SC"] renorm_thermal_data = {key: [] for key in thermal_keys} for key in thermal_keys: From dbef4f7915eff480c33e7cfafd18ed01298e372b Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Tue, 4 Apr 2023 09:50:19 -0700 Subject: [PATCH 174/207] cleanup --- atomate/vasp/analysis/lattice_dynamics.py | 21 ++++++--------------- 1 file changed, 6 insertions(+), 15 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 15b17beec..c78655a5b 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -793,7 +793,9 @@ def gruneisen( vol = phonopy.primitive.get_volume() cte = grun_tot*heat_capacity.repeat(3)/(vol/10**30)/(bulk_modulus*10**9)/3 cte = np.nan_to_num(cte) - dLfrac = thermal_expansion(temperature,list(cte)) + dLfrac = thermal_expansion(temperature,cte) + if len(temperature)==1: + dLfrac = dLfrac[-1] logger.info('Gruneisen: \n {}'.format(grun_tot)) logger.info('Coefficient of Thermal Expansion: \n {}'.format(cte)) logger.info('Linear Expansion Fraction: \n {}'.format(dLfrac)) @@ -803,15 +805,12 @@ def gruneisen( def thermal_expansion( temperature: List, - cte: List, - T: Optional[float]=None + cte: np.array, ) -> np.ndarray: assert len(temperature)==len(cte) if 0 not in temperature: temperature = [0] + temperature - cte = [[0,0,0]] + cte - logger.info('CTE: {}'.format(cte)) - logger.info('T_array: {}'.format(temperature)) + cte = np.array([np.array([0,0,0])] + list(cte)) temperature = np.array(temperature) ind = np.argsort(temperature) temperature = temperature[ind] @@ -821,15 +820,7 @@ def thermal_expansion( for t in range(len(temperature)): dLfrac[t,:] = np.trapz(cte[:t+1,:],temperature[:t+1],axis=0) dLfrac = np.nan_to_num(dLfrac) - logger.info('dLfrac: \n {}'.format(dLfrac)) - if T is None: - return dLfrac - else: - try: - T_ind = np.where(temperature==T)[0][0] - return np.array([dLfrac[T_ind]]) - except: - raise ValueError('Designated T does not exist in the temperature array!') + return dLfrac def run_renormalization( From 7b002554414c228f9266b8aa1436b86414c51a18 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Fri, 19 May 2023 13:02:38 -0400 Subject: [PATCH 175/207] fixed random displacements --- atomate/vasp/analysis/lattice_dynamics.py | 4 ++-- atomate/vasp/workflows/base/lattice_dynamics.py | 16 ++++++++++++---- 2 files changed, 14 insertions(+), 6 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index c78655a5b..5e9163eba 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -26,7 +26,7 @@ from hiphive.fitting import Optimizer from hiphive.renormalization import Renormalization from hiphive.utilities import get_displacements -from hiphive.run_tools import _clean_data, FE_correction, construct_fit_data +from hiphive.run_tools import _clean_data, free_energy_correction, construct_fit_data from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor @@ -886,7 +886,7 @@ def run_renormalization( omega_TD = phonopy.mesh.frequencies # THz evec = phonopy.mesh.eigenvectors # natom = phonopy.primitive.get_number_of_atoms() - correction_S, correction_SC = FE_correction(omega0,omega_TD,evec,[T]) # eV/atom + correction_S, correction_SC = free_energy_correction(omega0,omega_TD,evec,[T]) # eV/atom renorm_data["free_energy_correction_S"] = correction_S[0] renorm_data["free_energy_correction_SC"] = correction_SC[0] diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 8dd9f6c4c..a094fdc78 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -186,6 +186,7 @@ def get_lattice_dynamics_wf( wf = get_perturbed_structure_wf( structure, supercell_matrix=supercell_matrix, + separate_fit=separate_fit, vasp_input_set=vasp_input_set, common_settings=common_settings, copy_vasp_outputs=copy_vasp_outputs, @@ -288,6 +289,7 @@ def get_lattice_dynamics_wf( def get_perturbed_structure_wf( structure: Structure, supercell_matrix: Optional[np.ndarray], + separate_fit: bool = False, name: str = "perturbed structure", vasp_input_set: Optional[VaspInputSet] = None, common_settings: Optional[Dict] = None, @@ -363,10 +365,16 @@ def get_perturbed_structure_wf( rattle_min_distance = min_distance - 2 * rattle_std rattle_min_distance = min(scaled_min_distance, rattle_min_distance) - transformations = [ - "SupercellTransformation", - "MonteCarloRattleTransformation", - ] + if separate_fit: + transformations = [ + "SupercellTransformation", + "FixedRandomDisplacementTransformation", + ] + else: + transformations = [ + "SupercellTransformation", + "MonteCarloRattleTransformation", + ] transformation_params = [ {"scaling_matrix": supercell_matrix}, {"rattle_std": rattle_std, "min_distance": rattle_min_distance}, From 32768217ee71b2fafa256ecafffc3b85ae1868ec Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Wed, 24 May 2023 10:42:27 -0400 Subject: [PATCH 176/207] T diff --- atomate/vasp/workflows/base/lattice_dynamics.py | 7 +++++-- 1 file changed, 5 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index a094fdc78..a75151da8 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -237,8 +237,11 @@ def get_lattice_dynamics_wf( temperatures = thermal_conductivity_temperature # Because of the way ShengBTE works, a temperature array that is not # evenly spaced out (T_step) requires submission for each temperature - even_spacing = all(np.diff(temperatures)==np.diff(temperatures)[0]) - if even_spacing and not renormalize: + if not renormalize: + if type(temperatures)==dict: + pass + elif type(temperatures) in [list,np.ndarray]: + assert all(np.diff(temperatures)==np.diff(temperatures)[0]) fw_lattice_conductivity = LatticeThermalConductivityFW( db_file=db_file, shengbte_cmd=shengbte_cmd, From 0ccc13f87304a8868a9ce467818a45d507645383 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Thu, 25 May 2023 12:59:29 -0400 Subject: [PATCH 177/207] syntax errors --- atomate/vasp/analysis/lattice_dynamics.py | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 5e9163eba..6ed62a0e6 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -791,7 +791,8 @@ def gruneisen( else: heat_capacity *= eV2J*phonopy.primitive.get_number_of_atoms() # eV/K/atom to J/K vol = phonopy.primitive.get_volume() - cte = grun_tot*heat_capacity.repeat(3)/(vol/10**30)/(bulk_modulus*10**9)/3 +# cte = grun_tot*heat_capacity.repeat(3)/(vol/10**30)/(bulk_modulus*10**9)/3 + cte = grun_tot*heat_capacity.repeat(3).reshape(len(heat_capacity),3)/(vol/10**30)/(bulk_modulus*10**9)/3 cte = np.nan_to_num(cte) dLfrac = thermal_expansion(temperature,cte) if len(temperature)==1: @@ -861,7 +862,7 @@ def run_renormalization( nconfig = int(nconfig) renorm = Renormalization(cs,supercell,fcs,param,T,renorm_method,fit_method) - fcp, fcs, param = renorm.renormalize(nconfig,conv_tresh) + fcp, fcs, param = renorm.renormalize(nconfig)#,conv_tresh) renorm_data, phonopy = harmonic_properties( structure, supercell_matrix, fcs, [T], imaginary_tol From bfcfdbb257d3f8b98aa44b31661a9f8f059dc98d Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Fri, 9 Jun 2023 15:14:05 -0400 Subject: [PATCH 178/207] remove separate_fit --- atomate/vasp/analysis/lattice_dynamics.py | 57 +++++++++++++++------- atomate/vasp/firetasks/lattice_dynamics.py | 8 +-- atomate/vasp/fireworks/lattice_dynamics.py | 6 +-- atomate/vasp/workflows/presets/core.py | 5 +- 4 files changed, 46 insertions(+), 30 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 6ed62a0e6..e8422a4e8 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -172,8 +172,7 @@ def fit_force_constants( supercell_matrix: np.ndarray, structures: List["Atoms"], all_cutoffs: List[List[float]], - separate_fit: bool, - disp_cut: float = None, + disp_cut: float = 0.055, imaginary_tol: float = IMAGINARY_TOL, fit_method: str = FIT_METHOD, <<<<<<< HEAD @@ -203,9 +202,7 @@ def fit_force_constants( all_cutoffs: A nested list of cutoff values to trial. Each set of cutoffs contains the radii for different orders starting with second order. - separate_fit: Boolean to determine whether harmonic and anharmonic fitting - are to be done separately (True) or in one shot (False) - disp_cut: if separate_fit true, determines the mean displacement of perturbed + disp_cut: determines the mean displacement of perturbed structure to be included in harmonic (<) or anharmonic (>) fitting imaginary_tol: Tolerance used to decide if a phonon mode is imaginary, in THz. @@ -235,14 +232,7 @@ def fit_force_constants( fitting_data = { "cutoffs": [], "rmse_test": [], -# "n_imaginary": [], -# "min_frequency": [], -# "temperature": [], -# "free_energy": [], -# "entropy": [], -# "heat_capacity": [], "fit_method": fit_method, - "separate_fit": separate_fit, "disp_cut": disp_cut, "imaginary_tol": imaginary_tol, # "max_n_imaginary": max_n_imaginary, @@ -273,7 +263,7 @@ def fit_force_constants( cutoff_results = Parallel(n_jobs=min(os.cpu_count(),len(all_cutoffs)), backend="multiprocessing")(delayed(_run_cutoffs)( i, cutoffs, n_cutoffs, parent_structure, structures, supercell_matrix, fit_method, - separate_fit, disp_cut, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) + disp_cut, imaginary_tol, fit_kwargs) for i, cutoffs in enumerate(all_cutoffs)) logger.info('CUTOFF RESULTS \n {}'.format(cutoff_results)) @@ -343,10 +333,10 @@ def get_fit_data( saved_structures.append(structure) else: # fit separately if param2 is None: # for harmonic fitting - if mean_displacements < disp_cut: + if mean_displacements <= disp_cut: saved_structures.append(structure) else: # for anharmonic fitting - if mean_displacements >= disp_cut: + if mean_displacements > disp_cut: saved_structures.append(structure) fit_data_tmp = Parallel(n_jobs=min(os.cpu_count(),max(1,len(saved_structures))))(#,prefer="threads")( @@ -373,7 +363,6 @@ def _run_cutoffs( structures, supercell_matrix, fit_method, - separate_fit, disp_cut, imaginary_tol, fit_kwargs @@ -405,6 +394,7 @@ def _run_cutoffs( logger.debug(cs.__repr__()) n2nd = cs.get_n_dofs_by_order(2) nall = cs.n_dofs +<<<<<<< HEAD if separate_fit: logger.info('Fitting harmonic force constants separately') @@ -425,6 +415,38 @@ def _run_cutoffs( param_harmonic = opt.parameters # harmonic force constant parameters logger.info('Fitting anharmonic force constants separately') +======= + + logger.info('Fitting harmonic force constants separately') + separate_fit = True +# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, +# disp_cut, ncut=n2nd, param2=None) + sc = get_structure_container(cs, structures, separate_fit, disp_cut, + ncut=n2nd, param2=None) + opt = Optimizer(sc.get_fit_data(), + fit_method, + [0,n2nd], + **fit_kwargs) + opt.train() + param_harmonic = opt.parameters # harmonic force constant parameters + param_tmp = np.concatenate((param2,np.zeros(cs.n_dofs-len(param_harmonic)))) + fcp = ForceConstantPotential(cs, param_tmp) + fcs = fcp.get_force_constants(supercell_atoms) + + parent_phonopy = get_phonopy_structure(parent_structure) + phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) + natom = phonopy.primitive.get_number_of_atoms() + mesh = supercell_matrix.diagonal()*2 + phonopy.set_force_constants(fcs2) + phonopy.set_mesh(mesh,is_eigenvectors=False,is_mesh_symmetry=False) #run_mesh(is_gamma_center=True) + phonopy.run_mesh(mesh, with_eigenvectors=False, is_mesh_symmetry=False) + omega = phonopy.mesh.frequencies # THz + omega = np.sort(omega.flatten()) + imaginary = np.any(omega<-1e-3) + + if imaginary: + logger.info('Imaginary modes found! Fitting anharmonic force constants separately') +>>>>>>> 2e30eb4a (remove separate_fit) # fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, # disp_cut, ncut=n2nd, param2=param_harmonic) sc = get_structure_container(cs, structures, separate_fit, disp_cut, @@ -509,7 +531,8 @@ def get_structure_container( logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) else: - logger.info('Fitting all force constants in one shot') + logger.info('No imaginary modes! Fitting all force constants in one shot') + separate_fit = False # fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, # disp_cut=None, ncut=None, param2=None) sc = get_structure_container(cs, structures, separate_fit, disp_cut=None, diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 789073c3b..2c24c55bd 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -126,10 +126,7 @@ class RunHiPhive(FiretaskBase): cutoffs (Optional[list[list]]): A list of cutoffs to trial. If None, a set of trial cutoffs will be generated based on the structure (default). - separate_fit: If True, harmonic and anharmonic force constants are fit - separately and sequentially, harmonic first then anharmonic. If - False, then they are all fit in one go. Default is False. - disp_cut: if separate_fit=True, determines the mean displacement of perturbed + disp_cut: determines the mean displacement of perturbed structure to be included in harmonic (<) or anharmonic (>) fitting imaginary_tol (float): Tolerance used to decide if a phonon mode is imaginary, in THz. @@ -139,7 +136,6 @@ class RunHiPhive(FiretaskBase): optional_params = [ "cutoffs", - "separate_fit", "disp_cut", "temperature_qha", "bulk_modulus", @@ -157,7 +153,6 @@ def run_task(self, fw_spec): supercell_structure = structure_data["supercell_structure"] supercell_matrix = np.array(structure_data["supercell_matrix"]) - separate_fit = self.get('separate_fit', False) disp_cut = self.get('disp_cut', None) cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) T_qha = self.get("temperature_qha", T_QHA) @@ -181,7 +176,6 @@ def run_task(self, fw_spec): supercell_matrix, structures, cutoffs, - separate_fit, disp_cut, imaginary_tol, fit_method diff --git a/atomate/vasp/fireworks/lattice_dynamics.py b/atomate/vasp/fireworks/lattice_dynamics.py index 4adb1b157..db6aed82a 100644 --- a/atomate/vasp/fireworks/lattice_dynamics.py +++ b/atomate/vasp/fireworks/lattice_dynamics.py @@ -37,9 +37,7 @@ class FitForceConstantsFW(Firework): db_file: Path to a db file. cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs will be generated based on the structure (default). - separate_fit: Boolean to determine whether harmonic and anharmonic fitting - are to be done separately (True) or in one shot (False) - disp_cut: if separate_fit true, determines the mean displacement of perturbed + disp_cut: determines the mean displacement of perturbed structure to be included in harmonic (<) or anharmonic (>) fitting bulk_modulus: in GPa, necessary for thermal expansion imaginary_tol: Tolerance used to decide if a phonon mode is @@ -55,7 +53,6 @@ class FitForceConstantsFW(Firework): def __init__( self, fit_method: str, - separate_fit: bool, disp_cut: float, bulk_modulus: float, imaginary_tol: float, @@ -71,7 +68,6 @@ def __init__( fit_force_constants = RunHiPhive( cutoffs=cutoffs, - separate_fit=separate_fit, fit_method=fit_method, disp_cut=disp_cut, bulk_modulus=bulk_modulus, diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 6f206ef52..e56f0dd98 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -854,8 +854,12 @@ def wf_nudged_elastic_band(structures, parent, c=None): def wf_lattice_dynamics( structure: Structure, +<<<<<<< HEAD separate_fit: bool = False, fit_method: str = FIT_METHOD, +======= + fit_method: str = False, +>>>>>>> 2e30eb4a (remove separate_fit) disp_cut: float = None, bulk_modulus: float = None, c: Optional[dict] = None, @@ -918,7 +922,6 @@ def wf_lattice_dynamics( wf_ld = get_lattice_dynamics_wf( structure, fit_method=fit_method, - separate_fit=separate_fit, disp_cut=disp_cut, bulk_modulus=bulk_modulus, common_settings=c, From 09664c0c4673b489c1356baa64021cea56bdff9a Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 9 Jun 2023 12:54:46 -0700 Subject: [PATCH 179/207] remove separate_fit --- .../vasp/workflows/base/lattice_dynamics.py | 31 ++++++------------- 1 file changed, 10 insertions(+), 21 deletions(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index a75151da8..7d85ea7bf 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -70,7 +70,6 @@ def get_lattice_dynamics_wf( structure: Structure, fit_method:str = FIT_METHOD, - separate_fit: bool = False, disp_cut: float = None, bulk_modulus: float = None, common_settings: Dict = None, @@ -119,9 +118,7 @@ def get_lattice_dynamics_wf( Args: structure: Initial structure. - separate_fit: Boolean to determine whether harmonic and anharmonic fitting - are to be done separately (True) or in one shot (False) - disp_cut: if separate_fit true, determines the mean displacement of perturbed + disp_cut: determines the mean displacement of perturbed structure to be included in harmonic (<) or anharmonic (>) fitting bulk_modulus: bulk modulus in GPa, necessary for thermal expansion common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", @@ -186,7 +183,6 @@ def get_lattice_dynamics_wf( wf = get_perturbed_structure_wf( structure, supercell_matrix=supercell_matrix, - separate_fit=separate_fit, vasp_input_set=vasp_input_set, common_settings=common_settings, copy_vasp_outputs=copy_vasp_outputs, @@ -199,7 +195,6 @@ def get_lattice_dynamics_wf( fw_fit_force_constant = FitForceConstantsFW( db_file=db_file, spec=allow_fizzled, - separate_fit=separate_fit, fit_method=fit_method, disp_cut=disp_cut, bulk_modulus=bulk_modulus, @@ -292,7 +287,6 @@ def get_lattice_dynamics_wf( def get_perturbed_structure_wf( structure: Structure, supercell_matrix: Optional[np.ndarray], - separate_fit: bool = False, name: str = "perturbed structure", vasp_input_set: Optional[VaspInputSet] = None, common_settings: Optional[Dict] = None, @@ -365,22 +359,17 @@ def get_perturbed_structure_wf( # make sure the minimum distance is at least min_dist - 2 * rattle_std # as a sanity check - rattle_min_distance = min_distance - 2 * rattle_std - rattle_min_distance = min(scaled_min_distance, rattle_min_distance) - - if separate_fit: - transformations = [ - "SupercellTransformation", - "FixedRandomDisplacementTransformation", - ] - else: - transformations = [ - "SupercellTransformation", - "MonteCarloRattleTransformation", - ] +# rattle_min_distance = min_distance - 2 * rattle_std +# rattle_min_distance = min(scaled_min_distance, rattle_min_distance) + + transformations = [ + "SupercellTransformation", + "FixedRandomDisplacementTransformation", + ] + transformation_params = [ {"scaling_matrix": supercell_matrix}, - {"rattle_std": rattle_std, "min_distance": rattle_min_distance}, + {"rattle_std": rattle_std}#, "min_distance": rattle_min_distance}, ] fw = TransmuterFW( From 16b22d09ba154dad0336321d9e501ffef49c09f6 Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Wed, 14 Jun 2023 13:32:30 -0400 Subject: [PATCH 180/207] separate harmonic --- atomate/vasp/analysis/lattice_dynamics.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index e8422a4e8..5dc1b7d57 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -429,7 +429,7 @@ def _run_cutoffs( **fit_kwargs) opt.train() param_harmonic = opt.parameters # harmonic force constant parameters - param_tmp = np.concatenate((param2,np.zeros(cs.n_dofs-len(param_harmonic)))) + param_tmp = np.concatenate((param_harmonic,np.zeros(cs.n_dofs-len(param_harmonic)))) fcp = ForceConstantPotential(cs, param_tmp) fcs = fcp.get_force_constants(supercell_atoms) @@ -437,7 +437,7 @@ def _run_cutoffs( phonopy = Phonopy(parent_phonopy, supercell_matrix=supercell_matrix) natom = phonopy.primitive.get_number_of_atoms() mesh = supercell_matrix.diagonal()*2 - phonopy.set_force_constants(fcs2) + phonopy.set_force_constants(fcs.get_fc_array(2)) phonopy.set_mesh(mesh,is_eigenvectors=False,is_mesh_symmetry=False) #run_mesh(is_gamma_center=True) phonopy.run_mesh(mesh, with_eigenvectors=False, is_mesh_symmetry=False) omega = phonopy.mesh.frequencies # THz From 5df072422f12f9d294ec8a1950e4891b1a6480a5 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Wed, 21 Jun 2023 16:55:17 -0700 Subject: [PATCH 181/207] clean-up --- atomate/vasp/workflows/presets/core.py | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index e56f0dd98..8d898d141 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -854,12 +854,13 @@ def wf_nudged_elastic_band(structures, parent, c=None): def wf_lattice_dynamics( structure: Structure, -<<<<<<< HEAD - separate_fit: bool = False, fit_method: str = FIT_METHOD, +<<<<<<< HEAD ======= fit_method: str = False, >>>>>>> 2e30eb4a (remove separate_fit) +======= +>>>>>>> ac887694 (clean-up) disp_cut: float = None, bulk_modulus: float = None, c: Optional[dict] = None, From db53650e129b16e488fe12b844140b953e4bd915 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Fri, 5 Jan 2024 11:23:57 -0800 Subject: [PATCH 182/207] PhonopySupercellTransformation --- atomate/vasp/workflows/base/lattice_dynamics.py | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index 7d85ea7bf..c105ca4b4 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -363,7 +363,8 @@ def get_perturbed_structure_wf( # rattle_min_distance = min(scaled_min_distance, rattle_min_distance) transformations = [ - "SupercellTransformation", +# "SupercellTransformation", + "PhonopySupercellTransformation", "FixedRandomDisplacementTransformation", ] From 8c272be16fd149daaf18c06cf027db86a3a1e24c Mon Sep 17 00:00:00 2001 From: Junsoo Park Date: Fri, 12 Jan 2024 15:49:03 -0500 Subject: [PATCH 183/207] ARC AIMD --- atomate/vasp/analysis/lattice_dynamics.py | 4 + atomate/vasp/firetasks/aimd.py | 501 ++++++++++++++++++ atomate/vasp/firetasks/lattice_dynamics.py | 3 +- atomate/vasp/firetasks/run_calc.py | 7 + atomate/vasp/fireworks/aimd.py | 193 +++++++ atomate/vasp/fireworks/core.py | 8 + atomate/vasp/workflows/base/aimd.py | 162 ++++++ .../vasp/workflows/base/lattice_dynamics.py | 2 +- atomate/vasp/workflows/presets/core.py | 82 +++ 9 files changed, 960 insertions(+), 2 deletions(-) create mode 100644 atomate/vasp/firetasks/aimd.py create mode 100644 atomate/vasp/fireworks/aimd.py create mode 100644 atomate/vasp/workflows/base/aimd.py diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 5dc1b7d57..938575ce1 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -912,8 +912,12 @@ def run_renormalization( # natom = phonopy.primitive.get_number_of_atoms() correction_S, correction_SC = free_energy_correction(omega0,omega_TD,evec,[T]) # eV/atom + lambda_array = np.array([0,0.1,0.3,0.5,0.7,0.9,1]) + correction_TI = renorm.thermodynamic_integration(lambda_array,param,fcs,TI_nconfig=3) + renorm_data["free_energy_correction_S"] = correction_S[0] renorm_data["free_energy_correction_SC"] = correction_SC[0] + renorm_data["free_energy_correction_TI"] = correction_TI renorm_data["fcp"] = fcp renorm_data["fcs"] = fcs renorm_data["param"] = param diff --git a/atomate/vasp/firetasks/aimd.py b/atomate/vasp/firetasks/aimd.py new file mode 100644 index 000000000..83a2ff286 --- /dev/null +++ b/atomate/vasp/firetasks/aimd.py @@ -0,0 +1,501 @@ +import json +import os +import subprocess +import shlex +from datetime import datetime +from pathlib import Path + +import numpy as np +from copy import copy, deepcopy + +from monty.dev import requires +from monty.serialization import dumpfn, loadfn +from monty.json import jsanitize +from pymongo import ReturnDocument + +from atomate.utils.utils import env_chk, get_logger +from atomate.vasp.database import VaspCalcDb +from atomate.vasp.drones import VaspDrone + +from fireworks import FiretaskBase, FWAction, explicit_serialize + +from pymatgen.core.structure import Structure +from pymatgen.transformations.standard_transformations import ( + SupercellTransformation, +) + + +__author__ = "Junsoo Park" +__email__ = "junsoo.park@nasa.gov" + +logger = get_logger(__name__) + + +@explicit_serialize +class CollectMDSegments(FiretaskBase): + """ + Aggregate the structures and forces of perturbed supercells. + + Requires a ``perturbed_tasks`` key to be set in the fw_spec, containing a + list of dictionaries, each with the keys: + + - "parent_structure": The original structure. + - "supercell_matrix": The supercell transformation matrix. + - "structure": The perturbed supercell structure. + - "forces": The forces on each site in the supercell. + """ + + def run_task(self, fw_spec): + results = fw_spec.get("aimd", []) + logger.info("Found {} AIMD segments".format(len(results))) + + structures = [r["structure"] for r in results] + forces = [np.asarray(r["forces"][i]) for i in range(len(r)) for r in results] + stress = [np.asarray(r["stress"][i]) for i in range(len(r)) for r in results] + configs = [r["configurations"][i] for i in range(len(r)) for r in results] + + # if relaxation, get original structure from that calculation + calc_locs = fw_spec.get("calc_locs", []) + opt_calc_locs = [c for c in calc_locs if "optimiz" in c["name"]] + if opt_calc_locs: + opt_loc = opt_calc_locs[-1]["path"] + logger.info("Parsing optimization directory: {}".format(opt_loc)) + opt_doc = VaspDrone( + parse_dos=False, parse_locpot=False, + parse_bader=False, store_volumetric_data=[], + ).assimilate(opt_loc) + opt_output = opt_doc["calcs_reversed"][0]["output"] + structure = Structure.from_dict(opt_output["structure"]) + else: + structure = results[0]["parent_structure"] + supercell_matrix = results[0]["supercell_matrix"] + + # regenerate pure supercell structure + st = SupercellTransformation(supercell_matrix) + supercell_structure = st.apply_transformation(structure) + + structure_data = { + "structure": structure, + "supercell_structure": supercell_structure, + "supercell_matrix": supercell_matrix, + } + + logger.info("Writing structure and forces data.") + dumpfn(structures, "perturbed_structures.json") + dumpfn(forces, "perturbed_forces.json") + dumpfn(structure_data, "structure_data.json") + + +@explicit_serialize +class MDToDB(FiretaskBase): + required_params = ["db_file"] + optional_params = ["renormalized","renorm_temperature","mesh_density", "additional_fields"] + + def run_task(self, fw_spec): + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "renormalization_dir": os.getcwd()} + data = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix, + "supercell_structure": supercell_structure.as_dict(), + "perturbed_structures": [s.as_dict() for s in perturbed_structures], + "perturbed_forces": [f.tolist() for f in forces], + "fitting_data": fitting_data, + "thermal_data": thermal_data, + "force_constants_fs_id": fc_fsid, + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + } + data.update(self.get("additional_fields", {})) + data.update(metadata) + data = jsanitize(data, strict=True, allow_bson=True) + mmdb.db.aimd_for_potential_fitting.insert_one(data) + + logger.info("Finished inserting renormalized force constants and phonon data at {} K".format(T)) + + return FWAction(update_spec=metadata) + + +@explicit_serialize +class RunHiPhive(FiretaskBase): + """ + Fit force constants using hiPhive. + + Requires "perturbed_structures.json", "perturbed_forces.json", and + "structure_data.json" files to be present in the current working directory. + + Optional parameters: + cutoffs (Optional[list[list]]): A list of cutoffs to trial. If None, + a set of trial cutoffs will be generated based on the structure + (default). + disp_cut: determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + imaginary_tol (float): Tolerance used to decide if a phonon mode + is imaginary, in THz. + fit_method (str): Method used for fitting force constants. This can + be any of the values allowed by the hiphive ``Optimizer`` class. + """ + + optional_params = [ + "cutoffs", + "disp_cut", + "temperature_qha", + "bulk_modulus", + "imaginary_tol", + "fit_method", + ] + + @requires(hiphive, "hiphive is required for lattice dynamics workflow") + def run_task(self, fw_spec): + + all_structures = loadfn("perturbed_structures.json") + all_forces = loadfn("perturbed_forces.json") + structure_data = loadfn("structure_data.json") + parent_structure = structure_data["structure"] + supercell_structure = structure_data["supercell_structure"] + supercell_matrix = np.array(structure_data["supercell_matrix"]) + + disp_cut = self.get('disp_cut', None) + cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) + T_qha = self.get("temperature_qha", T_QHA) + T_qha.sort() + imaginary_tol = self.get("imaginary_tol") + bulk_modulus = self.get("bulk_modulus") + fit_method = self.get("fit_method") + + structures = [] + supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) + for structure, forces in zip(all_structures, all_forces): + atoms = AseAtomsAdaptor.get_atoms(structure) + displacements = get_displacements(atoms, supercell_atoms) + atoms.new_array("displacements", displacements) + atoms.new_array("forces", forces) + atoms.positions = supercell_atoms.get_positions() + structures.append(atoms) + + fcs, param, cs, fitting_data = fit_force_constants( + parent_structure, + supercell_matrix, + structures, + cutoffs, + disp_cut, + imaginary_tol, + fit_method + ) + + if fcs is None: + # fitting failed for some reason + raise RuntimeError( + "Could not find a force constant solution" + ) + + thermal_data, phonopy = harmonic_properties( + parent_structure, supercell_matrix, fcs, T_qha, imaginary_tol + ) + anharmonic_data = anharmonic_properties( + phonopy, fcs, T_qha, thermal_data["heat_capacity"], + thermal_data["n_imaginary"], bulk_modulus + ) + + phonopy.save("phonopy_orig.yaml") + fitting_data["n_imaginary"] = thermal_data.pop("n_imaginary") + thermal_data.update(anharmonic_data) + dumpfn(fitting_data, "fitting_data.json") + dumpfn(thermal_data, "thermal_data.json") + + logger.info("Writing cluster space and force_constants") + logger.info("{}".format(type(fcs))) + fcs.write("force_constants.fcs") + np.savetxt('parameters.txt',param) + cs.write('cluster_space.cs') + + if fitting_data["n_imaginary"] == 0: + logger.info("No imaginary modes! Writing ShengBTE files") + atoms = AseAtomsAdaptor.get_atoms(parent_structure) + fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms, order=3) + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND", format="text") + else: + logger.info("ShengBTE files not written due to imaginary modes.") + logger.info("You may want to perform phonon renormalization.") + + + +@explicit_serialize +class RunHiPhiveRenorm(FiretaskBase): + """ + Perform phonon renormalization to obtain dependent-temperature force constants + using hiPhive. Requires "structure_data.json" to be present in the current working + directory. + + Required parameters: + + Optional parameter: + temperature (float): temperature to perform renormalization + renorm_TE_iter (bool): if True, perform outer iteration over thermally expanded volumes + bulk_modulus (float): input bulk modulus - required for thermal expansion iterations + """ + + optional_params = ["renorm_method","temperature","nconfig","conv_thresh","max_iter", + "renorm_TE_iter","bulk_modulus","imaginary_tol"] + + @requires(hiphive, "hiphive is required for lattice dynamics workflow") + def run_task(self, fw_spec): + + cs = ClusterSpace.read('cluster_space.cs') + fcs = ForceConstants.read('force_constants.fcs') + param = np.loadtxt('parameters.txt') + fitting_data = loadfn("fitting_data.json") + structure_data = loadfn("structure_data.json") + phonopy_orig = phpy.load("phonopy_orig.yaml") + + cutoffs = fitting_data["cutoffs"] + fit_method = fitting_data["fit_method"] + imaginary_tol = fitting_data["imaginary_tol"] + + parent_structure = structure_data["structure"] + supercell_structure = structure_data["supercell_structure"] + supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) + supercell_matrix = np.array(structure_data["supercell_matrix"]) + + temperature = self.get("temperature") + renorm_method = self.get("renorm_method") + nconfig = self.get("nconfig") + conv_thresh = self.get("conv_thresh") + max_iter = self.get("max_iter") + renorm_TE_iter = self.get("renorm_TE_iter") + bulk_modulus = self.get("bulk_modulus") + + # Renormalization with DFT lattice + renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, temperature, + nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) + + # Additional renormalization with thermal expansion - optional - just single "iteration" for now + if renorm_TE_iter: + n_TE_iter = 1 + for i in range(n_TE_iter): + if renorm_data is None: # failed or incomplete + break + elif result["n_imaginary"] < 0: # still imaginary + break + else: + logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) + + dLfrac = renorm_data["expansion_fraction"] + param = renorm_data["param"] + + parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE = setup_TE_iter(cs,cutoffs,parent_structure,param,temperature,dLfrac) + prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) + prim_TE_phonopy = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), + scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) + phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) + + renorm_data = run_renormalization(parent_structure_TE, supercell_atoms_TE, supercell_matrix, + cs_TE, fcs_TE, param, temperature, nconfig, max_iter, + conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE) + structure_data["structure"] = parent_structure_TE + structure_data["supercell_structure"] = AseAtomsAdaptor.get_structure(supercell_atoms_TE) + + # write results + logger.info("Writing renormalized results") + renorm_thermal_data = dict() + fcs = renorm_data['fcs'] + fcs.write("force_constants.fcs") + thermal_keys = ["temperature","free_energy","entropy","heat_capacity", + "gruneisen","thermal_expansion","expansion_fraction", + "free_energy_correction_S","free_energy_correction_SC"] + renorm_thermal_data = {key: [] for key in thermal_keys} + for key in thermal_keys: + renorm_thermal_data[key].append(renorm_data[key]) + + logger.info("DEBUG: ",renorm_data) + if renorm_data["n_imaginary"] > 0: + logger.warning('Imaginary modes remain for {} K!'.format(temperature)) + logger.warning('ShengBTE files not written') + logger.warning('No renormalization with thermal expansion') + else: + logger.info("No imaginary modes! Writing ShengBTE files") + fcs.write_to_phonopy("FORCE_CONSTANTS_2ND".format(temperature), format="text") + + dumpfn(structure_data, "structure_data.json".format(temperature)) + dumpfn(renorm_thermal_data, "renorm_thermal_data.json".format(temperature)) + + +@explicit_serialize +class ForceConstantsToDb(FiretaskBase): + """ + Add force constants, phonon band structure and density of states + to the database. + + Assumes you are in a directory with the force constants, fitting + data, and structure data written to files. + + Required parameters: + db_file (str): Path to DB file for the database that contains the + perturbed structure calculations. + + Optional parameters: + renormalized (bool): Whether FC resulted from original fitting (False) + or renormalization process (True) determines how data are stored. + Default is False. + mesh_density (float): The density of the q-point mesh used to calculate + the phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + additional_fields (dict): Additional fields added to the document, such + as user-defined tags, name, ids, etc. + """ + + required_params = ["db_file"] + optional_params = ["renormalized","renorm_temperature","mesh_density", "additional_fields"] + + @requires(hiphive, "hiphive is required for lattice dynamics workflow") + def run_task(self, fw_spec): + + db_file = env_chk(self.get("db_file"), fw_spec) + mmdb = VaspCalcDb.from_db_file(db_file, admin=True) + renormalized = self.get("renormalized", False) + renorm_temperature = self.get("renorm_temperature", None) + mesh_density = self.get("mesh_density", 100.0) + + structure_data = loadfn("structure_data.json") + structure = structure_data["structure"] + supercell_structure = structure_data["supercell_structure"] + supercell_matrix = structure_data["supercell_matrix"] + + if not renormalized: + perturbed_structures = loadfn("perturbed_structures.json") + forces = loadfn("perturbed_forces.json") + fitting_data = loadfn("fitting_data.json") + thermal_data = loadfn("thermal_data.json") + fcs = ForceConstants.read("force_constants.fcs") + + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, fcs, mesh_density, mmdb + ) + + data = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix, + "supercell_structure": supercell_structure.as_dict(), + "perturbed_structures": [s.as_dict() for s in perturbed_structures], + "perturbed_forces": [f.tolist() for f in forces], + "fitting_data": fitting_data, + "thermal_data": thermal_data, + "force_constants_fs_id": fc_fsid, + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + } + data.update(self.get("additional_fields", {})) + + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} + data.update(metadata) + data = jsanitize(data,strict=True,allow_bson=True) + + mmdb.db.lattice_dynamics.insert_one(data) + + logger.info("Finished inserting force constants and phonon data") + + else: + renorm_thermal_data = loadfn("renorm_thermal_data.json") + fcs = ForceConstants.read("force_constants.fcs") + T = renorm_thermal_data["temperature"] + + dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( + structure, supercell_matrix, fcs, mesh_density, mmdb + ) + + data_at_T = { + "created_at": datetime.utcnow(), + "tags": fw_spec.get("tags", None), + "formula_pretty": structure.composition.reduced_formula, + "structure": structure.as_dict(), + "supercell_matrix": supercell_matrix, + "supercell_structure": supercell_structure.as_dict(), + "thermal_data": renorm_thermal_data, + "force_constants_fs_id": fc_fsid, + "phonon_dos_fs_id": dos_fsid, + "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, + "phonon_bandstructure_line_fs_id": lm_bs_fsid, + } + data_at_T.update(self.get("additional_fields", {})) + + # Get an id for the force constants + fitting_id = _get_fc_fitting_id(mmdb) + metadata = {"fc_fitting_id": fitting_id, "renormalization_dir": os.getcwd()} + data_at_T.update(metadata) + data_at_T = jsanitize(data_at_T,strict=True,allow_bson=True) + + mmdb.db.renormalized_lattice_dynamics.insert_one(data_at_T) + + logger.info("Finished inserting renormalized force constants and phonon data at {} K".format(T)) + + return FWAction(update_spec=metadata) + + +def _get_fc_fitting_id(mmdb: VaspCalcDb) -> int: + """Helper method to get a force constant fitting id.""" + fc_id = mmdb.db.counter.find_one_and_update( + {"_id": "fc_fitting_id"}, + {"$inc": {"c": 1}}, + return_document=ReturnDocument.AFTER, + ) + if fc_id is None: + mmdb.db.counter.insert({"_id": "fc_fitting_id", "c": 1}) + fc_id = 1 + else: + fc_id = fc_id["c"] + + return fc_id + + +def _get_fc_fsid(structure, supercell_matrix, fcs, mesh_density, mmdb): + phonopy_fc = fcs.get_fc_array(order=2) + + logger.info("Getting uniform phonon band structure.") + uniform_bs = get_phonon_band_structure_from_fc( + structure, supercell_matrix, phonopy_fc + ) + + logger.info("Getting line mode phonon band structure.") + lm_bs = get_phonon_band_structure_symm_line_from_fc( + structure, supercell_matrix, phonopy_fc + ) + + logger.info("Getting phonon density of states.") + dos = get_phonon_dos_from_fc( + structure, supercell_matrix, phonopy_fc, mesh_density=mesh_density + ) + + logger.info("Inserting phonon objects into database.") + dos_fsid, _ = mmdb.insert_gridfs( + dos.to_json(), collection="phonon_dos_fs" + ) + uniform_bs_fsid, _ = mmdb.insert_gridfs( + uniform_bs.to_json(), collection="phonon_bandstructure_fs" + ) + lm_bs_fsid, _ = mmdb.insert_gridfs( + lm_bs.to_json(), collection="phonon_bandstructure_fs" + ) + + logger.info("Inserting force constants into database.") + fc_json = json.dumps( + {str(k): v.tolist() for k, v in fcs.get_fc_dict().items()} + ) + fc_fsid, _ = mmdb.insert_gridfs( + fc_json, collection="phonon_force_constants_fs" + ) + + return dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index 2c24c55bd..ca2b886f7 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -300,7 +300,8 @@ def run_task(self, fw_spec): fcs.write("force_constants.fcs") thermal_keys = ["temperature","free_energy","entropy","heat_capacity", "gruneisen","thermal_expansion","expansion_fraction", - "free_energy_correction_S","free_energy_correction_SC"] + "free_energy_correction_S","free_energy_correction_SC", + "free_energy_correction_TI"] renorm_thermal_data = {key: [] for key in thermal_keys} for key in thermal_keys: renorm_thermal_data[key].append(renorm_data[key]) diff --git a/atomate/vasp/firetasks/run_calc.py b/atomate/vasp/firetasks/run_calc.py index 9b771c221..1eb017431 100644 --- a/atomate/vasp/firetasks/run_calc.py +++ b/atomate/vasp/firetasks/run_calc.py @@ -10,7 +10,14 @@ from custodian import Custodian from custodian.vasp.handlers import ( AliasingErrorHandler, +<<<<<<< HEAD DriftErrorHandler, +======= + MeshSymmetryErrorHandler, + UnconvergedErrorHandler, +# MaxForceErrorHandler, + PotimErrorHandler, +>>>>>>> c012f5fb (ARC AIMD) FrozenJobErrorHandler, IncorrectSmearingHandler, LargeSigmaHandler, diff --git a/atomate/vasp/fireworks/aimd.py b/atomate/vasp/fireworks/aimd.py new file mode 100644 index 000000000..40a0251b2 --- /dev/null +++ b/atomate/vasp/fireworks/aimd.py @@ -0,0 +1,193 @@ +from typing import List, Optional, Union, Dict + +import os + +from atomate.common.firetasks.glue_tasks import ( + CopyFiles, + CopyFilesFromCalcLoc, + PassCalcLocs, +) + +from atomate.vasp.firetasks.aimd import ( + CollectMDSegments, + MDToDB + ) + +from fireworks import Firework + +__author__ = "Junsoo Park" +__email__ = "junsoo.park@nasa.gov" + + +class ARCMDFW(Firework): + def __init__( + self, + structure, + start_temp, + end_temp, + nsteps, + name="AIMD", + vasp_input_set=None, + vasp_cmd=VASP_CMD, + override_default_vasp_params=None, + wall_time=19200, + db_file=DB_FILE, + parents=None, + **kwargs, + ): + """ + Standard firework for a single MD run. + + Args: + structure (Structure): Input structure. + start_temp (float): Start temperature of MD run. + end_temp (float): End temperature of MD run. + nsteps (int): Number of MD steps + name (string): Name for the Firework. + vasp_input_set (string): string name for the VASP input set (e.g., + "MITMDVaspInputSet"). + vasp_cmd (string): Command to run vasp. + override_default_vasp_params (dict): If this is not None, + these params are passed to the default vasp_input_set, i.e., + MITMDSet. This allows one to easily override some + settings, e.g., user_incar_settings, etc. Particular to MD, + one can control time_step and all other settings of the input set. + wall_time (int): Total wall time in seconds before writing STOPCAR. + copy_vasp_outputs (bool): Whether to copy outputs from previous run. Defaults to True. + db_file (string): Path to file specifying db credentials. + parents (Firework): Parents of this particular Firework. FW or list of FWS. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ + override_default_vasp_params = override_default_vasp_params or {} + vasp_input_set = vasp_input_set or ARCMDSet( + structure, + start_temp=start_temp, + end_temp=end_temp, + nsteps=nsteps, + **override_default_vasp_params, + ) + prev_runs = fw_spec.get("aimd", []) + last_run = prev_runs[-1] + last_config = last_run["final_configuration"] + t = [] + t.append(WriteVaspFromIOSet(structure=last_config, vasp_input_set=vasp_input_set)) + t.append( + RunVaspCustodian( + vasp_cmd=vasp_cmd, + gamma_vasp_cmd=">>vasp_cmd<<",#">>gamma_vasp_cmd<<", + handler_group="md", + wall_time=wall_time, + ) + ) + t.append(PassCalcLocs(name=name)) + t.append( + VaspToDb( + db_file=db_file, + additional_fields={"task_label": name}, + defuse_unsuccessful=False, + ) + ) + super().__init__( + t, + parents=parents, + name=f"{structure.composition.reduced_formula}-{name}", + **kwargs, + ) + + +class CollectMDSegmentsFW(Firework): + """ + Compile serial AIMD runs segmented into multiple Fireworks + + Args: + parents: Parent(s) of this Firework. + name: Name of this FW. + db_file: Path to a db file. + cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs + will be generated based on the structure (default). + disp_cut: determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + bulk_modulus: in GPa, necessary for thermal expansion + imaginary_tol: Tolerance used to decide if a phonon mode is + imaginary, in THz. + fit_method: Method used for fitting force constants. This can be + any of the values allowed by the hiphive ``Optimizer`` class. + mesh_density: The density of the q-point mesh used to calculate the + phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ + + def __init__( + self, + name="Collect MD Runs", + parents: Optional[Union[Firework, List[Firework]]] = None, + db_file: str = None, + **kwargs + ): + collect = CollectMDSegments() + + to_db = AIMDToDB( + db_file=db_file, additional_fields={} + ) + pass_locs = PassCalcLocs(name=name) + + tasks = [collect, to_db, pass_locs] + super().__init__(tasks, parents=parents, name=name, **kwargs) + + +class FitForceConstantsFW(Firework): + """ + Compile perturbed supercell calculations and fit force constants + using hiPhive. + + Args: + parents: Parent(s) of this Firework. + name: Name of this FW. + db_file: Path to a db file. + cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs + will be generated based on the structure (default). + disp_cut: determines the mean displacement of perturbed + structure to be included in harmonic (<) or anharmonic (>) fitting + bulk_modulus: in GPa, necessary for thermal expansion + imaginary_tol: Tolerance used to decide if a phonon mode is + imaginary, in THz. + fit_method: Method used for fitting force constants. This can be + any of the values allowed by the hiphive ``Optimizer`` class. + mesh_density: The density of the q-point mesh used to calculate the + phonon density of states. See the docstring for the ``mesh`` + argument in Phonopy.init_mesh() for more details. + **kwargs: Other kwargs that are passed to Firework.__init__. + """ + + def __init__( + self, + fit_method: str, + disp_cut: float, + bulk_modulus: float, + imaginary_tol: float, + mesh_density: float, + temperature_qha: float, + cutoffs: Optional[List[List[float]]] = None, + name="Fit Force Constants", + parents: Optional[Union[Firework, List[Firework]]] = None, + db_file: str = None, + **kwargs + ): + collect_structures = CollectPerturbedStructures() + + fit_force_constants = RunHiPhive( + cutoffs=cutoffs, + fit_method=fit_method, + disp_cut=disp_cut, + bulk_modulus=bulk_modulus, + temperature_qha=temperature_qha, + imaginary_tol=imaginary_tol, + ) + to_db = ForceConstantsToDb( + db_file=db_file, renormalized=False, mesh_density=mesh_density, additional_fields={} + ) + pass_locs = PassCalcLocs(name=name) + + tasks = [collect_structures, fit_force_constants, to_db, pass_locs] + super().__init__(tasks, parents=parents, name=name, **kwargs) diff --git a/atomate/vasp/fireworks/core.py b/atomate/vasp/fireworks/core.py index e99d18925..373635e30 100644 --- a/atomate/vasp/fireworks/core.py +++ b/atomate/vasp/fireworks/core.py @@ -64,6 +64,10 @@ def __init__( db_file=DB_FILE, force_gamma=True, job_type="double_relaxation_run", +<<<<<<< HEAD +======= +# max_force_threshold=RELAX_MAX_FORCE, +>>>>>>> c012f5fb (ARC AIMD) auto_npar=">>auto_npar<<", half_kpts_first_relax=HALF_KPOINTS_FIRST_RELAX, parents=None, @@ -113,6 +117,10 @@ def __init__( RunVaspCustodian( vasp_cmd=vasp_cmd, job_type=job_type, +<<<<<<< HEAD +======= +# max_force_threshold=max_force_threshold, +>>>>>>> c012f5fb (ARC AIMD) ediffg=ediffg, auto_npar=auto_npar, half_kpts_first_relax=half_kpts_first_relax, diff --git a/atomate/vasp/workflows/base/aimd.py b/atomate/vasp/workflows/base/aimd.py new file mode 100644 index 000000000..096aea5e6 --- /dev/null +++ b/atomate/vasp/workflows/base/aimd.py @@ -0,0 +1,162 @@ +import math +import warnings +from copy import deepcopy +from typing import Dict, List, Optional, Union +import numpy as np +from monty.serialization import loadfn, dumpfn + +from atomate.utils.utils import get_logger +from atomate.vasp.config import DB_FILE, VASP_CMD +from atomate.vasp.firetasks import pass_vasp_result +from atomate.vasp.analysis.lattice_dynamics import ( + FIT_METHOD, + MESH_DENSITY, +) +from atomate.vasp.fireworks.core import TransmuterFW, OptimizeFW +from atomate.vasp.fireworks.aimd import ARCMDFW, CollectMDSegmentsFW +from atomate.common.powerups import add_additional_fields_to_taskdocs +from fireworks import Workflow +from pymatgen.core.structure import Structure +from pymatgen.io.vasp.sets import ARCMDSet, VaspInputSet +from pymatgen.symmetry.analyzer import SpacegroupAnalyzer +from pymatgen.transformations.advanced_transformations import ( + CubicSupercellTransformation, +) + +__author__ = "Junsoo Park" +__email__ = "junsoo.park@nasa.gov" +__date__ = "December 2023" + +logger = get_logger(__name__) + +vasp_to_db_params = { + "store_volumetric_data": tuple(), + "vasp_drone_params": {"parse_bader": False, "parse_locpot": False} +} + +_DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} +_WF_VERSION = 0.1 + + +def get_aimd_wf( + structure: Structure, + common_settings: Dict = None, + ensemble='NVT', + start_temp=start_temp, + end_temp=end_temp, + simulation_time = simulation_time, + time_step = time_step, + copy_vasp_outputs = True, + supercell_matrix_kwargs: Optional[dict] = None +): + """ + This workflow will perform AIMD on VASP, + + Args: + structure: Initial structure. + common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", + and "user_incar_settings" keys. + vasp_input_set: Vasp input set for perturbed structure calculations. + copy_vasp_outputs: Whether or not to copy previous vasp outputs. + supercell_matrix_kwargs: Options that control the size of the supercell. + Will be passed directly to CubicSupercellTransformation in + pymatgen.transformations.advanced_transformations. Note, a diagonal + supercell is required to calculate lattice thermal conductivity. + ensemble: NVT, NPT, etc. + """ + + parent_structure = structure.as_dict() + supercell_matrix_kwargs = supercell_matrix_kwargs or {} + common_settings = _get_common_settings(common_settings) + db_file = common_settings["DB_FILE"] + + logger.debug('Transforming supercell!') + logger.debug('KWARGS: \n {}'.format(supercell_matrix_kwargs)) + st = CubicSupercellTransformation(**supercell_matrix_kwargs) + supercell = st.apply_transformation(structure) + supercell_matrix = st.transformation_matrix + logger.debug('SUPERCELL MATRIX: \n {}'.format(supercell_matrix)) + + nsteps_total = ceil(simulation_time/time_step) + nsteps_each = 500 + nfws = ceil(nsteps_total/nsteps_each) + parents=None + + vasp_input_set = ARCMDSet( + structure=supercell, + ensemble=ensemble, + start_temp=start_temp, + end_temp=end_temp, + nsteps=nsteps_each, + time_step=time_step, + reciprocal_density=1, + small_gap_multiply=None + ) + for ifw in range(nfws): + if ifw>0: + vasp_input_set.update() + parents = aimd_wf.fws[-1] + start_temp = end_temp + + aimd_fw = ARCMDFW( start_structure, + start_temp, + end_temp, + nsteps_fw, + name="AIMD_segment_{}".format(ifw+1), + vasp_input_set=vasp_input_set, + vasp_cmd=VASP_CMD, + wall_time=1080000, + db_file=DB_FILE, + parents=parents, + copy_vasp_outputs=copy_vasp_outputs, + override_default_vasp_params=None, + **kwargs,) + pass_task = pass_vasp_result( + pass_dict={ + "parent_structure": parent_structure, + "supercell_matrix": supercell_matrix, + "forces": ">>output.ionic_steps.:-1.forces", + "stress": ">>output.ionic_steps.:-1.stress", + "configurations": ">>output.ionic_steps.:-1.structure", + "final_configuration": ">>output.ionic_steps.-1.structure" + }, + mod_spec_cmd="_push", + mod_spec_key="aimd", + ) + aimd_fw.tasks.append(pass_task) + if ifw==0: + wf = Workflow.from_Firework(aimd_fw) + else: + wf.append_wf(Workflow.from_Firework(aimd_fw), wf.fws[-1].fw_id) + + collect_fw = CollectMDSegmentsFW( + db_file=db_file, + parents=wf.fws[-nfws:] + ) + wf.append_wf( + Workflow.from_Firework(collect_fw), [fw.fw_id for fw in wf.fws[-nfws:]] + ) + + # Add workflow metadata to all relevant *ToDb tasks. + wf_meta = {"wf_name": "AIMDWF", "wf_version": _WF_VERSION} + for task_name in ["VaspToDb"]: + wf = add_additional_fields_to_taskdocs( + wf, {"wf_meta": wf_meta}, task_name_constraint=task_name + ) + + return wf + + +def _get_common_settings(common_settings: Optional[Dict]): + common_settings = common_settings or {} + for k, v in _DEFAULT_SETTINGS.items(): + if k not in common_settings: + common_settings[k] = v + + user_incar_settings = deepcopy(_aimd_user_incar_settings) + user_incar_settings.update(common_settings.get("user_incar_settings", {})) + common_settings["user_incar_settings"] = user_incar_settings + + return common_settings + + diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index c105ca4b4..dab868dc6 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -190,7 +190,7 @@ def get_lattice_dynamics_wf( **perturbed_structure_kwargs, ) - # 2. Fit interatomic force constants from pertrubed structures + # 2. Fit interatomic force constants from perturbed structures allow_fizzled = {"_allow_fizzled_parents": True} fw_fit_force_constant = FitForceConstantsFW( db_file=db_file, diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 8d898d141..21c5ad522 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -950,3 +950,85 @@ def wf_lattice_dynamics( return wf + +def wf_aimd( + structure: Structure, + c: Optional[dict] = None, + supercell_matrix_kwargs: Optional[dict] = None, + num_supercell_kwargs: Optional[dict] = None, + ensemble='NVT', + simulation_time=10000, + time_step=2, + **aimd_kwargs +) -> Workflow: + """ + Get a workflow to run AIMD on vasp, preceded by a structure optimization. + + Args: + structure: The input structure. + c: Workflow common settings dict. Supports the keys: "VASP_CMD", + "DB_FILE", and "user_incar_settings", "ADD_WF_METADATA", and the + options supported by "add_common_powerups". + **aimd_kwargs: Keyword arguments to be passed directly to the AIMD base workflow. + + Returns: + A workflow to perform AIMD. + """ + + # start with defining the relaxation workflow + optimize_uis = { + "LAECHG": False, + 'ENCUT': 600, + 'ADDGRID': True, + 'EDIFF': 1e-8, + 'EDIFFG': -5e-4, + 'PREC': 'Accurate', + "LREAL": False, + 'LASPH': True, + 'ISPIN': 2, + 'ISMEAR': 0, + 'SIGMA': 0.1, + 'LCHARG': False, + 'LWAVE': False + } + c = c if c is not None else {} + if "USER_INCAR_SETTINGS" not in c: + c["USER_INCAR_SETTINGS"] = {} + + # wf_structure_optimization expects user incar settings in capitals + c["USER_INCAR_SETTINGS"].update(optimize_uis) + c["USER_INCAR_SETTINGS"].update(c.get("user_incar_settings", {})) + wf = wf_structure_optimization(structure, c=c) + + # don't store CHGCAR and other volumetric data in the VASP drone + for task in wf.fws[0].tasks: + if "VaspToDb" in str(task): + task.update(vasp_to_db_params) + + # Define AIMD workflow + wf_aimd = get_aimd_wf( + structure, + common_settings=c, + ensemble=ensemble, + start_temp=start_temp, + end_temp=end_temp, + simulation_time=simulation_time, + time_step=time_step, + copy_vasp_outputs = True, + supercell_matrix_kwargs=supercell_matrix_kwargs, + **aimd_kwargs + ) + + # join the workflows + wf.append_wf(wf_aimd, wf.leaf_fw_ids) + + formula = structure.composition.reduced_formula + wf_name = "{} AIMD - {} - {}K".format(formula,ensemble,end_temp) + wf.name = wf_name + + wf = add_common_powerups(wf, c) + if c.get("ADD_WF_METADATA", ADD_WF_METADATA): + wf = add_wf_metadata(wf, structure) + + return wf + From 75e4846b230cbaf5a89b706d9c09f6d6ad741542 Mon Sep 17 00:00:00 2001 From: jsyony37 Date: Sat, 2 Mar 2024 01:05:41 -0500 Subject: [PATCH 184/207] TI_IFC + clean-up --- atomate/vasp/analysis/lattice_dynamics.py | 124 ++++++++++++------ atomate/vasp/firetasks/lattice_dynamics.py | 91 +++++++------ .../vasp/workflows/base/lattice_dynamics.py | 8 +- 3 files changed, 133 insertions(+), 90 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index 938575ce1..fce785f11 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -747,7 +747,7 @@ def percent_diff(a,b): return abs((a-b)/b) # This process preserves cell symmetry upon thermal expansion, i.e., it prevents # symmetry-identical directions from inadvertently expanding by different ratios - # when the Gruneisen routine returns slighlty different ratios for those directions + # when/if the Gruneisen routine returns slightly different ratios for those directions avg012 = np.mean((grun_total_diag[0],grun_total_diag[1],grun_total_diag[2])) avg01 = np.mean((grun_total_diag[0],grun_total_diag[1])) avg02 = np.mean((grun_total_diag[0],grun_total_diag[2])) @@ -817,9 +817,10 @@ def gruneisen( # cte = grun_tot*heat_capacity.repeat(3)/(vol/10**30)/(bulk_modulus*10**9)/3 cte = grun_tot*heat_capacity.repeat(3).reshape(len(heat_capacity),3)/(vol/10**30)/(bulk_modulus*10**9)/3 cte = np.nan_to_num(cte) - dLfrac = thermal_expansion(temperature,cte) if len(temperature)==1: - dLfrac = dLfrac[-1] + dLfrac = cte*temperature + else: + dLfrac = thermal_expansion(temperature, cte) logger.info('Gruneisen: \n {}'.format(grun_tot)) logger.info('Coefficient of Thermal Expansion: \n {}'.format(cte)) logger.info('Linear Expansion Fraction: \n {}'.format(dLfrac)) @@ -849,19 +850,19 @@ def thermal_expansion( def run_renormalization( structure: Structure, - supercell: Atoms, + supercell_structure: Structure, supercell_matrix: np.ndarray, cs: ClusterSpace, fcs: ForceConstants, param: np.ndarray, T: float, nconfig: int, - max_iter: int, - conv_tresh: float, renorm_method: str, fit_method: str, bulk_modulus: float = None, phonopy_orig: Phonopy = None, + param_TD: np.ndarray = None, + fcs_TD: ForceConstants = None, imaginary_tol: float = IMAGINARY_TOL, ) -> Dict: """ @@ -884,63 +885,100 @@ def run_renormalization( """ nconfig = int(nconfig) - renorm = Renormalization(cs,supercell,fcs,param,T,renorm_method,fit_method) - fcp, fcs, param = renorm.renormalize(nconfig)#,conv_tresh) + supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) + renorm = Renormalization(cs,supercell_atoms,param,fcs,T,renorm_method,fit_method,param_TD=param_TD,fcs_TD=fcs_TD) + fcp_TD, fcs_TD, param_TD = renorm.renormalize(nconfig)#,conv_tresh) - renorm_data, phonopy = harmonic_properties( - structure, supercell_matrix, fcs, [T], imaginary_tol + TD_data, phonopy_TD = harmonic_properties( + structure, supercell_matrix, fcs_TD, [T], imaginary_tol ) - if renorm_data["n_imaginary"] == 0: + if TD_data["n_imaginary"] == 0: logger.info('Renormalized phonon is completely real at T = {} K!'.format(T)) - anharmonic_data = anharmonic_properties( - phonopy, fcs, [T], renorm_data["heat_capacity"], renorm_data["n_imaginary"], bulk_modulus=bulk_modulus - ) + anharmonic_data = anharmonic_properties( + phonopy_TD, fcs_TD, [T], TD_data["heat_capacity"], TD_data["n_imaginary"], bulk_modulus=bulk_modulus + ) + TD_data.update(anharmonic_data) # else: # anharmonic_data = dict() # anharmonic_data["temperature"] = T # anharmonic_data["gruneisen"] = np.array([0,0,0]) # anharmonic_data["thermal_expansion"] = np.array([0,0,0]) # anharmonic_data["expansion_fraction"] = np.array([0,0,0]) - renorm_data.update(anharmonic_data) phonopy_orig.run_mesh() phonopy.run_mesh() - omega0 = phonopy_orig.mesh.frequencies # THz + omega_h = phonopy_orig.mesh.frequencies # THz + evec_h = phonopy_orig.mesh.eigenvectors omega_TD = phonopy.mesh.frequencies # THz - evec = phonopy.mesh.eigenvectors -# natom = phonopy.primitive.get_number_of_atoms() - correction_S, correction_SC = free_energy_correction(omega0,omega_TD,evec,[T]) # eV/atom - - lambda_array = np.array([0,0.1,0.3,0.5,0.7,0.9,1]) - correction_TI = renorm.thermodynamic_integration(lambda_array,param,fcs,TI_nconfig=3) - - renorm_data["free_energy_correction_S"] = correction_S[0] - renorm_data["free_energy_correction_SC"] = correction_SC[0] - renorm_data["free_energy_correction_TI"] = correction_TI - renorm_data["fcp"] = fcp - renorm_data["fcs"] = fcs - renorm_data["param"] = param + evec_TD = phonopy.mesh.eigenvectors + correction_S, correction_SC = free_energy_correction(omega_h,omega_TD,evec_h,evec_TD,[T]) # eV/atom + + TD_data["free_energy_correction_S"] = correction_S # S = -(dF/dT)_V quasiparticle correction + TD_data["free_energy_correction_SC"] = correction_SC # SCPH 4th-order correction (perturbation theory) + TD_data["fcp"] = fcp_TD + TD_data["fcs"] = fcs_TD + TD_data["param"] = param_TD + TD_data['cs'] = cs - return renorm_data + return TD_data +def thermodynamic_integration_ifc( + TD_data: Dict, + fcs: ForceConstants, + param: np.ndarray, + lambda_array: np.ndarray = np.array([0, 0.1, 0.3, 0.5, 0.7, 0.9, 1]), + TI_nconfig=3, +) -> Dict: -def setup_TE_iter(cs,cutoffs,parent_structure,param,temperatures,dLfrac): - new_atoms = AseAtomsAdaptor.get_atoms(parent_structure) - new_cell = Cell(np.transpose([new_atoms.get_cell()[:,i]*(1+dLfrac[0,i]) for i in range(3)])) - new_atoms.set_cell(new_cell,scale_atoms=True) - parent_structure_TE = AseAtomsAdaptor.get_structure(new_atoms) - supercell_atoms_TE = AseAtomsAdaptor.get_atoms(parent_structure_TE*supercell_matrix) - new_cutoffs = [i*(1+np.linalg.norm(dLfrac)) for i in cutoffs] + supercell_structure = TD_data["supercell_structure"] + cs = TD_data['cs'] + fcs_TD = TD_data["fcs"] + param_TD = TD_data["param"] + T = TD_data['temperature'] + supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) + renorm = Renormalization(cs, supercell_atoms, param, fcs, T, 'least_squares', 'rfe', param_TD, fcs_TD) + matcov_TD, matcov_BO, matcov_TDBO = renorm.born_oppenheimer_qcv(TI_nconfig) + correction_TI = renorm.thermodynamic_integration(lambda_array, matcov_TD, matcov_BO, matcov_TDBO, TI_nconfig) + TD_data["free_energy_correction_TI"] = correction_TI + return TD_data + + +def setup_TE_renorm(cs,cutoffs,parent_atoms,supercell_atoms,param,dLfrac): + parent_atoms_TE = copy(parent_atoms) + new_cell = Cell(np.transpose([parent_atoms_TE.get_cell()[:,i]*(1+dLfrac[0,i]) for i in range(3)])) + parent_atoms_TE.set_cell(new_cell,scale_atoms=True) + parent_structure_TE = AseAtomsAdaptor.get_structure(parent_atoms_TE) + supercell_atoms_TE = copy(supercell_atoms) + new_supercell = Cell(np.transpose([supercell_atoms_TE.get_cell()[:,i]*(1+dLfrac[0,i]) for i in range(3)])) + supercell_atoms_TE.set_cell(new_supercell,scale_atoms=True) + supercell_structure_TE = AseAtomsAdaptor.get_structure(supercell_atoms_TE) + count = 0 + failed = False + cs_TE = ClusterSpace(parent_atoms_TE,cutoffs,symprec=1e-2,acoustic_sum_rules=True) while True: - cs_TE = ClusterSpace(atoms,new_cutoffs,1e-3,acoustic_sum_rules=True) + count += 1 if cs_TE.n_dofs == cs.n_dofs: break + elif count>10: + logger.warning("Could not find ClusterSpace for expanded cell identical to the original cluster space!") + failed = True + break + elif count==1: + cutoffs_TE = [i*(1+np.linalg.norm(dLfrac)) for i in cutoffs] elif cs_TE.n_dofs > cs.n_dofs: - new_cutoffs = [i*0.999 for i in new_cutoffs] + cutoffs_TE = [i*0.999 for i in cutoffs_TE] elif cs_TE.n_dofs < cs.n_dofs: - new_cutoffs = [i*1.001 for i in new_cutoffs] - new_fcp = ForceConstantsPotential(cs_TE,param) - fcs_TE.append(new_fcp.get_force_constants(supercell_atoms_TE)) - return parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE + cutoffs_TE = [i*1.001 for i in cutoffs_TE] + cs_TE = ClusterSpace(parent_atoms_TE,cutoffs_TE,symprec=1e-2,acoustic_sum_rules=True) + if failed: + return None, None, None, None, None, failed + else: + fcp_TE = ForceConstantPotential(cs_TE, param) + fcs_TE = fcp_TE.get_force_constants(supercell_atoms_TE) + prim_TE_phonopy = PhonopyAtoms(symbols=parent_atoms_TE.get_chemical_symbols(), + scaled_positions=parent_atoms_TE.get_scaled_positions(), + cell=parent_atoms_TE.cell) + phonopy_TE = Phonopy(prim_TE_phonopy, supercell_matrix=scmat, primitive_matrix=None) + return parent_structure_TE, supercell_structure_TE, cs_TE, phonopy_TE, fcs_TE, failed diff --git a/atomate/vasp/firetasks/lattice_dynamics.py b/atomate/vasp/firetasks/lattice_dynamics.py index ca2b886f7..84a572a60 100644 --- a/atomate/vasp/firetasks/lattice_dynamics.py +++ b/atomate/vasp/firetasks/lattice_dynamics.py @@ -26,7 +26,7 @@ harmonic_properties, anharmonic_properties, run_renormalization, - setup_TE_iter, + setup_TE_renorm, get_cutoffs ) @@ -233,7 +233,7 @@ class RunHiPhiveRenorm(FiretaskBase): bulk_modulus (float): input bulk modulus - required for thermal expansion iterations """ - optional_params = ["renorm_method","temperature","nconfig","conv_thresh","max_iter", + optional_params = ["renorm_method","temperature","nconfig", "renorm_TE_iter","bulk_modulus","imaginary_tol"] @requires(hiphive, "hiphive is required for lattice dynamics workflow") @@ -248,82 +248,88 @@ def run_task(self, fw_spec): cutoffs = fitting_data["cutoffs"] fit_method = fitting_data["fit_method"] - imaginary_tol = fitting_data["imaginary_tol"] parent_structure = structure_data["structure"] supercell_structure = structure_data["supercell_structure"] - supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) supercell_matrix = np.array(structure_data["supercell_matrix"]) temperature = self.get("temperature") renorm_method = self.get("renorm_method") nconfig = self.get("nconfig") - conv_thresh = self.get("conv_thresh") - max_iter = self.get("max_iter") renorm_TE_iter = self.get("renorm_TE_iter") bulk_modulus = self.get("bulk_modulus") + parent_atoms = AseAtomsAdaptor.get_atoms(parent_structure) + supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) + # Renormalization with DFT lattice - renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, temperature, - nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) + TD_data = run_renormalization(parent_structure, supercell_structure, supercell_matrix, + cs, fcs, param, temperature, nconfig, renorm_method, + fit_method, bulk_modulus, phonopy_orig) + TD_structure_data = copy(structure_data) + TD_structure_data["structure"] = parent_structure + TD_structure_data["supercell_structure"] = supercell_structure # Additional renormalization with thermal expansion - optional - just single "iteration" for now if renorm_TE_iter: n_TE_iter = 1 for i in range(n_TE_iter): - if renorm_data is None: # failed or incomplete + if TD_data is None: # failed or incomplete break elif result["n_imaginary"] < 0: # still imaginary break else: logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) + dLfrac = TD_data["expansion_fraction"] + param_TD = TD_data["param"] + a, b, c, d, e, failed = setup_TE_renorm( + cs,cutoffs,parent_atoms,supercell_atoms,param_TD,temperature,dLfrac + ) + if not failed: + parent_structure_TD, supercell_structure_TD, cs_TD, phonopy_TD, fcs_TD = a, b, c, d, e + TD_data = run_renormalization(parent_structure_TD, supercell_structure_TD, supercell_matrix, + cs_TD, fcs, param, temperature, nconfig, + renorm_method, fit_method, bulk_modulus, + phonopy_TD, param_TD, fcs_TD + ) + TD_structure_data["structure"] = parent_structure_TD + TD_structure_data["supercell_structure"] = supercell_structure_TD + + # Thermodynamic integration for anharmonic free energy + TD_data = thermodynamic_integration_ifc(TD_data, # everything TD + fcs, # original + param, # original + ) - dLfrac = renorm_data["expansion_fraction"] - param = renorm_data["param"] - - parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE = setup_TE_iter(cs,cutoffs,parent_structure,param,temperature,dLfrac) - prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) - prim_TE_phonopy = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), - scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) - phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) - - renorm_data = run_renormalization(parent_structure_TE, supercell_atoms_TE, supercell_matrix, - cs_TE, fcs_TE, param, temperature, nconfig, max_iter, - conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE) - structure_data["structure"] = parent_structure_TE - structure_data["supercell_structure"] = AseAtomsAdaptor.get_structure(supercell_atoms_TE) - # write results logger.info("Writing renormalized results") - renorm_thermal_data = dict() - fcs = renorm_data['fcs'] - fcs.write("force_constants.fcs") + fcs_TD = TD_data['fcs'] + fcs_TD.write("force_constants.fcs") thermal_keys = ["temperature","free_energy","entropy","heat_capacity", "gruneisen","thermal_expansion","expansion_fraction", "free_energy_correction_S","free_energy_correction_SC", "free_energy_correction_TI"] - renorm_thermal_data = {key: [] for key in thermal_keys} + TD_thermal_data = {key: [] for key in thermal_keys} for key in thermal_keys: - renorm_thermal_data[key].append(renorm_data[key]) + TD_thermal_data[key].append(TD_data[key]) - logger.info("DEBUG: ",renorm_data) - if renorm_data["n_imaginary"] > 0: - logger.warning('Imaginary modes remain for {} K!'.format(temperature)) - logger.warning('ShengBTE files not written') - logger.warning('No renormalization with thermal expansion') + logger.info("DEBUG: ",TD_data) + if TD_data["n_imaginary"] > 0: + logger.warning('Imaginary modes remain still exist') + logger.warning('ShengBTE FORCE_CONSTANTS_2ND not written') else: - logger.info("No imaginary modes! Writing ShengBTE files") - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND".format(temperature), format="text") + logger.info("No imaginary modes! Writing ShengBTE FORCE_CONSTANTS_2ND...") + fcs_TD.write_to_phonopy("FORCE_CONSTANTS_2ND".format(temperature), format="text") - dumpfn(structure_data, "structure_data.json".format(temperature)) - dumpfn(renorm_thermal_data, "renorm_thermal_data.json".format(temperature)) + dumpfn(TD_structure_data, "structure_data.json") + dumpfn(TD_thermal_data, "thermal_data.json") @explicit_serialize class ForceConstantsToDb(FiretaskBase): """ Add force constants, phonon band structure and density of states - to the database. + and thermal properties to the database. Assumes you are in a directory with the force constants, fitting data, and structure data written to files. @@ -352,7 +358,6 @@ def run_task(self, fw_spec): db_file = env_chk(self.get("db_file"), fw_spec) mmdb = VaspCalcDb.from_db_file(db_file, admin=True) renormalized = self.get("renormalized", False) - renorm_temperature = self.get("renorm_temperature", None) mesh_density = self.get("mesh_density", 100.0) structure_data = loadfn("structure_data.json") @@ -400,9 +405,9 @@ def run_task(self, fw_spec): logger.info("Finished inserting force constants and phonon data") else: - renorm_thermal_data = loadfn("renorm_thermal_data.json") + TD_thermal_data = loadfn("thermal_data.json") fcs = ForceConstants.read("force_constants.fcs") - T = renorm_thermal_data["temperature"] + T = TD_thermal_data["temperature"] dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( structure, supercell_matrix, fcs, mesh_density, mmdb @@ -415,7 +420,7 @@ def run_task(self, fw_spec): "structure": structure.as_dict(), "supercell_matrix": supercell_matrix, "supercell_structure": supercell_structure.as_dict(), - "thermal_data": renorm_thermal_data, + "thermal_data": TD_thermal_data, "force_constants_fs_id": fc_fsid, "phonon_dos_fs_id": dos_fsid, "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, diff --git a/atomate/vasp/workflows/base/lattice_dynamics.py b/atomate/vasp/workflows/base/lattice_dynamics.py index dab868dc6..1aa1568a4 100644 --- a/atomate/vasp/workflows/base/lattice_dynamics.py +++ b/atomate/vasp/workflows/base/lattice_dynamics.py @@ -339,10 +339,10 @@ def get_perturbed_structure_wf( vasp_input_set = MPStaticSet(structure) # find the smallest nearest neighbor distance taking into account PBC - min_distance = np.min( - [n.nn_distance for d in structure.get_all_neighbors(10) for n in d] - ) - scaled_min_distance = min_distance * min_nn_scale +# min_distance = np.min( +# [n.nn_distance for d in structure.get_all_neighbors(10) for n in d] +# ) +# scaled_min_distance = min_distance * min_nn_scale all_rattle_stds = np.repeat(rattle_stds, n_configs_per_std) logger.debug("Using supercell_matrix of: {}".format(supercell_matrix)) From 72c74cac6566c175d3c3c056362b6234691bfa25 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 4 Mar 2024 20:35:05 -0800 Subject: [PATCH 185/207] parse_output (fix conflicts and cleanup) --- atomate/vasp/firetasks/parse_outputs.py | 71 +------------------------ 1 file changed, 1 insertion(+), 70 deletions(-) diff --git a/atomate/vasp/firetasks/parse_outputs.py b/atomate/vasp/firetasks/parse_outputs.py index 1efb2b28c..a8b423401 100644 --- a/atomate/vasp/firetasks/parse_outputs.py +++ b/atomate/vasp/firetasks/parse_outputs.py @@ -1,8 +1,3 @@ -<<<<<<< HEAD -======= -# coding: utf-8 - ->>>>>>> 7a7f01df (Remove old firetasks) import json import os import re @@ -10,28 +5,11 @@ from datetime import datetime import numpy as np -<<<<<<< HEAD -======= - -from monty.json import MontyEncoder, jsanitize -from pydash.objects import has, get - -from atomate.vasp.config import DEFUSE_UNSUCCESSFUL ->>>>>>> 816883c7 (Cleaned up code (made functions for CSLD firetask, adhered to PEP guidelines, etc.)) from fireworks import FiretaskBase, FWAction, explicit_serialize from fireworks.utilities.fw_serializers import DATETIME_HANDLER -<<<<<<< HEAD -<<<<<<< HEAD from monty.json import MontyEncoder, jsanitize from monty.os.path import zpath from pydash.objects import get, has -======= -from fireworks import Firework -======= ->>>>>>> 7a7f01df (Remove old firetasks) - -from pymatgen import Structure ->>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) from pymatgen.analysis.elasticity.elastic import ElasticTensor, ElasticTensorExpansion from pymatgen.analysis.elasticity.strain import Deformation, Strain from pymatgen.analysis.elasticity.stress import Stress @@ -50,36 +28,12 @@ from pymatgen.electronic_structure.boltztrap import BoltztrapAnalyzer from pymatgen.io.vasp.sets import get_vasprun_outcar from pymatgen.symmetry.analyzer import SpacegroupAnalyzer -<<<<<<< HEAD -======= -from pymatgen.analysis.ferroelectricity.polarization import Polarization, get_total_ionic_dipole, \ - EnergyTrend -from pymatgen.analysis.magnetism import CollinearMagneticStructureAnalyzer, Ordering, magnetic_deformation -from pymatgen.command_line.bader_caller import bader_analysis_from_path -<<<<<<< HEAD -from pymatgen.io.vasp.sets import MPStaticSet ->>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) -======= ->>>>>>> 7a7f01df (Remove old firetasks) from atomate.common.firetasks.glue_tasks import get_calc_loc from atomate.utils.utils import env_chk, get_logger, get_meta_from_structure -from atomate.vasp.config import DEFUSE_UNSUCCESSFUL, STORE_VOLUMETRIC_DATA +from atomate.vasp.config import DEFUSE_UNSUCCESSFUL, STORE_VOLUMETRIC_DATA, STORE_BADER from atomate.vasp.database import VaspCalcDb -<<<<<<< HEAD -<<<<<<< HEAD from atomate.vasp.drones import BADER_EXE_EXISTS, VaspDrone -======= -from atomate.vasp.drones import VaspDrone -<<<<<<< HEAD -from atomate.vasp.fireworks.core import StaticFW ->>>>>>> 9a28c322 (Added dynamic fireworks for possible error handling (i.e. larger displacement values)) -======= ->>>>>>> fd3cc888 (Added fw_spec updates to all dynamically added fireworks and wrote a ShengBTE firetask) -======= -from atomate.vasp.drones import VaspDrone, BADER_EXE_EXISTS -from atomate.vasp.config import STORE_VOLUMETRIC_DATA, STORE_BADER ->>>>>>> 13ec960c (VASP runs successfully) __author__ = "Anubhav Jain, Kiran Mathew, Shyam Dwaraknath" __email__ = "ajain@lbl.gov, kmathew@lbl.gov, shyamd@lbl.gov" @@ -123,7 +77,6 @@ class VaspToDb(FiretaskBase): Format: {key : path} -> fw.spec[key] = task_doc[path] The path is a full mongo-style path so subdocuments can be referenced using dot notation and array keys can be referenced using the index. -<<<<<<< HEAD E.g "calcs_reversed.0.output.outcar.run_stats" """ @@ -143,17 +96,6 @@ class VaspToDb(FiretaskBase): "parse_bader", "store_volumetric_data", ] -======= - E.g "calcs_reversed.0.output.outar.run_stats" - vasp_drone_params (dict): Additional keyword arguments to pass to the - VaspDrone. - """ - optional_params = ["calc_dir", "calc_loc", "parse_dos", "bandstructure_mode", - "additional_fields", "db_file", "fw_spec_field", "defuse_unsuccessful", - "task_fields_to_push", "parse_chgcar", "parse_aeccar", - "parse_potcar_file", - "store_volumetric_data", "vasp_drone_params"] ->>>>>>> cf160919 (Tweak VaspToDb params) def run_task(self, fw_spec): # get the directory that contains the VASP dir to parse @@ -166,7 +108,6 @@ def run_task(self, fw_spec): # parse the VASP directory logger.info(f"PARSING DIRECTORY: {calc_dir}") -<<<<<<< HEAD drone = VaspDrone( additional_fields=self.get("additional_fields"), parse_dos=self.get("parse_dos", False), @@ -179,16 +120,6 @@ def run_task(self, fw_spec): "store_volumetric_data", STORE_VOLUMETRIC_DATA ), ) -======= - drone = VaspDrone(additional_fields=self.get("additional_fields"), - parse_dos=self.get("parse_dos", False), - parse_potcar_file=self.get("parse_potcar_file", True), - bandstructure_mode=self.get("bandstructure_mode", False), - parse_chgcar=self.get("parse_chgcar", False), # deprecated - parse_aeccar=self.get("parse_aeccar", False), # deprecated - store_volumetric_data=self.get("store_volumetric_data", STORE_VOLUMETRIC_DATA), - **self.get("vasp_drone_params", {})) ->>>>>>> cf160919 (Tweak VaspToDb params) # assimilate (i.e., parse) task_doc = drone.assimilate(calc_dir) From 2b733377b7b7cf326638a6d7691e5c4908d3a513 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 4 Mar 2024 21:05:44 -0800 Subject: [PATCH 186/207] cleanup imports --- atomate/vasp/firetasks/run_calc.py | 7 ------- 1 file changed, 7 deletions(-) diff --git a/atomate/vasp/firetasks/run_calc.py b/atomate/vasp/firetasks/run_calc.py index 1eb017431..9b771c221 100644 --- a/atomate/vasp/firetasks/run_calc.py +++ b/atomate/vasp/firetasks/run_calc.py @@ -10,14 +10,7 @@ from custodian import Custodian from custodian.vasp.handlers import ( AliasingErrorHandler, -<<<<<<< HEAD DriftErrorHandler, -======= - MeshSymmetryErrorHandler, - UnconvergedErrorHandler, -# MaxForceErrorHandler, - PotimErrorHandler, ->>>>>>> c012f5fb (ARC AIMD) FrozenJobErrorHandler, IncorrectSmearingHandler, LargeSigmaHandler, From b8d024668deba812c39f0eaeb641931075778404 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 16:19:28 -0800 Subject: [PATCH 187/207] remove aimd wf --- atomate/common/powerups.py | 38 ------ atomate/vasp/fireworks/core.py | 82 ------------- atomate/vasp/workflows/base/aimd.py | 162 ------------------------- atomate/vasp/workflows/presets/core.py | 110 +---------------- 4 files changed, 2 insertions(+), 390 deletions(-) delete mode 100644 atomate/vasp/workflows/base/aimd.py diff --git a/atomate/common/powerups.py b/atomate/common/powerups.py index f9658f89f..d76db63b5 100644 --- a/atomate/common/powerups.py +++ b/atomate/common/powerups.py @@ -1,4 +1,3 @@ -<<<<<<< HEAD """ This module defines general powerups that can be used for all workflows """ @@ -319,40 +318,3 @@ def powerup_by_kwargs( if not found: raise RuntimeError(f"Could not find powerup {name}.") return original_wf -======= -from typing import Dict, Any, Optional - -from fireworks import Workflow -from atomate.utils.utils import get_fws_and_tasks - - -def update_firetask( - original_wf: Workflow, - update_params: Dict[str, Any], - task_name_constraint: str, - fw_name_constraint: Optional[str] = None, -) -> Workflow: - """ - General powerup for arbitrary updates to a Firetask. - - Args: - original_wf: The original workflow. - update_params: A dictionary of the keyword arguments to update. - task_name_constraint: Only apply changes to the Firetasks where the - Firetask class name contains this string. - fw_name_constraint: Only apply changes to Fireworks where the Firework - name contains this substring. - - Returns: - Workflow - """ - idx_list = get_fws_and_tasks( - original_wf, - fw_name_constraint=fw_name_constraint, - task_name_constraint=task_name_constraint, - ) - for idx_fw, idx_t in idx_list: - original_wf.fws[idx_fw].tasks[idx_t].update(update_params) - - return original_wf ->>>>>>> bd235a73 (Add powerup for updating any firetask) diff --git a/atomate/vasp/fireworks/core.py b/atomate/vasp/fireworks/core.py index 373635e30..7292a64dc 100644 --- a/atomate/vasp/fireworks/core.py +++ b/atomate/vasp/fireworks/core.py @@ -64,10 +64,6 @@ def __init__( db_file=DB_FILE, force_gamma=True, job_type="double_relaxation_run", -<<<<<<< HEAD -======= -# max_force_threshold=RELAX_MAX_FORCE, ->>>>>>> c012f5fb (ARC AIMD) auto_npar=">>auto_npar<<", half_kpts_first_relax=HALF_KPOINTS_FIRST_RELAX, parents=None, @@ -103,13 +99,8 @@ def __init__( and job_type == "double_relaxation" ): warnings.warn( -<<<<<<< HEAD f"A double relaxation run might not be appropriate with ISIF {vasp_input_set.incar['ISIF']}" ) -======= - "A double relaxation run might not be appropriate with ISIF {}".format( - vasp_input_set.incar["ISIF"])) ->>>>>>> 23b88a18 (Tidy docstrings) t = [] t.append(WriteVaspFromIOSet(structure=structure, vasp_input_set=vasp_input_set)) @@ -117,10 +108,6 @@ def __init__( RunVaspCustodian( vasp_cmd=vasp_cmd, job_type=job_type, -<<<<<<< HEAD -======= -# max_force_threshold=max_force_threshold, ->>>>>>> c012f5fb (ARC AIMD) ediffg=ediffg, auto_npar=auto_npar, half_kpts_first_relax=half_kpts_first_relax, @@ -153,26 +140,11 @@ def __init__( **kwargs, ): """ -<<<<<<< HEAD Structure optimization using the SCAN metaGGA functional. If this Firework is initialized with no parents, it will perform a GGA optimization of the provided structure using the PBESol functional. This GGA-relaxed structure is intended to be passed to a second instance of this Firework for optimization with SCAN. (see workflow definition in metagga_optimization.yaml) -======= - Structure optimization using the SCAN metaGGA functional. - - This workflow performs a 3-step optmization. The first step ('relax1') - is a conventional GGA run relaxation that initializes the geometry and - calculates the bandgap of the structure. The bandgap is used to update - the KSPACING parameter, which sets the appropriate number of k-points - for the structure. The second step ('.relax2') is a static GGA - calculation that computes wavefunctions using the updated number of - k-points. The third step ('relax3') is a SCAN relaxation. - - By default, .relax1 and .relax2 are force converged with - EDIFFG = -0.05, and .relax3 is force converged with EDIFFG=-0.02. ->>>>>>> 23b88a18 (Tidy docstrings) Args: structure (Structure): Input structure. Note that for prev_calc_loc jobs, the structure @@ -216,7 +188,6 @@ def __init__( is not supported by this InputSet." ) -<<<<<<< HEAD if prev_calc_dir: has_previous_calc = True # Copy the CHGCAR from previous calc directory (usually PBE) @@ -247,59 +218,6 @@ def __init__( raise UserWarning( "You specified prev_calc_loc but did not provide a parent Firework. Set " "parents and try again." -======= - t = [] - # write the VASP input files based on MPScanRelaxSet - t.append(WriteVaspFromIOSet(structure=structure, - vasp_input_set=orig_input_set - ) - ) - - # pass the CalcLoc so that CopyFilesFromCalcLoc can find the directory - t.append(PassCalcLocs(name=name)) - - # Copy the pre-compiled VdW kernel for VASP, if required - if orig_input_set.vdw is not None: - t.append(CopyFiles(from_dir=vdw_kernel_dir)) - - # Copy original inputs with the ".orig" suffix - t.append( - CopyFilesFromCalcLoc( - calc_loc=True, - name_append=".orig", - exclude_files=["vdw_kernel.bindat", "FW.json", "FW--*"], - ) - ) - - # Update the INCAR for the GGA preconditioning step - # Disable writing the WAVECAR because the no. of k-points will likely - # change before the next step in the calculation - pre_opt_settings = {"_set": {"METAGGA": None, - "EDIFFG": -0.05, - "LWAVE": False}} - - # Disable vdW for the precondition step - if orig_input_set.incar.get("LUSE_VDW", None): - pre_opt_settings.update({"_unset": {"LUSE_VDW": True, - "BPARAM": 15.7}}) - - t.append(ModifyIncar(incar_dictmod=pre_opt_settings)) - - # Run the GGA .relax1 step - t.append(RunVaspCustodian(vasp_cmd=vasp_cmd, - job_type="normal_no_backup", - gzip_output=False - ) - ) - - # Copy GGA outputs with '.relax1' suffix - # by the subsequent UpdateScanRelaxBandgap Firetask - t.append( - CopyFilesFromCalcLoc( - calc_loc=True, - name_append=".relax1", - exclude_files=["vdw_kernel.bindat", "FW.json", "FW--*", "*.orig"], ->>>>>>> 23b88a18 (Tidy docstrings) ) if has_previous_calc: diff --git a/atomate/vasp/workflows/base/aimd.py b/atomate/vasp/workflows/base/aimd.py deleted file mode 100644 index 096aea5e6..000000000 --- a/atomate/vasp/workflows/base/aimd.py +++ /dev/null @@ -1,162 +0,0 @@ -import math -import warnings -from copy import deepcopy -from typing import Dict, List, Optional, Union -import numpy as np -from monty.serialization import loadfn, dumpfn - -from atomate.utils.utils import get_logger -from atomate.vasp.config import DB_FILE, VASP_CMD -from atomate.vasp.firetasks import pass_vasp_result -from atomate.vasp.analysis.lattice_dynamics import ( - FIT_METHOD, - MESH_DENSITY, -) -from atomate.vasp.fireworks.core import TransmuterFW, OptimizeFW -from atomate.vasp.fireworks.aimd import ARCMDFW, CollectMDSegmentsFW -from atomate.common.powerups import add_additional_fields_to_taskdocs -from fireworks import Workflow -from pymatgen.core.structure import Structure -from pymatgen.io.vasp.sets import ARCMDSet, VaspInputSet -from pymatgen.symmetry.analyzer import SpacegroupAnalyzer -from pymatgen.transformations.advanced_transformations import ( - CubicSupercellTransformation, -) - -__author__ = "Junsoo Park" -__email__ = "junsoo.park@nasa.gov" -__date__ = "December 2023" - -logger = get_logger(__name__) - -vasp_to_db_params = { - "store_volumetric_data": tuple(), - "vasp_drone_params": {"parse_bader": False, "parse_locpot": False} -} - -_DEFAULT_SETTINGS = {"VASP_CMD": VASP_CMD, "DB_FILE": DB_FILE} -_WF_VERSION = 0.1 - - -def get_aimd_wf( - structure: Structure, - common_settings: Dict = None, - ensemble='NVT', - start_temp=start_temp, - end_temp=end_temp, - simulation_time = simulation_time, - time_step = time_step, - copy_vasp_outputs = True, - supercell_matrix_kwargs: Optional[dict] = None -): - """ - This workflow will perform AIMD on VASP, - - Args: - structure: Initial structure. - common_settings: Common settings dict. Supports "VASP_CMD", "DB_FILE", - and "user_incar_settings" keys. - vasp_input_set: Vasp input set for perturbed structure calculations. - copy_vasp_outputs: Whether or not to copy previous vasp outputs. - supercell_matrix_kwargs: Options that control the size of the supercell. - Will be passed directly to CubicSupercellTransformation in - pymatgen.transformations.advanced_transformations. Note, a diagonal - supercell is required to calculate lattice thermal conductivity. - ensemble: NVT, NPT, etc. - """ - - parent_structure = structure.as_dict() - supercell_matrix_kwargs = supercell_matrix_kwargs or {} - common_settings = _get_common_settings(common_settings) - db_file = common_settings["DB_FILE"] - - logger.debug('Transforming supercell!') - logger.debug('KWARGS: \n {}'.format(supercell_matrix_kwargs)) - st = CubicSupercellTransformation(**supercell_matrix_kwargs) - supercell = st.apply_transformation(structure) - supercell_matrix = st.transformation_matrix - logger.debug('SUPERCELL MATRIX: \n {}'.format(supercell_matrix)) - - nsteps_total = ceil(simulation_time/time_step) - nsteps_each = 500 - nfws = ceil(nsteps_total/nsteps_each) - parents=None - - vasp_input_set = ARCMDSet( - structure=supercell, - ensemble=ensemble, - start_temp=start_temp, - end_temp=end_temp, - nsteps=nsteps_each, - time_step=time_step, - reciprocal_density=1, - small_gap_multiply=None - ) - for ifw in range(nfws): - if ifw>0: - vasp_input_set.update() - parents = aimd_wf.fws[-1] - start_temp = end_temp - - aimd_fw = ARCMDFW( start_structure, - start_temp, - end_temp, - nsteps_fw, - name="AIMD_segment_{}".format(ifw+1), - vasp_input_set=vasp_input_set, - vasp_cmd=VASP_CMD, - wall_time=1080000, - db_file=DB_FILE, - parents=parents, - copy_vasp_outputs=copy_vasp_outputs, - override_default_vasp_params=None, - **kwargs,) - pass_task = pass_vasp_result( - pass_dict={ - "parent_structure": parent_structure, - "supercell_matrix": supercell_matrix, - "forces": ">>output.ionic_steps.:-1.forces", - "stress": ">>output.ionic_steps.:-1.stress", - "configurations": ">>output.ionic_steps.:-1.structure", - "final_configuration": ">>output.ionic_steps.-1.structure" - }, - mod_spec_cmd="_push", - mod_spec_key="aimd", - ) - aimd_fw.tasks.append(pass_task) - if ifw==0: - wf = Workflow.from_Firework(aimd_fw) - else: - wf.append_wf(Workflow.from_Firework(aimd_fw), wf.fws[-1].fw_id) - - collect_fw = CollectMDSegmentsFW( - db_file=db_file, - parents=wf.fws[-nfws:] - ) - wf.append_wf( - Workflow.from_Firework(collect_fw), [fw.fw_id for fw in wf.fws[-nfws:]] - ) - - # Add workflow metadata to all relevant *ToDb tasks. - wf_meta = {"wf_name": "AIMDWF", "wf_version": _WF_VERSION} - for task_name in ["VaspToDb"]: - wf = add_additional_fields_to_taskdocs( - wf, {"wf_meta": wf_meta}, task_name_constraint=task_name - ) - - return wf - - -def _get_common_settings(common_settings: Optional[Dict]): - common_settings = common_settings or {} - for k, v in _DEFAULT_SETTINGS.items(): - if k not in common_settings: - common_settings[k] = v - - user_incar_settings = deepcopy(_aimd_user_incar_settings) - user_incar_settings.update(common_settings.get("user_incar_settings", {})) - common_settings["user_incar_settings"] = user_incar_settings - - return common_settings - - diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 21c5ad522..0f8b5ec3b 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -1,23 +1,14 @@ -<<<<<<< HEAD -from uuid import uuid4 - -import numpy as np -======= -# coding: utf-8 from typing import Optional - from uuid import uuid4 - import numpy as np from atomate.vasp.workflows.base.lattice_dynamics import \ - get_lattice_dynamics_wf, vasp_to_db_params + get_lattice_dynamics_wf, vasp_to_db_params + from fireworks import Workflow from pymatgen import Structure from pymatgen.io.vasp.sets import MPRelaxSet, MPStaticSet, MPHSERelaxSet ->>>>>>> 7cb526cb (Rewrite preset workflow) from pymatgen.io.vasp.inputs import Kpoints -from pymatgen.io.vasp.sets import MPHSERelaxSet, MPRelaxSet, MPStaticSet from atomate.vasp.config import ( ADD_WF_METADATA, @@ -33,11 +24,8 @@ add_stability_check, add_wf_metadata, ) -<<<<<<< HEAD from atomate.vasp.workflows.base.bulk_modulus import get_wf_bulk_modulus -======= from atomate.vasp.analysis.lattice_dynamics import FIT_METHOD ->>>>>>> 0da85957 (small fix for cutoffs and fit_method) from atomate.vasp.workflows.base.core import get_wf from atomate.vasp.workflows.base.elastic import get_wf_elastic_constant from atomate.vasp.workflows.base.gibbs import get_wf_gibbs_free_energy @@ -337,7 +325,6 @@ def wf_elastic_constant(structure, c=None, order=2, sym_reduce=False): uis_optimize = {"ENCUT": 700, "EDIFF": 1e-6, "LAECHG": False, "LREAL": False} if order > 2: -<<<<<<< HEAD uis_optimize.update( { "EDIFF": 1e-10, @@ -347,10 +334,6 @@ def wf_elastic_constant(structure, c=None, order=2, sym_reduce=False): "ISYM": 0, } ) -======= - uis_optimize.update({"EDIFF": 1e-8, "EDIFFG": -0.001, - "ADDGRID": True, "LREAL": False, "ISYM": 0}) ->>>>>>> 16220e12 (Tweak lattice dynamics settings) # This ensures a consistent k-point mesh across all calculations # We also turn off symmetry to prevent VASP from changing the # mesh internally @@ -855,12 +838,6 @@ def wf_nudged_elastic_band(structures, parent, c=None): def wf_lattice_dynamics( structure: Structure, fit_method: str = FIT_METHOD, -<<<<<<< HEAD -======= - fit_method: str = False, ->>>>>>> 2e30eb4a (remove separate_fit) -======= ->>>>>>> ac887694 (clean-up) disp_cut: float = None, bulk_modulus: float = None, c: Optional[dict] = None, @@ -949,86 +926,3 @@ def wf_lattice_dynamics( wf = add_wf_metadata(wf, structure) return wf - - -def wf_aimd( - structure: Structure, - c: Optional[dict] = None, - supercell_matrix_kwargs: Optional[dict] = None, - num_supercell_kwargs: Optional[dict] = None, - ensemble='NVT', - simulation_time=10000, - time_step=2, - **aimd_kwargs -) -> Workflow: - """ - Get a workflow to run AIMD on vasp, preceded by a structure optimization. - - Args: - structure: The input structure. - c: Workflow common settings dict. Supports the keys: "VASP_CMD", - "DB_FILE", and "user_incar_settings", "ADD_WF_METADATA", and the - options supported by "add_common_powerups". - **aimd_kwargs: Keyword arguments to be passed directly to the AIMD base workflow. - - Returns: - A workflow to perform AIMD. - """ - - # start with defining the relaxation workflow - optimize_uis = { - "LAECHG": False, - 'ENCUT': 600, - 'ADDGRID': True, - 'EDIFF': 1e-8, - 'EDIFFG': -5e-4, - 'PREC': 'Accurate', - "LREAL": False, - 'LASPH': True, - 'ISPIN': 2, - 'ISMEAR': 0, - 'SIGMA': 0.1, - 'LCHARG': False, - 'LWAVE': False - } - c = c if c is not None else {} - if "USER_INCAR_SETTINGS" not in c: - c["USER_INCAR_SETTINGS"] = {} - - # wf_structure_optimization expects user incar settings in capitals - c["USER_INCAR_SETTINGS"].update(optimize_uis) - c["USER_INCAR_SETTINGS"].update(c.get("user_incar_settings", {})) - wf = wf_structure_optimization(structure, c=c) - - # don't store CHGCAR and other volumetric data in the VASP drone - for task in wf.fws[0].tasks: - if "VaspToDb" in str(task): - task.update(vasp_to_db_params) - - # Define AIMD workflow - wf_aimd = get_aimd_wf( - structure, - common_settings=c, - ensemble=ensemble, - start_temp=start_temp, - end_temp=end_temp, - simulation_time=simulation_time, - time_step=time_step, - copy_vasp_outputs = True, - supercell_matrix_kwargs=supercell_matrix_kwargs, - **aimd_kwargs - ) - - # join the workflows - wf.append_wf(wf_aimd, wf.leaf_fw_ids) - - formula = structure.composition.reduced_formula - wf_name = "{} AIMD - {} - {}K".format(formula,ensemble,end_temp) - wf.name = wf_name - - wf = add_common_powerups(wf, c) - if c.get("ADD_WF_METADATA", ADD_WF_METADATA): - wf = add_wf_metadata(wf, structure) - - return wf - From 743666efa77dfeb6a03d31b440d2e1f2bbb5b56e Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 18:05:45 -0800 Subject: [PATCH 188/207] Update fixes --- atomate/vasp/analysis/lattice_dynamics.py | 173 +--------------------- 1 file changed, 6 insertions(+), 167 deletions(-) diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index fce785f11..c86dbe9fb 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -1,5 +1,6 @@ from itertools import product -from typing import Dict, List, Tuple +from joblib import Parallel, delayed +from typing import Dict, List, Tuple, Optional import numpy as np import scipy as sp @@ -8,20 +9,11 @@ from copy import copy from atomate.utils.utils import get_logger -<<<<<<< HEAD -<<<<<<< HEAD -from pymatgen import Structure -======= -======= from hiphive import (ForceConstants, ForceConstantPotential, enforce_rotational_sum_rules, ClusterSpace, StructureContainer) -<<<<<<< HEAD ->>>>>>> 1e75a82a (imports) -======= from hiphive.force_constant_model import ForceConstantModel ->>>>>>> 0d613579 (revert to structure container for fitting) from hiphive.cutoffs import is_cutoff_allowed, estimate_maximum_cutoff from hiphive.fitting import Optimizer from hiphive.renormalization import Renormalization @@ -30,7 +22,6 @@ from pymatgen.core.structure import Structure from pymatgen.io.ase import AseAtomsAdaptor ->>>>>>> 8f4f7e37 (gruneisen and CTE) from pymatgen.io.phonopy import get_phonopy_structure from ase.atoms import Atoms @@ -40,8 +31,8 @@ from phono3py.phonon3.gruneisen import Gruneisen -__author__ = "Alex Ganose, Rees Chang, Junsoo Park" -__email__ = "aganose@lbl.gov, rc564@cornell.edu, jsyony37@lbl.gov" +__author__ = "Alex Ganose, Rees Chang, Junsoo Park, Zhuoying Zhu" +__email__ = "aganose@lbl.gov, rc564@cornell.edu, jsyony37@lbl.gov, zyzhu@lbl.gov" logger = get_logger(__name__) @@ -69,11 +60,7 @@ def get_cutoffs(structure: Structure): """ -<<<<<<< HEAD - Get a list of trial cutoffs based on a structure. -======= Get a list of trial cutoffs based on a supercell structure for grid search. ->>>>>>> b637d9a8 (update) An initial guess for the lower bound of the cutoffs is made based on the average period (row) of the elements in the structure, according to: @@ -99,15 +86,9 @@ def get_cutoffs(structure: Structure): ====== ==== ===== Cutoff Max Step ====== ==== ===== -<<<<<<< HEAD - 2ND +3.0 0.5 - 3RD +1.5 0.25 - 4TH +1.0 0.25 -======= 2ND +2.0 1.0 3RD +1.5 0.75 4TH +0.6 0.6 ->>>>>>> b637d9a8 (update) ====== ==== ===== Args: @@ -123,28 +104,11 @@ def get_cutoffs(structure: Structure): 3: {1: 3.0, 2: 3.5, 3: 4.5, 4: 5.5, 5: 6.0, 6: 6.5, 7: 7.0}, 4: {1: 2.5, 2: 3.0, 3: 3.5, 4: 4.0, 5: 4.5, 6: 5.0, 7: 5.5}, } -<<<<<<< HEAD -<<<<<<< HEAD -<<<<<<< HEAD - inc = {2: 3, 3: 1.5, 4: 1} - steps = {2: 0.5, 3: 0.25, 4: 0.25} - - row = min([s.row for s in structure.species]) -======= - inc = {2: 2, 3: 1, 4: 0.5} - steps = {2: 1, 3: 0.5, 4: 0.5} -======= - inc = {2: 2, 3: 1.5, 4: 0.5} - steps = {2: 1, 3: 0.75, 4: 0.5} ->>>>>>> c69d0316 (fixed cutoff) -======= inc = {2: 2, 3: 1.5, 4: 0.6} steps = {2: 1, 3: 0.75, 4: 0.6} ->>>>>>> b637d9a8 (update) row = int(np.around(np.array([s.row for s in supercell_structure.species]).mean(),0)) factor = row/4 ->>>>>>> cc7520c5 (separate fitting) mins = { 2: min_cutoffs[2][row], 3: min_cutoffs[3][row], 4: min_cutoffs[4][row] } @@ -153,9 +117,6 @@ def get_cutoffs(structure: Structure): range_three = np.arange(mins[3], mins[3] + factor*(inc[3]+steps[3]), factor*steps[3]) range_four = np.arange(mins[4], mins[4] + factor*(inc[4]+steps[4]), factor*steps[4]) -<<<<<<< HEAD - return list(map(list, product(range_two, range_three, range_four))) -======= cutoffs = np.array(list(map(list, product(range_two, range_three, range_four)))) max_cutoff = estimate_maximum_cutoff(AseAtomsAdaptor.get_atoms(supercell_structure)) cutoffs[cutoffs>max_cutoff] = max_cutoff-0.2 @@ -164,7 +125,6 @@ def get_cutoffs(structure: Structure): good_cutoffs = np.all(cutoffs < max_cutoff-0.1, axis=1) logger.info('GOOD CUTOFFS \n{}'.format(good_cutoffs)) return cutoffs[good_cutoffs].tolist() ->>>>>>> c094a175 (cutoff vs cell_size) def fit_force_constants( @@ -175,13 +135,9 @@ def fit_force_constants( disp_cut: float = 0.055, imaginary_tol: float = IMAGINARY_TOL, fit_method: str = FIT_METHOD, -<<<<<<< HEAD -) -> Tuple["SortedForceConstants", Dict]: -======= n_jobs: int = -1, fit_kwargs: Optional[Dict] = None ) -> Tuple["SortedForceConstants", np.ndarray, ClusterSpace, Dict]: ->>>>>>> fddd9681 (get_cutoffs) """ Fit force constants using hiphive and select the optimum cutoff values. @@ -220,14 +176,7 @@ def fit_force_constants( ``SortedForceConstants`` object, array of parameters, cluster space, and a dictionary of information on the fitting results. """ -<<<<<<< HEAD - from hiphive.fitting import Optimizer - from hiphive import ForceConstantPotential, enforce_rotational_sum_rules - - logger.info("Starting fitting force constants.") -======= logger.info("Starting force constant fitting.") ->>>>>>> 8f4f7e37 (gruneisen and CTE) fitting_data = { "cutoffs": [], @@ -242,20 +191,13 @@ def fit_force_constants( best_fit = { "n_imaginary": np.inf, -<<<<<<< HEAD - "free_energy": np.inf, -======= "rmse_test": np.inf, "cluster_space": None, ->>>>>>> cd00c732 (cluster_space to best_fit) "force_constants": None, "parameters":None, "cutoffs": None, } n_cutoffs = len(all_cutoffs) -<<<<<<< HEAD - for i, cutoffs in enumerate(all_cutoffs): -======= fit_kwargs = fit_kwargs if fit_kwargs else {} if fit_method == "rfe" and n_jobs == -1: @@ -374,48 +316,15 @@ def _run_cutoffs( supercell_atoms = structures[0] if not is_cutoff_allowed(supercell_atoms, max(cutoffs)): ->>>>>>> 8f4f7e37 (gruneisen and CTE) logger.info( - "Testing cutoffs {} out of {}: {}".format(i, n_cutoffs, cutoffs) + "Skipping cutoff due as it is not commensurate with supercell size" ) -<<<<<<< HEAD - sc = get_structure_container(cutoffs, structures) -<<<<<<< HEAD - opt = Optimizer(sc.get_fit_data(), fit_method) -======= - logger.info('{}, {}: FINE UNTIL SC'.format(i,cutoffs)) - opt = Optimizer(sc.get_fit_data(), fit_method, **fit_kwargs) - logger.info('{}, {}: FINE UNTIL OPT'.format(i,cutoffs)) ->>>>>>> fddd9681 (get_cutoffs) -======= return None cs = ClusterSpace(supercell_atoms, cutoffs, symprec=1e-3, acoustic_sum_rules=True) logger.debug(cs.__repr__()) n2nd = cs.get_n_dofs_by_order(2) nall = cs.n_dofs -<<<<<<< HEAD - - if separate_fit: - logger.info('Fitting harmonic force constants separately') -# fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, -# disp_cut, ncut=n2nd, param2=None) - sc = get_structure_container(cs, structures, separate_fit, disp_cut, - ncut=n2nd, param2=None) - opt = Optimizer(sc.get_fit_data(), - fit_method, - [0,n2nd], - **fit_kwargs) -<<<<<<< HEAD - logger.info('Optimizer set up for cutoff: {}, {}'.format(i,cutoffs)) ->>>>>>> 79348b89 (bulk_mod input) -======= ->>>>>>> cc7520c5 (separate fitting) - opt.train() - param_harmonic = opt.parameters # harmonic force constant parameters - - logger.info('Fitting anharmonic force constants separately') -======= logger.info('Fitting harmonic force constants separately') separate_fit = True @@ -446,7 +355,6 @@ def _run_cutoffs( if imaginary: logger.info('Imaginary modes found! Fitting anharmonic force constants separately') ->>>>>>> 2e30eb4a (remove separate_fit) # fit_data = get_fit_data(cs, supercell_atoms, structures, separate_fit, # disp_cut, ncut=n2nd, param2=param_harmonic) sc = get_structure_container(cs, structures, separate_fit, disp_cut, @@ -457,75 +365,7 @@ def _run_cutoffs( **fit_kwargs) opt.train() param_anharmonic = opt.parameters # anharmonic force constant parameters - -<<<<<<< HEAD - parameters = enforce_rotational_sum_rules( - sc.cluster_space, opt.parameters, ["Huang", "Born-Huang"] - ) - fcp = ForceConstantPotential(sc.cluster_space, parameters) - fcs = fcp.get_force_constants(supercell_atoms) - logger.info('FCS generated for cutoff {}, {}'.format(i,cutoffs)) - n_imaginary, min_freq, free_energy, entropy, Cv, grun, cte, dLfrac = evaluate_force_constants( - parent_structure, supercell_matrix, fcs, bulk_modulus, T_QHA, imaginary_tol - ) -<<<<<<< HEAD -<<<<<<< HEAD -<<<<<<< HEAD - - fitting_data["cutoffs"].append(cutoffs) - fitting_data["rmse_test"].append(opt.rmse_test) - fitting_data["n_imaginary"].append(n_imaginary) - fitting_data["min_frequency"].append(min_freq) - fitting_data["300K_free_energy"].append(free_energy) - - if ( - min_freq > -np.abs(max_imaginary_freq) - and n_imaginary <= max_n_imaginary - and n_imaginary < best_fit["n_imaginary"] - and free_energy < best_fit["free_energy"] - ): - best_fit.update( - { - "n_imaginary": n_imaginary, - "free_energy": free_energy, - "force_constants": fcs, - "cutoffs": cutoffs, - } - ) - fitting_data["best"] = cutoffs - - logger.info("Finished fitting force constants.") - - return best_fit["force_constants"], fitting_data -======= -======= - logger.info('evaluate_force_constants success!') ->>>>>>> fddd9681 (get_cutoffs) -======= - logger.info('evaluate_force_constants success: {}, {}'.format(i,cutoffs)) ->>>>>>> 79348b89 (bulk_mod input) - return { - "cutoffs": cutoffs, - "rmse_test": opt.rmse_test, - "n_imaginary": n_imaginary, - "min_frequency": min_freq, - "temperature": T_QHA, - "free_energy": free_energy, - "entropy": entropy, - "heat_capacity": Cv, - "thermal_expansion": cte, - "cluster_space": sc.cluster_space, - "parameters": parameters, - "force_constants": fcs - } - except Exception: - return None ->>>>>>> 8f4f7e37 (gruneisen and CTE) - - -def get_structure_container( - cutoffs: List[float], structures: List["Atoms"] -======= + parameters = np.concatenate((param_harmonic,param_anharmonic)) # combine assert(nall==len(parameters)) logger.info('Training complete for cutoff: {}, {}'.format(i,cutoffs)) @@ -572,7 +412,6 @@ def get_structure_container( disp_cut: float, ncut: int, param2: np.ndarray ->>>>>>> cc7520c5 (separate fitting) ) -> "StructureContainer": """ Get a hiPhive StructureContainer from cutoffs and a list of atoms objects. From 78bec862424dae83d2b40c5e07c77de366ea9f77 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 18:42:57 -0800 Subject: [PATCH 189/207] remove requirements.txt --- atomate/vasp/analysis/lattice_dynamics.py | 3 +-- requirements-optional.txt | 2 -- requirements.txt | 16 ---------------- setup.py | 1 + 4 files changed, 2 insertions(+), 20 deletions(-) delete mode 100644 requirements-optional.txt delete mode 100644 requirements.txt diff --git a/atomate/vasp/analysis/lattice_dynamics.py b/atomate/vasp/analysis/lattice_dynamics.py index c86dbe9fb..9489d3a0c 100644 --- a/atomate/vasp/analysis/lattice_dynamics.py +++ b/atomate/vasp/analysis/lattice_dynamics.py @@ -404,7 +404,6 @@ def _run_cutoffs( except Exception: return None - def get_structure_container( cs: ClusterSpace, structures: List["Atoms"], @@ -820,4 +819,4 @@ def setup_TE_renorm(cs,cutoffs,parent_atoms,supercell_atoms,param,dLfrac): scaled_positions=parent_atoms_TE.get_scaled_positions(), cell=parent_atoms_TE.cell) phonopy_TE = Phonopy(prim_TE_phonopy, supercell_matrix=scmat, primitive_matrix=None) - return parent_structure_TE, supercell_structure_TE, cs_TE, phonopy_TE, fcs_TE, failed + return parent_structure_TE, supercell_structure_TE, cs_TE, phonopy_TE, fcs_TE, failed \ No newline at end of file diff --git a/requirements-optional.txt b/requirements-optional.txt deleted file mode 100644 index 8218f9e81..000000000 --- a/requirements-optional.txt +++ /dev/null @@ -1,2 +0,0 @@ -f90nml==1.1.2 -ase==3.19.0 diff --git a/requirements.txt b/requirements.txt deleted file mode 100644 index a8b26d3e4..000000000 --- a/requirements.txt +++ /dev/null @@ -1,16 +0,0 @@ -numpy==1.16.4 -scipy==1.2.0 -FireWorks==1.9.0 -pymatgen_diffusion==2019.2.28 -monty==2.0.4 -paramiko==2.4.2 -tqdm==4.32.1 -six==1.12.0 -pybtex==0.22.2 -ruamel.yaml==0.15.96 -pandas==0.24.2 -pymatgen==2019.5.8 -custodian==2019.2.10 -networkx==2.2 -pydash==4.7.4 -pymongo==3.10.1 diff --git a/setup.py b/setup.py index 1f028bae2..5b050a0ce 100644 --- a/setup.py +++ b/setup.py @@ -46,6 +46,7 @@ "phonons": ["phonopy>=1.10.8"], "qchem": ["openbabel-wheel"], "defects": ["pymatgen-analysis-defects"], + "hiphive": ["hiphive","phono3py","ase>=3.19.0"] "complete": [ "matplotlib>=1.5.2", "phonopy>=1.10.8", From affcb2650f28409bec6eee4809ea020a268f7e03 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 18:48:12 -0800 Subject: [PATCH 190/207] install dependencies --- setup.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/setup.py b/setup.py index 5b050a0ce..f1a95da42 100644 --- a/setup.py +++ b/setup.py @@ -46,7 +46,7 @@ "phonons": ["phonopy>=1.10.8"], "qchem": ["openbabel-wheel"], "defects": ["pymatgen-analysis-defects"], - "hiphive": ["hiphive","phono3py","ase>=3.19.0"] + "hiphive": ["hiphive","phono3py","ase>=3.19.0"], "complete": [ "matplotlib>=1.5.2", "phonopy>=1.10.8", From c5432bfcc93044b8a1e7ee0fc56e0d0b23a67ec6 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 18:59:23 -0800 Subject: [PATCH 191/207] add setup --- setup.py | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/setup.py b/setup.py index f1a95da42..77acc3e54 100644 --- a/setup.py +++ b/setup.py @@ -46,11 +46,14 @@ "phonons": ["phonopy>=1.10.8"], "qchem": ["openbabel-wheel"], "defects": ["pymatgen-analysis-defects"], - "hiphive": ["hiphive","phono3py","ase>=3.19.0"], + "hiphive": ["hiphive>=1.1","phono3py","ase>=3.19.0"], "complete": [ "matplotlib>=1.5.2", "phonopy>=1.10.8", "openbabel-wheel", + "hiphive>=1.1", + "phono3py", + "ase>=3.19.0", "boto3>=1.28.15", "Flask>=2.3.2", "coverage>=7.2.7", From 2026f42b51590bded18589f9d569ce53d8976fe6 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 19:26:12 -0800 Subject: [PATCH 192/207] update phono3py dependencies --- setup.py | 6 ++++-- 1 file changed, 4 insertions(+), 2 deletions(-) diff --git a/setup.py b/setup.py index 77acc3e54..2d9b4c011 100644 --- a/setup.py +++ b/setup.py @@ -46,13 +46,15 @@ "phonons": ["phonopy>=1.10.8"], "qchem": ["openbabel-wheel"], "defects": ["pymatgen-analysis-defects"], - "hiphive": ["hiphive>=1.1","phono3py","ase>=3.19.0"], + "hiphive": ["hiphive>=1.1","phono3py==2.3.2","ase>=3.19.0"], "complete": [ "matplotlib>=1.5.2", "phonopy>=1.10.8", "openbabel-wheel", "hiphive>=1.1", - "phono3py", + "phono3py==2.3.2", + "cmake==3.22.4", + "spglib==1.16.5", "ase>=3.19.0", "boto3>=1.28.15", "Flask>=2.3.2", From 68124f647e27410509b3941cd218cbd069ed7408 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 20:04:54 -0800 Subject: [PATCH 193/207] install f90nml --- setup.py | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/setup.py b/setup.py index 2d9b4c011..a92256448 100644 --- a/setup.py +++ b/setup.py @@ -46,12 +46,13 @@ "phonons": ["phonopy>=1.10.8"], "qchem": ["openbabel-wheel"], "defects": ["pymatgen-analysis-defects"], - "hiphive": ["hiphive>=1.1","phono3py==2.3.2","ase>=3.19.0"], + "hiphive": ["hiphive>=1.1","phono3py==2.3.2","f90nml==1.3.1","ase>=3.19.0"], "complete": [ "matplotlib>=1.5.2", "phonopy>=1.10.8", "openbabel-wheel", "hiphive>=1.1", + "f90nml==1.3.1", "phono3py==2.3.2", "cmake==3.22.4", "spglib==1.16.5", @@ -77,5 +78,5 @@ "Topic :: Other/Nonlisted Topic", "Topic :: Scientific/Engineering", ], - scripts=[join("scripts", f) for f in os.listdir(join(module_dir, "scripts"))], + scripts=[join("scripts", f) for f in os.listdir(join(module_dir, "scripts"))] ) From c6a5747523d143789b6c35b55bfcb95510f1b47d Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Tue, 5 Mar 2024 22:31:56 -0800 Subject: [PATCH 194/207] Update requirements --- .github/workflows/test.yml | 4 ++++ setup.py | 20 +++++++++----------- 2 files changed, 13 insertions(+), 11 deletions(-) diff --git a/.github/workflows/test.yml b/.github/workflows/test.yml index ce22bba3f..5bc02192e 100644 --- a/.github/workflows/test.yml +++ b/.github/workflows/test.yml @@ -34,6 +34,10 @@ jobs: sudo apt-get install libopenbabel-dev # https://github.com/openbabel/openbabel/issues/2408#issuecomment-1014466193 sudo ln -s /usr/include/openbabel3 /usr/local/include/openbabel3 + + - name: Install phono3py + run: | + conda install -c conda-forge phono3py - name: Install dependencies run: | diff --git a/setup.py b/setup.py index a92256448..957e8dc5c 100644 --- a/setup.py +++ b/setup.py @@ -33,8 +33,8 @@ "paramiko", "pydash>=7.0.6", "pymatgen-analysis-diffusion>=2023.8.15", - "pymatgen-analysis-defects>=2023.7.24", - "pymatgen>=2023.7.20", + "pymatgen-analysis-defects==2023.7.24", + "pymatgen==2023.7.20", "pymongo", "pyyaml>=5.1.2", "ruamel.yaml", @@ -43,20 +43,18 @@ ], extras_require={ "plotting": ["matplotlib>=1.5.2"], - "phonons": ["phonopy>=1.10.8"], + "phonons": ["phonopy>=2.21.0"], "qchem": ["openbabel-wheel"], "defects": ["pymatgen-analysis-defects"], - "hiphive": ["hiphive>=1.1","phono3py==2.3.2","f90nml==1.3.1","ase>=3.19.0"], + "hiphive": ["hiphive @ git+https://gitlab.com/jsyony37/hiphive.git@personal#egg=hiphive","f90nml==1.3.1","ase>=3.22.1"], "complete": [ "matplotlib>=1.5.2", - "phonopy>=1.10.8", + "phonopy>=2.21.0", "openbabel-wheel", - "hiphive>=1.1", - "f90nml==1.3.1", - "phono3py==2.3.2", - "cmake==3.22.4", - "spglib==1.16.5", - "ase>=3.19.0", + "hiphive @ git+https://gitlab.com/jsyony37/hiphive.git@personal#egg=hiphive", + "f90nml==1.4.4", + "spglib>=2.2.0", + "ase>=3.22.1", "boto3>=1.28.15", "Flask>=2.3.2", "coverage>=7.2.7", From dce7e2de365d9e3eb94daeef904dec57388a506f Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Wed, 6 Mar 2024 11:20:48 -0800 Subject: [PATCH 195/207] fix tests file --- .../tests/test_polarization_to_db.py | 35 +++---------------- 1 file changed, 4 insertions(+), 31 deletions(-) diff --git a/atomate/vasp/firetasks/tests/test_polarization_to_db.py b/atomate/vasp/firetasks/tests/test_polarization_to_db.py index b85b0da70..23cb62d58 100644 --- a/atomate/vasp/firetasks/tests/test_polarization_to_db.py +++ b/atomate/vasp/firetasks/tests/test_polarization_to_db.py @@ -1,11 +1,7 @@ -<<<<<<< HEAD import os -======= import bson import gzip - from pathlib import Path ->>>>>>> 45fcce62 (Tidy polarization tests) from atomate.utils.testing import AtomateTest from atomate.vasp.firetasks.parse_outputs import PolarizationToDb @@ -13,10 +9,9 @@ __author__ = "Tess Smidt" __email__ = "blondegeek@gmail.com" -<<<<<<< HEAD -module_dir = os.path.dirname(os.path.abspath(__file__)) -db_dir = os.path.join(module_dir, "..", "..", "..", "common", "test_files") -ref_dir = os.path.join(module_dir, "..", "..", "test_files") +module_dir = Path(__file__).resolve().parent +db_dir = module_dir / "../../../common/test_files" +ref_dir = module_dir / "../../test_files" DEBUG_MODE = ( @@ -24,32 +19,14 @@ ) # If None, runs a "fake" VASP. Otherwise, runs VASP with this command... VASP_CMD = None -======= -module_dir = Path(__file__).resolve().parent -db_dir = module_dir / "../../../common/test_files" -<<<<<<< HEAD -ref_dir = module_dir / "../..//test_files" ->>>>>>> 45fcce62 (Tidy polarization tests) -======= -ref_dir = module_dir / "../../test_files" ->>>>>>> fcdf2e63 (Finish tidying polarization tests) + class TestPolarizationFiretasks(AtomateTest): def test_polarizationtodb(self): -<<<<<<< HEAD - import gzip - - import bson - - reference_dir = os.path.abspath(os.path.join(ref_dir, "ferroelectric_wf")) - - with gzip.open(os.path.join(reference_dir, "tasks.bson.gz")) as f: -======= wf_dir = ref_dir / "ferroelectric_wf" with gzip.open(wf_dir / "tasks.bson.gz") as f: ->>>>>>> 45fcce62 (Tidy polarization tests) coll_raw = f.read() coll = bson.decode_all(coll_raw) @@ -69,8 +46,4 @@ def test_polarizationtodb(self): # Check recovered change in polarization coll = self.get_task_collection("polarization_tasks") d = coll.find_one() -<<<<<<< HEAD - self.assertAlmostEqual(d["polarization_change_norm"], 46.288752795325244, 5) -======= self.assertAlmostEqual(d["polarization_change_norm"], 46.28875279532, 5) ->>>>>>> 45fcce62 (Tidy polarization tests) From 4d835dd6d672192508852ebd6141e6e7f5dbfea4 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Wed, 6 Mar 2024 14:18:42 -0800 Subject: [PATCH 196/207] delate aimd and csld related codes --- atomate/utils/tests/test_database.py | 10 +- atomate/vasp/firetasks/aimd.py | 501 ------------------ atomate/vasp/fireworks/aimd.py | 193 ------- atomate/vasp/workflows/presets/core.py | 2 +- .../workflows/tests/test_csld_workflow.py | 175 ------ .../tests/test_lattice_dynamics_workflow.py | 2 +- .../workflows/tests/test_vasp_workflows.py | 4 +- 7 files changed, 9 insertions(+), 878 deletions(-) delete mode 100644 atomate/vasp/firetasks/aimd.py delete mode 100644 atomate/vasp/fireworks/aimd.py delete mode 100644 atomate/vasp/workflows/tests/test_csld_workflow.py diff --git a/atomate/utils/tests/test_database.py b/atomate/utils/tests/test_database.py index 0d1555f0f..03ce4879d 100644 --- a/atomate/utils/tests/test_database.py +++ b/atomate/utils/tests/test_database.py @@ -6,7 +6,7 @@ import boto3 from maggma.stores import MemoryStore -from moto import mock_s3 +from moto import mock_aws __author__ = "Jimmy Shen " @@ -37,7 +37,7 @@ def tearDownClass(cls): cls.testdb.connection.drop_database(cls.testdb.db_name) def test_s3_valid(self): - with mock_s3(): + with mock_aws(): conn = boto3.resource("s3", region_name="us-east-1") conn.create_bucket(Bucket="test_bucket") index_store = MemoryStore() @@ -50,7 +50,7 @@ def test_s3_valid(self): self.assertEqual(res["data"], "111111111110111111") def test_s3_not_valid(self): - with mock_s3(): + with mock_aws(): conn = boto3.resource("s3", region_name="us-east-1") conn.create_bucket(Bucket="test_bucket_2") index_store = MemoryStore() @@ -61,7 +61,7 @@ def test_s3_not_valid(self): store.connect() def test_maggma_store_names(self): - with mock_s3(): + with mock_aws(): conn = boto3.resource("s3", region_name="us-east-1") conn.create_bucket(Bucket="test_bucket") index_store = MemoryStore() @@ -84,7 +84,7 @@ def test_uri(self): calc_db.collection.insert_one({"task_id": "mp-1", "data": "12345"}) self.assertEqual(calc_db.collection.find_one()["data"], "12345") - with mock_s3(): + with mock_aws(): conn = boto3.resource("s3", region_name="us-east-1") conn.create_bucket(Bucket="test_bucket") uri_db = TestToDb.from_db_file(db_dir + "/db_aws_uri.json") diff --git a/atomate/vasp/firetasks/aimd.py b/atomate/vasp/firetasks/aimd.py deleted file mode 100644 index 83a2ff286..000000000 --- a/atomate/vasp/firetasks/aimd.py +++ /dev/null @@ -1,501 +0,0 @@ -import json -import os -import subprocess -import shlex -from datetime import datetime -from pathlib import Path - -import numpy as np -from copy import copy, deepcopy - -from monty.dev import requires -from monty.serialization import dumpfn, loadfn -from monty.json import jsanitize -from pymongo import ReturnDocument - -from atomate.utils.utils import env_chk, get_logger -from atomate.vasp.database import VaspCalcDb -from atomate.vasp.drones import VaspDrone - -from fireworks import FiretaskBase, FWAction, explicit_serialize - -from pymatgen.core.structure import Structure -from pymatgen.transformations.standard_transformations import ( - SupercellTransformation, -) - - -__author__ = "Junsoo Park" -__email__ = "junsoo.park@nasa.gov" - -logger = get_logger(__name__) - - -@explicit_serialize -class CollectMDSegments(FiretaskBase): - """ - Aggregate the structures and forces of perturbed supercells. - - Requires a ``perturbed_tasks`` key to be set in the fw_spec, containing a - list of dictionaries, each with the keys: - - - "parent_structure": The original structure. - - "supercell_matrix": The supercell transformation matrix. - - "structure": The perturbed supercell structure. - - "forces": The forces on each site in the supercell. - """ - - def run_task(self, fw_spec): - results = fw_spec.get("aimd", []) - logger.info("Found {} AIMD segments".format(len(results))) - - structures = [r["structure"] for r in results] - forces = [np.asarray(r["forces"][i]) for i in range(len(r)) for r in results] - stress = [np.asarray(r["stress"][i]) for i in range(len(r)) for r in results] - configs = [r["configurations"][i] for i in range(len(r)) for r in results] - - # if relaxation, get original structure from that calculation - calc_locs = fw_spec.get("calc_locs", []) - opt_calc_locs = [c for c in calc_locs if "optimiz" in c["name"]] - if opt_calc_locs: - opt_loc = opt_calc_locs[-1]["path"] - logger.info("Parsing optimization directory: {}".format(opt_loc)) - opt_doc = VaspDrone( - parse_dos=False, parse_locpot=False, - parse_bader=False, store_volumetric_data=[], - ).assimilate(opt_loc) - opt_output = opt_doc["calcs_reversed"][0]["output"] - structure = Structure.from_dict(opt_output["structure"]) - else: - structure = results[0]["parent_structure"] - supercell_matrix = results[0]["supercell_matrix"] - - # regenerate pure supercell structure - st = SupercellTransformation(supercell_matrix) - supercell_structure = st.apply_transformation(structure) - - structure_data = { - "structure": structure, - "supercell_structure": supercell_structure, - "supercell_matrix": supercell_matrix, - } - - logger.info("Writing structure and forces data.") - dumpfn(structures, "perturbed_structures.json") - dumpfn(forces, "perturbed_forces.json") - dumpfn(structure_data, "structure_data.json") - - -@explicit_serialize -class MDToDB(FiretaskBase): - required_params = ["db_file"] - optional_params = ["renormalized","renorm_temperature","mesh_density", "additional_fields"] - - def run_task(self, fw_spec): - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "renormalization_dir": os.getcwd()} - data = { - "created_at": datetime.utcnow(), - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, - "structure": structure.as_dict(), - "supercell_matrix": supercell_matrix, - "supercell_structure": supercell_structure.as_dict(), - "perturbed_structures": [s.as_dict() for s in perturbed_structures], - "perturbed_forces": [f.tolist() for f in forces], - "fitting_data": fitting_data, - "thermal_data": thermal_data, - "force_constants_fs_id": fc_fsid, - "phonon_dos_fs_id": dos_fsid, - "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, - "phonon_bandstructure_line_fs_id": lm_bs_fsid, - } - data.update(self.get("additional_fields", {})) - data.update(metadata) - data = jsanitize(data, strict=True, allow_bson=True) - mmdb.db.aimd_for_potential_fitting.insert_one(data) - - logger.info("Finished inserting renormalized force constants and phonon data at {} K".format(T)) - - return FWAction(update_spec=metadata) - - -@explicit_serialize -class RunHiPhive(FiretaskBase): - """ - Fit force constants using hiPhive. - - Requires "perturbed_structures.json", "perturbed_forces.json", and - "structure_data.json" files to be present in the current working directory. - - Optional parameters: - cutoffs (Optional[list[list]]): A list of cutoffs to trial. If None, - a set of trial cutoffs will be generated based on the structure - (default). - disp_cut: determines the mean displacement of perturbed - structure to be included in harmonic (<) or anharmonic (>) fitting - imaginary_tol (float): Tolerance used to decide if a phonon mode - is imaginary, in THz. - fit_method (str): Method used for fitting force constants. This can - be any of the values allowed by the hiphive ``Optimizer`` class. - """ - - optional_params = [ - "cutoffs", - "disp_cut", - "temperature_qha", - "bulk_modulus", - "imaginary_tol", - "fit_method", - ] - - @requires(hiphive, "hiphive is required for lattice dynamics workflow") - def run_task(self, fw_spec): - - all_structures = loadfn("perturbed_structures.json") - all_forces = loadfn("perturbed_forces.json") - structure_data = loadfn("structure_data.json") - parent_structure = structure_data["structure"] - supercell_structure = structure_data["supercell_structure"] - supercell_matrix = np.array(structure_data["supercell_matrix"]) - - disp_cut = self.get('disp_cut', None) - cutoffs = self.get("cutoffs") or get_cutoffs(supercell_structure) - T_qha = self.get("temperature_qha", T_QHA) - T_qha.sort() - imaginary_tol = self.get("imaginary_tol") - bulk_modulus = self.get("bulk_modulus") - fit_method = self.get("fit_method") - - structures = [] - supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) - for structure, forces in zip(all_structures, all_forces): - atoms = AseAtomsAdaptor.get_atoms(structure) - displacements = get_displacements(atoms, supercell_atoms) - atoms.new_array("displacements", displacements) - atoms.new_array("forces", forces) - atoms.positions = supercell_atoms.get_positions() - structures.append(atoms) - - fcs, param, cs, fitting_data = fit_force_constants( - parent_structure, - supercell_matrix, - structures, - cutoffs, - disp_cut, - imaginary_tol, - fit_method - ) - - if fcs is None: - # fitting failed for some reason - raise RuntimeError( - "Could not find a force constant solution" - ) - - thermal_data, phonopy = harmonic_properties( - parent_structure, supercell_matrix, fcs, T_qha, imaginary_tol - ) - anharmonic_data = anharmonic_properties( - phonopy, fcs, T_qha, thermal_data["heat_capacity"], - thermal_data["n_imaginary"], bulk_modulus - ) - - phonopy.save("phonopy_orig.yaml") - fitting_data["n_imaginary"] = thermal_data.pop("n_imaginary") - thermal_data.update(anharmonic_data) - dumpfn(fitting_data, "fitting_data.json") - dumpfn(thermal_data, "thermal_data.json") - - logger.info("Writing cluster space and force_constants") - logger.info("{}".format(type(fcs))) - fcs.write("force_constants.fcs") - np.savetxt('parameters.txt',param) - cs.write('cluster_space.cs') - - if fitting_data["n_imaginary"] == 0: - logger.info("No imaginary modes! Writing ShengBTE files") - atoms = AseAtomsAdaptor.get_atoms(parent_structure) - fcs.write_to_shengBTE("FORCE_CONSTANTS_3RD", atoms, order=3) - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND", format="text") - else: - logger.info("ShengBTE files not written due to imaginary modes.") - logger.info("You may want to perform phonon renormalization.") - - - -@explicit_serialize -class RunHiPhiveRenorm(FiretaskBase): - """ - Perform phonon renormalization to obtain dependent-temperature force constants - using hiPhive. Requires "structure_data.json" to be present in the current working - directory. - - Required parameters: - - Optional parameter: - temperature (float): temperature to perform renormalization - renorm_TE_iter (bool): if True, perform outer iteration over thermally expanded volumes - bulk_modulus (float): input bulk modulus - required for thermal expansion iterations - """ - - optional_params = ["renorm_method","temperature","nconfig","conv_thresh","max_iter", - "renorm_TE_iter","bulk_modulus","imaginary_tol"] - - @requires(hiphive, "hiphive is required for lattice dynamics workflow") - def run_task(self, fw_spec): - - cs = ClusterSpace.read('cluster_space.cs') - fcs = ForceConstants.read('force_constants.fcs') - param = np.loadtxt('parameters.txt') - fitting_data = loadfn("fitting_data.json") - structure_data = loadfn("structure_data.json") - phonopy_orig = phpy.load("phonopy_orig.yaml") - - cutoffs = fitting_data["cutoffs"] - fit_method = fitting_data["fit_method"] - imaginary_tol = fitting_data["imaginary_tol"] - - parent_structure = structure_data["structure"] - supercell_structure = structure_data["supercell_structure"] - supercell_atoms = AseAtomsAdaptor.get_atoms(supercell_structure) - supercell_matrix = np.array(structure_data["supercell_matrix"]) - - temperature = self.get("temperature") - renorm_method = self.get("renorm_method") - nconfig = self.get("nconfig") - conv_thresh = self.get("conv_thresh") - max_iter = self.get("max_iter") - renorm_TE_iter = self.get("renorm_TE_iter") - bulk_modulus = self.get("bulk_modulus") - - # Renormalization with DFT lattice - renorm_data = run_renormalization(parent_structure, supercell_atoms, supercell_matrix, cs, fcs, param, temperature, - nconfig, max_iter, conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_orig) - - # Additional renormalization with thermal expansion - optional - just single "iteration" for now - if renorm_TE_iter: - n_TE_iter = 1 - for i in range(n_TE_iter): - if renorm_data is None: # failed or incomplete - break - elif result["n_imaginary"] < 0: # still imaginary - break - else: - logger.info("Renormalizing with thermally expanded lattice - iteration {}".format(i)) - - dLfrac = renorm_data["expansion_fraction"] - param = renorm_data["param"] - - parent_structure_TE, supercell_atoms_TE, cs_TE, fcs_TE = setup_TE_iter(cs,cutoffs,parent_structure,param,temperature,dLfrac) - prim_TE_atoms = AseAtomsAdaptor.get_atoms(parent_structure_TE) - prim_TE_phonopy = PhonopyAtoms(symbols=prim_TE_atoms.get_chemical_symbols(), - scaled_positions=prim_TE_atoms.get_scaled_positions(), cell=prim_TE_atoms.cell) - phonopy_TE = Phonopy(prim_phonopy_TE, supercell_matrix=scmat, primitive_matrix=None) - - renorm_data = run_renormalization(parent_structure_TE, supercell_atoms_TE, supercell_matrix, - cs_TE, fcs_TE, param, temperature, nconfig, max_iter, - conv_thresh, renorm_method, fit_method, bulk_modulus, phonopy_TE) - structure_data["structure"] = parent_structure_TE - structure_data["supercell_structure"] = AseAtomsAdaptor.get_structure(supercell_atoms_TE) - - # write results - logger.info("Writing renormalized results") - renorm_thermal_data = dict() - fcs = renorm_data['fcs'] - fcs.write("force_constants.fcs") - thermal_keys = ["temperature","free_energy","entropy","heat_capacity", - "gruneisen","thermal_expansion","expansion_fraction", - "free_energy_correction_S","free_energy_correction_SC"] - renorm_thermal_data = {key: [] for key in thermal_keys} - for key in thermal_keys: - renorm_thermal_data[key].append(renorm_data[key]) - - logger.info("DEBUG: ",renorm_data) - if renorm_data["n_imaginary"] > 0: - logger.warning('Imaginary modes remain for {} K!'.format(temperature)) - logger.warning('ShengBTE files not written') - logger.warning('No renormalization with thermal expansion') - else: - logger.info("No imaginary modes! Writing ShengBTE files") - fcs.write_to_phonopy("FORCE_CONSTANTS_2ND".format(temperature), format="text") - - dumpfn(structure_data, "structure_data.json".format(temperature)) - dumpfn(renorm_thermal_data, "renorm_thermal_data.json".format(temperature)) - - -@explicit_serialize -class ForceConstantsToDb(FiretaskBase): - """ - Add force constants, phonon band structure and density of states - to the database. - - Assumes you are in a directory with the force constants, fitting - data, and structure data written to files. - - Required parameters: - db_file (str): Path to DB file for the database that contains the - perturbed structure calculations. - - Optional parameters: - renormalized (bool): Whether FC resulted from original fitting (False) - or renormalization process (True) determines how data are stored. - Default is False. - mesh_density (float): The density of the q-point mesh used to calculate - the phonon density of states. See the docstring for the ``mesh`` - argument in Phonopy.init_mesh() for more details. - additional_fields (dict): Additional fields added to the document, such - as user-defined tags, name, ids, etc. - """ - - required_params = ["db_file"] - optional_params = ["renormalized","renorm_temperature","mesh_density", "additional_fields"] - - @requires(hiphive, "hiphive is required for lattice dynamics workflow") - def run_task(self, fw_spec): - - db_file = env_chk(self.get("db_file"), fw_spec) - mmdb = VaspCalcDb.from_db_file(db_file, admin=True) - renormalized = self.get("renormalized", False) - renorm_temperature = self.get("renorm_temperature", None) - mesh_density = self.get("mesh_density", 100.0) - - structure_data = loadfn("structure_data.json") - structure = structure_data["structure"] - supercell_structure = structure_data["supercell_structure"] - supercell_matrix = structure_data["supercell_matrix"] - - if not renormalized: - perturbed_structures = loadfn("perturbed_structures.json") - forces = loadfn("perturbed_forces.json") - fitting_data = loadfn("fitting_data.json") - thermal_data = loadfn("thermal_data.json") - fcs = ForceConstants.read("force_constants.fcs") - - dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( - structure, supercell_matrix, fcs, mesh_density, mmdb - ) - - data = { - "created_at": datetime.utcnow(), - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, - "structure": structure.as_dict(), - "supercell_matrix": supercell_matrix, - "supercell_structure": supercell_structure.as_dict(), - "perturbed_structures": [s.as_dict() for s in perturbed_structures], - "perturbed_forces": [f.tolist() for f in forces], - "fitting_data": fitting_data, - "thermal_data": thermal_data, - "force_constants_fs_id": fc_fsid, - "phonon_dos_fs_id": dos_fsid, - "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, - "phonon_bandstructure_line_fs_id": lm_bs_fsid, - } - data.update(self.get("additional_fields", {})) - - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "fc_fitting_dir": os.getcwd()} - data.update(metadata) - data = jsanitize(data,strict=True,allow_bson=True) - - mmdb.db.lattice_dynamics.insert_one(data) - - logger.info("Finished inserting force constants and phonon data") - - else: - renorm_thermal_data = loadfn("renorm_thermal_data.json") - fcs = ForceConstants.read("force_constants.fcs") - T = renorm_thermal_data["temperature"] - - dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid = _get_fc_fsid( - structure, supercell_matrix, fcs, mesh_density, mmdb - ) - - data_at_T = { - "created_at": datetime.utcnow(), - "tags": fw_spec.get("tags", None), - "formula_pretty": structure.composition.reduced_formula, - "structure": structure.as_dict(), - "supercell_matrix": supercell_matrix, - "supercell_structure": supercell_structure.as_dict(), - "thermal_data": renorm_thermal_data, - "force_constants_fs_id": fc_fsid, - "phonon_dos_fs_id": dos_fsid, - "phonon_bandstructure_uniform_fs_id": uniform_bs_fsid, - "phonon_bandstructure_line_fs_id": lm_bs_fsid, - } - data_at_T.update(self.get("additional_fields", {})) - - # Get an id for the force constants - fitting_id = _get_fc_fitting_id(mmdb) - metadata = {"fc_fitting_id": fitting_id, "renormalization_dir": os.getcwd()} - data_at_T.update(metadata) - data_at_T = jsanitize(data_at_T,strict=True,allow_bson=True) - - mmdb.db.renormalized_lattice_dynamics.insert_one(data_at_T) - - logger.info("Finished inserting renormalized force constants and phonon data at {} K".format(T)) - - return FWAction(update_spec=metadata) - - -def _get_fc_fitting_id(mmdb: VaspCalcDb) -> int: - """Helper method to get a force constant fitting id.""" - fc_id = mmdb.db.counter.find_one_and_update( - {"_id": "fc_fitting_id"}, - {"$inc": {"c": 1}}, - return_document=ReturnDocument.AFTER, - ) - if fc_id is None: - mmdb.db.counter.insert({"_id": "fc_fitting_id", "c": 1}) - fc_id = 1 - else: - fc_id = fc_id["c"] - - return fc_id - - -def _get_fc_fsid(structure, supercell_matrix, fcs, mesh_density, mmdb): - phonopy_fc = fcs.get_fc_array(order=2) - - logger.info("Getting uniform phonon band structure.") - uniform_bs = get_phonon_band_structure_from_fc( - structure, supercell_matrix, phonopy_fc - ) - - logger.info("Getting line mode phonon band structure.") - lm_bs = get_phonon_band_structure_symm_line_from_fc( - structure, supercell_matrix, phonopy_fc - ) - - logger.info("Getting phonon density of states.") - dos = get_phonon_dos_from_fc( - structure, supercell_matrix, phonopy_fc, mesh_density=mesh_density - ) - - logger.info("Inserting phonon objects into database.") - dos_fsid, _ = mmdb.insert_gridfs( - dos.to_json(), collection="phonon_dos_fs" - ) - uniform_bs_fsid, _ = mmdb.insert_gridfs( - uniform_bs.to_json(), collection="phonon_bandstructure_fs" - ) - lm_bs_fsid, _ = mmdb.insert_gridfs( - lm_bs.to_json(), collection="phonon_bandstructure_fs" - ) - - logger.info("Inserting force constants into database.") - fc_json = json.dumps( - {str(k): v.tolist() for k, v in fcs.get_fc_dict().items()} - ) - fc_fsid, _ = mmdb.insert_gridfs( - fc_json, collection="phonon_force_constants_fs" - ) - - return dos_fsid, uniform_bs_fsid, lm_bs_fsid, fc_fsid diff --git a/atomate/vasp/fireworks/aimd.py b/atomate/vasp/fireworks/aimd.py deleted file mode 100644 index 40a0251b2..000000000 --- a/atomate/vasp/fireworks/aimd.py +++ /dev/null @@ -1,193 +0,0 @@ -from typing import List, Optional, Union, Dict - -import os - -from atomate.common.firetasks.glue_tasks import ( - CopyFiles, - CopyFilesFromCalcLoc, - PassCalcLocs, -) - -from atomate.vasp.firetasks.aimd import ( - CollectMDSegments, - MDToDB - ) - -from fireworks import Firework - -__author__ = "Junsoo Park" -__email__ = "junsoo.park@nasa.gov" - - -class ARCMDFW(Firework): - def __init__( - self, - structure, - start_temp, - end_temp, - nsteps, - name="AIMD", - vasp_input_set=None, - vasp_cmd=VASP_CMD, - override_default_vasp_params=None, - wall_time=19200, - db_file=DB_FILE, - parents=None, - **kwargs, - ): - """ - Standard firework for a single MD run. - - Args: - structure (Structure): Input structure. - start_temp (float): Start temperature of MD run. - end_temp (float): End temperature of MD run. - nsteps (int): Number of MD steps - name (string): Name for the Firework. - vasp_input_set (string): string name for the VASP input set (e.g., - "MITMDVaspInputSet"). - vasp_cmd (string): Command to run vasp. - override_default_vasp_params (dict): If this is not None, - these params are passed to the default vasp_input_set, i.e., - MITMDSet. This allows one to easily override some - settings, e.g., user_incar_settings, etc. Particular to MD, - one can control time_step and all other settings of the input set. - wall_time (int): Total wall time in seconds before writing STOPCAR. - copy_vasp_outputs (bool): Whether to copy outputs from previous run. Defaults to True. - db_file (string): Path to file specifying db credentials. - parents (Firework): Parents of this particular Firework. FW or list of FWS. - **kwargs: Other kwargs that are passed to Firework.__init__. - """ - override_default_vasp_params = override_default_vasp_params or {} - vasp_input_set = vasp_input_set or ARCMDSet( - structure, - start_temp=start_temp, - end_temp=end_temp, - nsteps=nsteps, - **override_default_vasp_params, - ) - prev_runs = fw_spec.get("aimd", []) - last_run = prev_runs[-1] - last_config = last_run["final_configuration"] - t = [] - t.append(WriteVaspFromIOSet(structure=last_config, vasp_input_set=vasp_input_set)) - t.append( - RunVaspCustodian( - vasp_cmd=vasp_cmd, - gamma_vasp_cmd=">>vasp_cmd<<",#">>gamma_vasp_cmd<<", - handler_group="md", - wall_time=wall_time, - ) - ) - t.append(PassCalcLocs(name=name)) - t.append( - VaspToDb( - db_file=db_file, - additional_fields={"task_label": name}, - defuse_unsuccessful=False, - ) - ) - super().__init__( - t, - parents=parents, - name=f"{structure.composition.reduced_formula}-{name}", - **kwargs, - ) - - -class CollectMDSegmentsFW(Firework): - """ - Compile serial AIMD runs segmented into multiple Fireworks - - Args: - parents: Parent(s) of this Firework. - name: Name of this FW. - db_file: Path to a db file. - cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs - will be generated based on the structure (default). - disp_cut: determines the mean displacement of perturbed - structure to be included in harmonic (<) or anharmonic (>) fitting - bulk_modulus: in GPa, necessary for thermal expansion - imaginary_tol: Tolerance used to decide if a phonon mode is - imaginary, in THz. - fit_method: Method used for fitting force constants. This can be - any of the values allowed by the hiphive ``Optimizer`` class. - mesh_density: The density of the q-point mesh used to calculate the - phonon density of states. See the docstring for the ``mesh`` - argument in Phonopy.init_mesh() for more details. - **kwargs: Other kwargs that are passed to Firework.__init__. - """ - - def __init__( - self, - name="Collect MD Runs", - parents: Optional[Union[Firework, List[Firework]]] = None, - db_file: str = None, - **kwargs - ): - collect = CollectMDSegments() - - to_db = AIMDToDB( - db_file=db_file, additional_fields={} - ) - pass_locs = PassCalcLocs(name=name) - - tasks = [collect, to_db, pass_locs] - super().__init__(tasks, parents=parents, name=name, **kwargs) - - -class FitForceConstantsFW(Firework): - """ - Compile perturbed supercell calculations and fit force constants - using hiPhive. - - Args: - parents: Parent(s) of this Firework. - name: Name of this FW. - db_file: Path to a db file. - cutoffs: A list of cutoffs to trial. If None, a set of trial cutoffs - will be generated based on the structure (default). - disp_cut: determines the mean displacement of perturbed - structure to be included in harmonic (<) or anharmonic (>) fitting - bulk_modulus: in GPa, necessary for thermal expansion - imaginary_tol: Tolerance used to decide if a phonon mode is - imaginary, in THz. - fit_method: Method used for fitting force constants. This can be - any of the values allowed by the hiphive ``Optimizer`` class. - mesh_density: The density of the q-point mesh used to calculate the - phonon density of states. See the docstring for the ``mesh`` - argument in Phonopy.init_mesh() for more details. - **kwargs: Other kwargs that are passed to Firework.__init__. - """ - - def __init__( - self, - fit_method: str, - disp_cut: float, - bulk_modulus: float, - imaginary_tol: float, - mesh_density: float, - temperature_qha: float, - cutoffs: Optional[List[List[float]]] = None, - name="Fit Force Constants", - parents: Optional[Union[Firework, List[Firework]]] = None, - db_file: str = None, - **kwargs - ): - collect_structures = CollectPerturbedStructures() - - fit_force_constants = RunHiPhive( - cutoffs=cutoffs, - fit_method=fit_method, - disp_cut=disp_cut, - bulk_modulus=bulk_modulus, - temperature_qha=temperature_qha, - imaginary_tol=imaginary_tol, - ) - to_db = ForceConstantsToDb( - db_file=db_file, renormalized=False, mesh_density=mesh_density, additional_fields={} - ) - pass_locs = PassCalcLocs(name=name) - - tasks = [collect_structures, fit_force_constants, to_db, pass_locs] - super().__init__(tasks, parents=parents, name=name, **kwargs) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 0f8b5ec3b..10fa8632c 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -6,7 +6,7 @@ get_lattice_dynamics_wf, vasp_to_db_params from fireworks import Workflow -from pymatgen import Structure +from pymatgen.core import Structure from pymatgen.io.vasp.sets import MPRelaxSet, MPStaticSet, MPHSERelaxSet from pymatgen.io.vasp.inputs import Kpoints diff --git a/atomate/vasp/workflows/tests/test_csld_workflow.py b/atomate/vasp/workflows/tests/test_csld_workflow.py deleted file mode 100644 index 07471c7ab..000000000 --- a/atomate/vasp/workflows/tests/test_csld_workflow.py +++ /dev/null @@ -1,175 +0,0 @@ -# coding: utf-8 - -from __future__ import division, print_function, unicode_literals, absolute_import - -import os -from monty.os.path import which -import unittest -import numpy as np -import shutil - -from pymatgen import Structure -from atomate.vasp.workflows.base.csld import CompressedSensingLatticeDynamicsWF -from atomate.vasp.firetasks.parse_outputs import ( - CSLDForceConstantsToDB, - ShengBTEToDB, -) -from atomate.utils.testing import AtomateTest, DB_DIR - -import json - -module_dir = os.path.join(os.path.dirname(os.path.abspath(__file__))) -db_dir = os.path.join(module_dir, "..", "..", "..", "common", "test_files") -ref_dir = os.path.join(module_dir, "..", "..", "test_files", "csld_wf") - -__author__ = "Rees Chang" -__email__ = "rc564@cornell.edu" - -csld_present = which("csld_main") - -class TestCompressedSensingLatticeDynamicsWorkflow(AtomateTest): - - @staticmethod - def init(): - with open(os.path.join(ref_dir, "FW.json"), - "r") as f: - sample_task = json.load(f)[0] - wf_uuid = sample_task["spec"]["_tasks"][0]["wf_uuid"] - parent_structure = Structure.from_dict( - sample_task["spec"]["_tasks"][0]["parent_structure"]) - trans_mat = sample_task["spec"]["_tasks"][0]["trans_mat"] - supercell_structure = Structure.from_dict( - sample_task["spec"]["_tasks"][0]["supercell_structure"]) - supercell_smallest_dim = sample_task["spec"]["_tasks"][0]["supercell_smallest_dim"] - perturbed_supercells = sample_task["spec"]["_tasks"][0]["perturbed_supercells"] - for i in range(len(perturbed_supercells)): - perturbed_supercells[i] = Structure.from_dict( - perturbed_supercells[i]) - disps = sample_task["spec"]["_tasks"][0]["disps"] - first_pass = sample_task["spec"]["_tasks"][0]["first_pass"] - static_user_incar_settings = sample_task["spec"]["_tasks"][0]["static_user_incar_settings"] - env_vars = sample_task["spec"]["_tasks"][0]["env_vars"] - shengbte_t_range = sample_task["spec"]["_tasks"][0]["shengbte_t_range"] - shengbte_fworker = sample_task["spec"]["_tasks"][0]["shengbte_fworker"] - - csld_firetask = CSLDForceConstantsToDB( - db_file=os.path.join(DB_DIR, "db.json"), - wf_uuid=wf_uuid, - parent_structure=parent_structure, - trans_mat=trans_mat, - supercell_structure=supercell_structure, - supercell_smallest_dim=supercell_smallest_dim, - perturbed_supercells=perturbed_supercells, - disps=disps, - first_pass=first_pass, - static_user_incar_settings=static_user_incar_settings, - env_vars=env_vars, - shengbte_t_range=shengbte_t_range, - shengbte_fworker=shengbte_fworker, - force_diagonal_transformation=True, - ) - - return csld_firetask - - def test_collect_successful_static_calcs_results(self): - tasks = self.get_task_collection() - csld_firetask = self.init() - with open(os.path.join(ref_dir, "FW.json"), - "r") as f: - sample_task = json.load(f)[1] - tasks.insert_one(sample_task) - - supercells_forces, successful_disps = csld_firetask.collect_successful_static_calcs_results( - tasks) - - self.assertEqual( - float(successful_disps[0]), - 0.1 - ) - self.assertTrue( - isinstance(supercells_forces, list) - ) - self.assertEqual( - supercells_forces[0][0][0], - 0.07831190000000000373 - ) - self.assertEqual( - supercells_forces[0][0][1], - 0.13348752999999999314 - ) - self.assertEqual( - supercells_forces[0][0][2], - -0.7885310199999999714 - ) - self.assertEqual( - len(supercells_forces[0]), - 216 - ) - - def test_set_params(self): - - csld_firetask = self.init() - csld_firetask.set_params( - iteration_number=0, - disps=[0.1], - cluster_diam='11 6.5 5.0', - max_order=3, - submodel1='anh 0 1 2 3', - export_sbte='5 5 5 2 3', - supercells_forces=[np.eye(3)] - ) - - self.assertEqual( - csld_firetask["csld_settings"]["structure"]["prim"], - "Si_supercell_iter0/POSCAR") - self.assertEqual( - csld_firetask["csld_settings"]["model"]["max_order"], - '3' - ) - self.assertEqual( - csld_firetask["csld_settings"]["model"]["cluster_diameter"], - '11 6.5 5.0' - ) - self.assertEqual( - csld_firetask["csld_settings"]["model"]["cluster_filter"], - r"lambda cls: ((cls.order_uniq <= 2) or (cls.bond_counts(2.9) " - r">= 2)) and cls.is_small_in('" + "Si_supercell_iter0" + "/sc.txt')" - ) - self.assertEqual( - csld_firetask["csld_settings"]["training"]["traindat1"], - 'Si_supercell_iter0/SPOSCAR Si_supercell_iter0/disp0.10' - ) - self.assertEqual( - csld_firetask["csld_settings"]["fitting"]["submodel1"], - 'anh 0 1 2 3' - ) - self.assertEqual( - csld_firetask["csld_settings"]["export_potential"]["export_shengbte"], - '5 5 5 2 3' - ) - self.assertEqual( - csld_firetask["forces_paths"], - ['Si_supercell_iter0/disp0.10'] - ) - self.assertTrue( - os.path.isfile(csld_firetask["forces_paths"][0] + "/force.txt") - ) - self.assertTrue( - os.path.isfile('Si_supercell_iter0/POSCAR') - ) - self.assertTrue( - os.path.isfile('Si_supercell_iter0/SPOSCAR') - ) - self.assertTrue( - os.path.isfile('Si_supercell_iter0/sc.txt') - ) - shutil.rmtree('Si_supercell_iter0') - - @unittest.skipIf(not csld_present, "CSLD not present") - def test_run_csld(self): - print('hi') - - - - - diff --git a/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py b/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py index 55da5cde4..2c04847db 100644 --- a/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py +++ b/atomate/vasp/workflows/tests/test_lattice_dynamics_workflow.py @@ -1,7 +1,7 @@ from pathlib import Path -from atomate.vasp.workflows import get_lattice_dynamics_wf +from atomate.vasp.workflows.base.lattice_dynamics import get_lattice_dynamics_wf from fireworks import FWorker from fireworks.core.rocket_launcher import rapidfire diff --git a/atomate/vasp/workflows/tests/test_vasp_workflows.py b/atomate/vasp/workflows/tests/test_vasp_workflows.py index b5d5fc0db..fbdbab5c4 100644 --- a/atomate/vasp/workflows/tests/test_vasp_workflows.py +++ b/atomate/vasp/workflows/tests/test_vasp_workflows.py @@ -7,7 +7,7 @@ from fireworks import FWorker from fireworks.core.rocket_launcher import rapidfire from monty.json import MontyDecoder -from moto import mock_s3 +from moto import mock_aws from pymatgen.core import Structure from pymatgen.electronic_structure.bandstructure import BandStructure from pymatgen.electronic_structure.dos import CompleteDos @@ -403,7 +403,7 @@ def test_insert_maggma_store(self): # generate a doc from the test folder doc = {"a": 1, "b": 2} - with mock_s3(): + with mock_aws(): conn = boto3.client("s3") conn.create_bucket(Bucket="test_bucket") mmdb = VaspCalcDb.from_db_file(os.path.join(db_dir, "db_aws.json")) From a156d310e503594dd0754c182d09d0e987b10efb Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Wed, 6 Mar 2024 14:29:14 -0800 Subject: [PATCH 197/207] remove __init__ for pytest --- atomate/vasp/workflows/tests/__init__.py | 1 - 1 file changed, 1 deletion(-) delete mode 100644 atomate/vasp/workflows/tests/__init__.py diff --git a/atomate/vasp/workflows/tests/__init__.py b/atomate/vasp/workflows/tests/__init__.py deleted file mode 100644 index b06452a32..000000000 --- a/atomate/vasp/workflows/tests/__init__.py +++ /dev/null @@ -1 +0,0 @@ -__author__ = "Anubhav Jain " From 16957fbf3dafdebbd22e0e1b558dd83f79f29704 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Wed, 6 Mar 2024 19:15:04 -0800 Subject: [PATCH 198/207] remove __init__ for pytest 2 --- atomate/common/tests/__init__.py | 1 - 1 file changed, 1 deletion(-) delete mode 100644 atomate/common/tests/__init__.py diff --git a/atomate/common/tests/__init__.py b/atomate/common/tests/__init__.py deleted file mode 100644 index 982614220..000000000 --- a/atomate/common/tests/__init__.py +++ /dev/null @@ -1 +0,0 @@ -__author__ = "Janine George (janine.george@uclouvain.be), Guido Petretto (guido.petretto@uclouvain.be)" From 17929f463ddd574c010ce920f2a8e2cd43ed1e52 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 11:54:26 -0700 Subject: [PATCH 199/207] pytest fix --- atomate/common/firetasks/tests/test_parse_outputs.py | 3 ++- atomate/common/tests/__init__.py | 1 + atomate/vasp/workflows/tests/__init__.py | 1 + 3 files changed, 4 insertions(+), 1 deletion(-) create mode 100644 atomate/common/tests/__init__.py create mode 100644 atomate/vasp/workflows/tests/__init__.py diff --git a/atomate/common/firetasks/tests/test_parse_outputs.py b/atomate/common/firetasks/tests/test_parse_outputs.py index 09c7f5101..c2dc9ca89 100644 --- a/atomate/common/firetasks/tests/test_parse_outputs.py +++ b/atomate/common/firetasks/tests/test_parse_outputs.py @@ -14,7 +14,8 @@ class TestDrone(AbstractDrone): - def __init__(self): + @classmethod + def setUpClass(cls): pass def assimilate(self, path): diff --git a/atomate/common/tests/__init__.py b/atomate/common/tests/__init__.py new file mode 100644 index 000000000..982614220 --- /dev/null +++ b/atomate/common/tests/__init__.py @@ -0,0 +1 @@ +__author__ = "Janine George (janine.george@uclouvain.be), Guido Petretto (guido.petretto@uclouvain.be)" diff --git a/atomate/vasp/workflows/tests/__init__.py b/atomate/vasp/workflows/tests/__init__.py new file mode 100644 index 000000000..b06452a32 --- /dev/null +++ b/atomate/vasp/workflows/tests/__init__.py @@ -0,0 +1 @@ +__author__ = "Anubhav Jain " From f53134d09db882ea0e3b192a8d303e4ebce293a8 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 14:23:55 -0700 Subject: [PATCH 200/207] fix pytest --- atomate/utils/tests/test_database.py | 8 +++++++- 1 file changed, 7 insertions(+), 1 deletion(-) diff --git a/atomate/utils/tests/test_database.py b/atomate/utils/tests/test_database.py index 03ce4879d..636f2197b 100644 --- a/atomate/utils/tests/test_database.py +++ b/atomate/utils/tests/test_database.py @@ -3,7 +3,6 @@ """ import os import unittest - import boto3 from maggma.stores import MemoryStore from moto import mock_aws @@ -19,7 +18,14 @@ logger = get_logger(__name__) + + class TestToDb(CalcDb): + def setup_method(self,method): + self.reset() + + def teardown_method(self,method): + def build_indexes(self, indexes=None, background=True): pass From 9506c2799ddd2a5d472dc3941226e36a60de28b7 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 14:49:34 -0700 Subject: [PATCH 201/207] small fix --- atomate/utils/tests/test_database.py | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/atomate/utils/tests/test_database.py b/atomate/utils/tests/test_database.py index 636f2197b..38718c874 100644 --- a/atomate/utils/tests/test_database.py +++ b/atomate/utils/tests/test_database.py @@ -25,7 +25,8 @@ def setup_method(self,method): self.reset() def teardown_method(self,method): - + pass + def build_indexes(self, indexes=None, background=True): pass From 18dd9b4d104bc200cbf57b7786a78ee04615aa5d Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 15:11:38 -0700 Subject: [PATCH 202/207] remove tests/__init__.py --- atomate/common/tests/__init__.py | 1 - atomate/vasp/workflows/tests/__init__.py | 1 - 2 files changed, 2 deletions(-) delete mode 100644 atomate/common/tests/__init__.py delete mode 100644 atomate/vasp/workflows/tests/__init__.py diff --git a/atomate/common/tests/__init__.py b/atomate/common/tests/__init__.py deleted file mode 100644 index 982614220..000000000 --- a/atomate/common/tests/__init__.py +++ /dev/null @@ -1 +0,0 @@ -__author__ = "Janine George (janine.george@uclouvain.be), Guido Petretto (guido.petretto@uclouvain.be)" diff --git a/atomate/vasp/workflows/tests/__init__.py b/atomate/vasp/workflows/tests/__init__.py deleted file mode 100644 index b06452a32..000000000 --- a/atomate/vasp/workflows/tests/__init__.py +++ /dev/null @@ -1 +0,0 @@ -__author__ = "Anubhav Jain " From 461c5a934144821e9eb1d61bbd880f25a0134c56 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 16:17:17 -0700 Subject: [PATCH 203/207] add path in presets/core --- atomate/vasp/workflows/presets/core.py | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/atomate/vasp/workflows/presets/core.py b/atomate/vasp/workflows/presets/core.py index 10fa8632c..00d2ef427 100644 --- a/atomate/vasp/workflows/presets/core.py +++ b/atomate/vasp/workflows/presets/core.py @@ -1,6 +1,8 @@ from typing import Optional from uuid import uuid4 import numpy as np +import os +import logging from atomate.vasp.workflows.base.lattice_dynamics import \ get_lattice_dynamics_wf, vasp_to_db_params @@ -44,6 +46,8 @@ # TODO: @computron: Clarify the config dict -computron # TODO: @computron: Allow default config dict to be loaded from file -computron +module_dir = os.path.dirname(os.path.abspath(__file__)) +logger = logging.getLogger(__name__) def wf_bandstructure(structure, c=None): From fa41428830b57b60caaf662a3dcd405886975c9c Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 16:27:09 -0700 Subject: [PATCH 204/207] test phono3py install --- atomate/vasp/workflows/tests/test_adsorbate_workflow.py | 1 + 1 file changed, 1 insertion(+) diff --git a/atomate/vasp/workflows/tests/test_adsorbate_workflow.py b/atomate/vasp/workflows/tests/test_adsorbate_workflow.py index 644c2572a..f9170e5e3 100644 --- a/atomate/vasp/workflows/tests/test_adsorbate_workflow.py +++ b/atomate/vasp/workflows/tests/test_adsorbate_workflow.py @@ -16,6 +16,7 @@ get_slab_trans_params, get_wf_slab, ) +from phono3py.phonon3.gruneisen import Gruneisen __author__ = "Kiran Mathew, Joseph Montoya" __email__ = "montoyjh@lbl.gov" From 93a422fe9f48cc53ec56b6f65344a3485afdd1ae Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 16:37:30 -0700 Subject: [PATCH 205/207] add phono3y into complete --- atomate/vasp/workflows/tests/test_adsorbate_workflow.py | 1 - setup.py | 1 + 2 files changed, 1 insertion(+), 1 deletion(-) diff --git a/atomate/vasp/workflows/tests/test_adsorbate_workflow.py b/atomate/vasp/workflows/tests/test_adsorbate_workflow.py index f9170e5e3..644c2572a 100644 --- a/atomate/vasp/workflows/tests/test_adsorbate_workflow.py +++ b/atomate/vasp/workflows/tests/test_adsorbate_workflow.py @@ -16,7 +16,6 @@ get_slab_trans_params, get_wf_slab, ) -from phono3py.phonon3.gruneisen import Gruneisen __author__ = "Kiran Mathew, Joseph Montoya" __email__ = "montoyjh@lbl.gov" diff --git a/setup.py b/setup.py index 957e8dc5c..1c2b086b3 100644 --- a/setup.py +++ b/setup.py @@ -51,6 +51,7 @@ "matplotlib>=1.5.2", "phonopy>=2.21.0", "openbabel-wheel", + "phono3py", "hiphive @ git+https://gitlab.com/jsyony37/hiphive.git@personal#egg=hiphive", "f90nml==1.4.4", "spglib>=2.2.0", From 52ef78bb4eda56578b9f0a9dd61fa15fcf6ae826 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 16:50:24 -0700 Subject: [PATCH 206/207] install h5py --- setup.py | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/setup.py b/setup.py index 1c2b086b3..2f2e8396b 100644 --- a/setup.py +++ b/setup.py @@ -36,7 +36,7 @@ "pymatgen-analysis-defects==2023.7.24", "pymatgen==2023.7.20", "pymongo", - "pyyaml>=5.1.2", + "pyyaml>=5.3", "ruamel.yaml", "scipy", "tqdm>=4.65.0", @@ -51,6 +51,7 @@ "matplotlib>=1.5.2", "phonopy>=2.21.0", "openbabel-wheel", + "h5py>=3.0", "phono3py", "hiphive @ git+https://gitlab.com/jsyony37/hiphive.git@personal#egg=hiphive", "f90nml==1.4.4", From a291b5d9bdabcbb714fc3187e0a90ed2145796a1 Mon Sep 17 00:00:00 2001 From: Zhuoying Date: Mon, 11 Mar 2024 17:06:49 -0700 Subject: [PATCH 207/207] revert back --- setup.py | 1 - 1 file changed, 1 deletion(-) diff --git a/setup.py b/setup.py index 2f2e8396b..1cc4e6a2f 100644 --- a/setup.py +++ b/setup.py @@ -52,7 +52,6 @@ "phonopy>=2.21.0", "openbabel-wheel", "h5py>=3.0", - "phono3py", "hiphive @ git+https://gitlab.com/jsyony37/hiphive.git@personal#egg=hiphive", "f90nml==1.4.4", "spglib>=2.2.0",