Update of tools around nac params symmetrization

This commit is contained in:
Atsushi Togo 2020-10-27 18:11:08 +09:00
parent a00493b140
commit 429d902a6a
9 changed files with 1292 additions and 33 deletions

View File

@ -37,6 +37,7 @@ from phonopy.api_phonopy import Phonopy
from phonopy.interface.phonopy_yaml import PhonopyYaml
from phonopy.interface.calculator import get_default_physical_units
import phonopy.cui.load_helper as load_helper
from phonopy.structure.cells import get_primitive_matrix
def load(phonopy_yaml=None, # phonopy.yaml-like must be the first argument.
@ -219,8 +220,8 @@ def load(phonopy_yaml=None, # phonopy.yaml-like must be the first argument.
smat = phpy_yaml.supercell_matrix
if smat is None:
smat = np.eye(3, dtype='intc', order='C')
if primitive_matrix == 'auto':
pmat = 'auto'
if primitive_matrix is not None:
pmat = get_primitive_matrix(primitive_matrix, symprec=symprec)
else:
pmat = phpy_yaml.primitive_matrix
if nac_params is not None:

View File

@ -35,8 +35,7 @@
import os
import numpy as np
from phonopy.interface.calculator import read_crystal_structure
from phonopy.structure.cells import (
get_primitive_matrix_by_centring, get_primitive_matrix)
from phonopy.structure.cells import get_primitive_matrix
from phonopy.file_IO import (
parse_BORN, read_force_constants_hdf5, parse_FORCE_SETS,
parse_FORCE_CONSTANTS)

View File

@ -379,9 +379,8 @@ def elaborate_borns_and_epsilon(ucell,
"""
assert len(borns) == ucell.get_number_of_atoms(), \
"num_atom %d != len(borns) %d" % (ucell.get_number_of_atoms(),
len(borns))
assert len(borns) == len(ucell), \
"num_atom %d != len(borns) %d" % (len(ucell), len(borns))
if symmetrize_tensors:
borns_, epsilon_ = symmetrize_borns_and_epsilon(
@ -453,38 +452,19 @@ def symmetrize_borns_and_epsilon(borns,
"""
lattice = ucell.get_cell()
positions = ucell.get_scaled_positions()
lattice = ucell.cell
u_sym = Symmetry(ucell, is_symmetry=is_symmetry, symprec=symprec)
rotations = u_sym.get_symmetry_operations()['rotations']
translations = u_sym.get_symmetry_operations()['translations']
ptg_ops = u_sym.get_pointgroup_operations()
epsilon_ = _symmetrize_2nd_rank_tensor(epsilon, ptg_ops, lattice)
for i, Z in enumerate(borns):
site_sym = u_sym.get_site_symmetry(i)
Z = _symmetrize_2nd_rank_tensor(Z, site_sym, lattice)
borns_ = np.zeros_like(borns)
for i in range(len(borns)):
count = 0
for r, t in zip(rotations, translations):
count += 1
diff = np.dot(positions, r.T) + t - positions[i]
diff -= np.rint(diff)
dist = np.sqrt(np.sum(np.dot(diff, lattice) ** 2, axis=1))
j = np.nonzero(dist < symprec)[0][0]
r_cart = similarity_transformation(lattice.T, r)
borns_[i] += similarity_transformation(r_cart, borns[j])
borns_[i] /= count
sum_born = borns_.sum(axis=0) / len(borns_)
borns_ -= sum_born
borns_ = _take_average_of_borns(borns, rotations, translations, ucell,
symprec)
if (abs(borns - borns_) > 0.1).any():
lines = ["Born effective charge symmetry is largely broken. "
"Largest different among elements: "
"%s" % np.amax(abs(borns - borns_))]
lines = ["Symmetry of Born effective charge is largely broken. "
"The difference is:",
"%s" % (borns - borns_)]
import warnings
warnings.warn("\n".join(lines))
@ -512,6 +492,26 @@ def symmetrize_borns_and_epsilon(borns,
return borns_in_prim[idx2].copy(), epsilon_
def _take_average_of_borns(borns, rotations, translations, cell, symprec):
lattice = cell.cell
positions = cell.scaled_positions
borns_ = np.zeros_like(borns)
for i in range(len(borns)):
for r, t in zip(rotations, translations):
diff = np.dot(positions, r.T) + t - positions[i]
diff -= np.rint(diff)
dist = np.sqrt(np.sum(np.dot(diff, lattice) ** 2, axis=1))
j = np.nonzero(dist < symprec)[0][0]
r_cart = similarity_transformation(lattice.T, r)
borns_[i] += similarity_transformation(r_cart, borns[j])
borns_[i] /= len(rotations)
sum_born = borns_.sum(axis=0) / len(borns_)
borns_ -= sum_born
return borns_
def _get_mapping_between_cells(cell_from, cell_to, symprec=1e-5):
indices = []
lattice = cell_from.cell

4
test/BORN_TiO2 Normal file
View File

@ -0,0 +1,4 @@
# epsilon and Z* of atoms 1 9
7.10729047 0.00000000 0.00000000 0.00000000 7.10729047 0.00000000 0.00000000 0.00000000 6.41993410
-5.54435990 0.00000000 0.00000000 0.00000000 -1.11960146 -0.00000000 0.00000000 0.00000000 -2.89515567
6.66396136 0.00000000 0.00000000 0.00000000 6.66396136 -0.00000000 0.00000000 0.00000000 5.79031133

668
test/FORCE_SETS_TiO2 Normal file
View File

@ -0,0 +1,668 @@
108
6
1
0.0100000000000000 0.0000000000000000 0.0000000000000000
-0.2264017900 0.0000000000 0.0030145900
0.0383601000 0.0000000000 -0.0067958100
0.0379886900 0.0000000000 0.0142123900
-0.0065630100 -0.0000062500 0.0037944400
0.0034612400 0.0009250800 0.0032741900
0.0034672900 -0.0009188100 0.0043425800
-0.0065630100 0.0000062500 0.0037944400
0.0034612400 -0.0009250800 0.0032741900
0.0034672900 0.0009188100 0.0043425800
0.0021898400 0.0000000000 -0.0107932500
0.0021730700 0.0000000000 0.0186330800
0.0019268000 0.0000000000 0.0038368100
-0.0004800700 -0.0035028000 0.0023995000
-0.0004866700 0.0035243100 0.0052422400
0.0007451100 0.0000079300 0.0038178600
-0.0004800700 0.0035028000 0.0023995000
-0.0004866700 -0.0035243100 0.0052422400
0.0007451100 -0.0000079300 0.0038178600
0.0065188900 -0.0232491400 -0.0128329600
0.0064827300 0.0235482200 0.0052585400
0.0024233900 0.0000306800 -0.0038056400
-0.0003694100 0.0000000000 -0.0046576200
-0.0003765300 0.0000000000 -0.0029649500
0.0008225200 0.0000000000 -0.0038123000
0.0065188900 0.0232491400 -0.0128329600
0.0064827300 -0.0235482200 0.0052585400
0.0024233900 -0.0000306800 -0.0038056400
-0.0079833700 -0.0000040400 -0.0037822700
0.0044143300 0.0007563800 -0.0029619100
0.0044218200 -0.0007483700 -0.0046495000
-0.0032961500 0.0000000000 -0.0038027200
0.0016293400 0.0000000000 -0.0037592900
0.0016370200 0.0000000000 -0.0038618000
-0.0079833700 0.0000040400 -0.0037822700
0.0044143300 -0.0007563800 -0.0029619100
0.0044218200 0.0007483700 -0.0046495000
-0.0017881200 -0.0004999700 0.0015304500
-0.0018584300 0.0004934400 0.0061421600
0.0038543800 0.0000017800 0.0038243100
-0.0009413500 0.0000000000 0.0030605700
-0.0009679800 0.0000000000 0.0045849700
0.0019129500 0.0000000000 0.0038204400
-0.0017881200 0.0004999700 0.0015304500
-0.0018584300 -0.0004934400 0.0061421600
0.0038543800 -0.0000017800 0.0038243100
-0.0027912200 -0.0001541200 0.0039054500
0.0013966600 0.0035234400 0.0025267600
0.0014093900 -0.0035044600 0.0050989500
-0.0006756700 0.0000000000 0.0038233000
0.0003465500 0.0000000000 0.0034655800
0.0003518200 0.0000000000 0.0041651000
-0.0027912200 0.0001541200 0.0039054500
0.0013966600 -0.0035234400 0.0025267600
0.0014093900 0.0035044600 0.0050989500
-0.0004818400 0.0000000000 -0.0035894800
0.0010304400 0.0000000000 -0.0065338200
0.0010385300 0.0000000000 -0.0011176600
-0.0006127200 -0.0000305300 -0.0038057700
0.0003169300 0.0010062600 -0.0040786800
0.0003220000 -0.0010030100 -0.0035533400
-0.0006127200 0.0000305300 -0.0038057700
0.0003169300 -0.0010062600 -0.0040786800
0.0003220000 0.0010030100 -0.0035533400
0.0274539400 0.0000000000 0.0309310500
0.0274723800 0.0000000000 -0.0391081300
0.0167003400 0.0000000000 -0.0038400300
-0.0014255700 -0.0005701000 -0.0024044300
-0.0014763200 0.0005598300 -0.0052515300
0.0032193500 0.0000007100 -0.0038208500
-0.0014255700 0.0005701000 -0.0024044300
-0.0014763200 -0.0005598300 -0.0052515300
0.0032193500 -0.0000007100 -0.0038208500
0.0283063000 0.0000000000 -0.0129475600
0.0335680700 0.0000000000 0.0145031900
-0.0314523100 0.0000000000 -0.0000145000
0.0025112400 0.0111039400 -0.0040651400
0.0025543300 -0.0111600500 0.0041179600
-0.0051126600 -0.0000173800 0.0000103200
0.0025112400 -0.0111039400 -0.0040651400
0.0025543300 0.0111600500 0.0041179600
-0.0051126600 0.0000173800 0.0000103200
0.0030252200 0.0075390600 0.0115699200
0.0030877400 -0.0075948900 -0.0116502300
-0.0064809900 -0.0000124000 -0.0000194300
0.0012967400 0.0000000000 0.0025150000
0.0013113800 0.0000000000 -0.0025404700
-0.0025845700 0.0000000000 -0.0000089000
0.0030252200 -0.0075390600 0.0115699200
0.0030877400 0.0075948900 -0.0116502300
-0.0064809900 0.0000124000 -0.0000194300
0.0052778000 0.0000841800 -0.0000969300
-0.0026630700 -0.0018921900 0.0009969400
-0.0027057300 0.0018839000 -0.0010052900
0.0022630000 0.0000000000 -0.0000262900
-0.0011222700 0.0000000000 0.0005511400
-0.0011403100 0.0000000000 -0.0005555300
0.0052778000 -0.0000841800 -0.0000969300
-0.0026630700 0.0018921900 0.0009969400
-0.0027057300 -0.0018839000 -0.0010052900
0.0398662800 0.0000000000 -0.0006738300
-0.0161956000 0.0000000000 0.0084150300
-0.0163004500 0.0000000000 -0.0083315600
0.0039975700 0.0000865400 0.0000233300
-0.0020587900 -0.0023404700 0.0001710400
-0.0020906100 0.0023321900 -0.0001614000
0.0039975700 -0.0000865400 0.0000233300
-0.0020587900 0.0023404700 0.0001710400
-0.0020906100 -0.0023321900 -0.0001614000
1
0.0000000000000000 0.0100000000000000 0.0000000000000000
0.0000000000 -0.0390997300 0.0035243500
-0.0000592900 0.0016791000 0.0038355500
0.0000592900 0.0016791000 0.0038355500
0.0000000000 0.0008195700 0.0034813300
0.0009276400 0.0004079600 0.0034098900
-0.0009276400 0.0004079600 0.0034098900
0.0000000000 0.0008228300 0.0041509500
-0.0009126500 0.0004074800 0.0042158600
0.0009126500 0.0004074800 0.0042158600
0.0000080900 -0.0027927400 0.0038002200
-0.0000080900 -0.0027927400 0.0038002200
0.0000000000 -0.0006765800 0.0038078200
0.0000315700 0.0014023900 0.0044833100
-0.0000315700 0.0014023900 0.0044833100
0.0000000000 0.0003456800 0.0039376700
-0.0000294000 0.0014044200 0.0031539200
0.0000294000 0.0014044200 0.0031539200
0.0000000000 0.0003527700 0.0036932100
-0.0082268800 0.0065412600 0.0009528700
0.0082268800 0.0065412600 0.0009528700
0.0000000000 -0.0003845900 -0.0038569600
-0.0000009700 0.0024238200 -0.0038128500
0.0000009700 0.0024238200 -0.0038128500
0.0000000000 0.0008255300 -0.0038160800
0.0080988000 0.0064605100 -0.0085210200
-0.0080988000 0.0064605100 -0.0085210200
0.0000000000 -0.0003649400 -0.0037795300
0.0000000000 -0.0000116700 -0.0035864500
0.0007558000 -0.0000989500 -0.0033809200
-0.0007558000 -0.0000989500 -0.0033809200
0.0000000000 0.0003783100 -0.0038118500
0.0000020600 0.0002188400 -0.0038140400
-0.0000020600 0.0002188400 -0.0038140400
0.0000000000 -0.0000056600 -0.0040505100
-0.0007485100 -0.0000947600 -0.0042456700
0.0007485100 -0.0000947600 -0.0042456700
-0.0004986100 -0.0001103500 0.0043257800
0.0004986100 -0.0001103500 0.0043257800
0.0000000000 -0.0000558500 0.0039197500
-0.0000006500 0.0002048400 0.0038160600
0.0000006500 0.0002048400 0.0038160600
0.0000000000 0.0001033300 0.0038166800
0.0004962100 -0.0001068000 0.0033089600
-0.0004962100 -0.0001068000 0.0033089600
0.0000000000 -0.0000546700 0.0037084900
0.0000000000 0.0021986500 -0.0013397800
-0.0000294300 -0.0004923000 0.0039441700
0.0000294300 -0.0004923000 0.0039441700
0.0000000000 0.0019277500 0.0038148300
0.0000005500 0.0007447600 0.0038153800
-0.0000005500 0.0007447600 0.0038153800
0.0000000000 0.0021626200 0.0088922000
0.0000312000 -0.0004751500 0.0036904000
-0.0000312000 -0.0004751500 0.0036904000
0.0000000000 -0.0004836000 -0.0037651200
-0.0000003600 -0.0006128200 -0.0038079100
0.0000003600 -0.0006128200 -0.0038079100
0.0000000000 0.0010349300 -0.0042784500
0.0000493500 0.0003168200 -0.0039352300
-0.0000493500 0.0003168200 -0.0039352300
0.0000000000 0.0010356200 -0.0033612000
-0.0000488600 0.0003217100 -0.0036955700
0.0000488600 0.0003217100 -0.0036955700
0.0000623900 -0.0071080600 -0.0037585900
-0.0000623900 -0.0071080600 -0.0037585900
0.0000000000 -0.0005521700 -0.0038067700
-0.0005689200 0.0003574200 -0.0042163600
0.0005689200 0.0003574200 -0.0042163600
0.0000000000 0.0000326400 -0.0039467800
0.0005623700 0.0003577100 -0.0034179200
-0.0005623700 0.0003577100 -0.0034179200
0.0000000000 0.0000350800 -0.0036818000
0.0002667200 0.0105806200 -0.0000756800
-0.0002667200 0.0105806200 -0.0000756800
0.0000000000 0.0010102400 0.0000129100
0.0008842300 -0.0049929000 0.0005171200
-0.0008842300 -0.0049929000 0.0005171200
0.0000000000 -0.0004128000 -0.0003385200
-0.0008768400 -0.0049711800 -0.0005098100
0.0008768400 -0.0049711800 -0.0005098100
0.0000000000 -0.0004294300 0.0003356300
0.0009077100 0.0010227200 -0.0034238100
-0.0009077100 0.0010227200 -0.0034238100
0.0000000000 0.0003162700 0.0000999500
0.0000013200 -0.0019936900 -0.0000041500
-0.0000013200 -0.0019936900 -0.0000041500
0.0000000000 -0.0006666800 0.0000003300
-0.0009013000 0.0009927900 0.0034069400
0.0009013000 0.0009927900 0.0034069400
0.0000000000 0.0003001000 -0.0000938500
0.0000000000 0.0009048000 0.0010784500
-0.0004334200 0.0003102700 -0.0005128300
0.0004334200 0.0003102700 -0.0005128300
0.0000000000 -0.0014221000 0.0000015400
-0.0000012000 -0.0006157400 -0.0000012000
0.0000012000 -0.0006157400 -0.0000012000
0.0000000000 0.0008589300 -0.0010589500
0.0004264200 0.0002975600 0.0005080300
-0.0004264200 0.0002975600 0.0005080300
0.0000000000 0.0116453700 0.0002029400
-0.0000025200 0.0006356800 -0.0000116600
0.0000025200 0.0006356800 -0.0000116600
0.0000000000 -0.0032338500 0.0011527700
-0.0005544900 -0.0003170200 0.0006856900
0.0005544900 -0.0003170200 0.0006856900
0.0000000000 -0.0032122600 -0.0011534200
0.0005450400 -0.0003284400 -0.0006778400
-0.0005450400 -0.0003284400 -0.0006778400
1
0.0000000000000000 0.0000000000000000 0.0100000000000000
0.0000000000 0.0000000000 -0.1146941600
0.0104587200 0.0000000000 -0.0010771500
-0.0104587200 0.0000000000 -0.0010771500
0.0000000000 0.0003287300 0.0013337000
0.0005315200 0.0004005300 0.0027817200
-0.0005315200 0.0004005300 0.0027817200
0.0000000000 -0.0003287300 0.0013337000
0.0005315200 -0.0004005300 0.0027817200
-0.0005315200 -0.0004005300 0.0027817200
-0.0051507000 0.0000000000 0.0099182100
0.0051507000 0.0000000000 0.0099182100
0.0000000000 0.0000000000 0.0044149500
0.0001257100 0.0012786400 0.0042629400
-0.0001257100 0.0012786400 0.0042629400
0.0000000000 0.0003517700 0.0038693400
0.0001257100 -0.0012786400 0.0042629400
-0.0001257100 -0.0012786400 0.0042629400
0.0000000000 -0.0003517700 0.0038693400
-0.0047108400 0.0090057100 -0.0023678500
0.0047108400 0.0090057100 -0.0023678500
0.0000000000 0.0008420800 -0.0036098700
0.0000387800 0.0000000000 -0.0036099800
-0.0000387800 0.0000000000 -0.0036099800
0.0000000000 0.0000000000 -0.0036860100
-0.0047108400 -0.0090057100 -0.0023678500
0.0047108400 -0.0090057100 -0.0023678500
0.0000000000 -0.0008420800 -0.0036098700
0.0000000000 0.0002331000 0.0012358900
0.0008429300 0.0004320200 -0.0022414600
-0.0008429300 0.0004320200 -0.0022414600
0.0000000000 0.0000000000 -0.0026632200
0.0000556800 0.0000000000 -0.0033239800
-0.0000556800 0.0000000000 -0.0033239800
0.0000000000 -0.0002331000 0.0012358900
0.0008429300 -0.0004320200 -0.0022414600
-0.0008429300 -0.0004320200 -0.0022414600
0.0022867600 -0.0005042900 0.0064623500
-0.0022867600 -0.0005042900 0.0064623500
0.0000000000 -0.0001034500 0.0048333000
0.0007568100 0.0000000000 0.0046382000
-0.0007568100 0.0000000000 0.0046382000
0.0000000000 0.0000000000 0.0042352100
0.0022867600 0.0005042900 0.0064623500
-0.0022867600 0.0005042900 0.0064623500
0.0000000000 0.0001034500 0.0048333000
0.0000000000 -0.0145899900 0.0098666500
-0.0006655000 -0.0014191600 0.0042708400
0.0006655000 -0.0014191600 0.0042708400
0.0000000000 0.0000000000 0.0044168600
-0.0001213100 0.0000000000 0.0038717100
0.0001213100 0.0000000000 0.0038717100
0.0000000000 0.0145899900 0.0098666500
-0.0006655000 0.0014191600 0.0042708400
0.0006655000 0.0014191600 0.0042708400
0.0000000000 0.0000000000 0.0222764300
-0.0004593700 0.0000000000 -0.0031479900
0.0004593700 0.0000000000 -0.0031479900
0.0000000000 -0.0026869300 -0.0031538000
-0.0001185700 -0.0002619600 -0.0037201000
0.0001185700 -0.0002619600 -0.0037201000
0.0000000000 0.0026869300 -0.0031538000
-0.0001185700 0.0002619600 -0.0037201000
0.0001185700 0.0002619600 -0.0037201000
0.0347939900 0.0000000000 0.0034945100
-0.0347939900 0.0000000000 0.0034945100
0.0000000000 0.0000000000 -0.0075504000
0.0014135500 -0.0003985800 -0.0053572400
-0.0014135500 -0.0003985800 -0.0053572400
0.0000000000 -0.0001306200 -0.0045537300
0.0014135500 0.0003985800 -0.0053572400
-0.0014135500 0.0003985800 -0.0053572400
0.0000000000 0.0001306200 -0.0045537300
0.0077293200 0.0000000000 0.0189673400
-0.0077293200 0.0000000000 0.0189673400
0.0000000000 0.0000000000 0.0004745600
-0.0004496900 -0.0040790000 0.0027909100
0.0004496900 -0.0040790000 0.0027909100
0.0000000000 -0.0005727900 0.0006583600
-0.0004496900 0.0040790000 0.0027909100
0.0004496900 0.0040790000 0.0027909100
0.0000000000 0.0005727900 0.0006583600
0.0000562600 -0.0042198500 -0.0067039900
-0.0000562600 -0.0042198500 -0.0067039900
0.0000000000 -0.0005473800 -0.0011025200
-0.0002470800 0.0000000000 -0.0013903700
0.0002470800 0.0000000000 -0.0013903700
0.0000000000 0.0000000000 -0.0006272900
0.0000562600 0.0042198500 -0.0067039900
-0.0000562600 0.0042198500 -0.0067039900
0.0000000000 0.0005473800 -0.0011025200
0.0000000000 0.0095460200 -0.0097688000
0.0012573500 0.0005447900 -0.0019713400
-0.0012573500 0.0005447900 -0.0019713400
0.0000000000 0.0000000000 -0.0022771000
0.0004249000 0.0000000000 -0.0006068700
-0.0004249000 0.0000000000 -0.0006068700
0.0000000000 -0.0095460200 -0.0097688000
0.0012573500 -0.0005447900 -0.0019713400
-0.0012573500 -0.0005447900 -0.0019713400
0.0000000000 0.0000000000 0.0299906200
0.0098518300 0.0000000000 0.0035789800
-0.0098518300 0.0000000000 0.0035789800
0.0000000000 0.0066965400 0.0033973200
0.0007939700 0.0008290600 0.0010564000
-0.0007939700 0.0008290600 0.0010564000
0.0000000000 -0.0066965400 0.0033973200
0.0007939700 -0.0008290600 0.0010564000
-0.0007939700 -0.0008290600 0.0010564000
1
0.0000000000000000 0.0000000000000000 -0.0100000000000000
0.0000000000 0.0000000000 0.1275488800
-0.0105505400 0.0000000000 0.0087884300
0.0105505400 0.0000000000 0.0087884300
0.0000000000 -0.0003402700 0.0063253100
-0.0005361400 -0.0004038000 0.0048590800
0.0005361400 -0.0004038000 0.0048590800
0.0000000000 0.0003402700 0.0063253100
-0.0005361400 0.0004038000 0.0048590800
0.0005361400 0.0004038000 0.0048590800
0.0050866200 0.0000000000 -0.0022301600
-0.0050866200 0.0000000000 -0.0022301600
0.0000000000 0.0000000000 0.0032047600
-0.0001276100 -0.0012897300 0.0033542600
0.0001276100 -0.0012897300 0.0033542600
0.0000000000 -0.0003466200 0.0037568100
-0.0001276100 0.0012897300 0.0033542600
0.0001276100 0.0012897300 0.0033542600
0.0000000000 0.0003466200 0.0037568100
0.0047614800 -0.0090866800 -0.0053530500
-0.0047614800 -0.0090866800 -0.0053530500
0.0000000000 -0.0008503400 -0.0040290700
-0.0000385900 0.0000000000 -0.0040292600
0.0000385900 0.0000000000 -0.0040292600
0.0000000000 0.0000000000 -0.0039395300
0.0047614800 0.0090866800 -0.0053530500
-0.0047614800 0.0090866800 -0.0053530500
0.0000000000 0.0008503400 -0.0040290700
0.0000000000 -0.0002314100 -0.0089209500
-0.0008446500 -0.0004313400 -0.0054016200
0.0008446500 -0.0004313400 -0.0054016200
0.0000000000 0.0000000000 -0.0049827300
-0.0000464700 0.0000000000 -0.0043113000
0.0000464700 0.0000000000 -0.0043113000
0.0000000000 0.0002314100 -0.0089209500
-0.0008446500 0.0004313400 -0.0054016200
0.0008446500 0.0004313400 -0.0054016200
-0.0023240300 0.0005129300 0.0011388200
0.0023240300 0.0005129300 0.0011388200
0.0000000000 0.0001061800 0.0027899800
-0.0007728400 0.0000000000 0.0029828300
0.0007728400 0.0000000000 0.0029828300
0.0000000000 0.0000000000 0.0033830900
-0.0023240300 -0.0005129300 0.0011388200
0.0023240300 -0.0005129300 0.0011388200
0.0000000000 -0.0001061800 0.0027899800
0.0000000000 0.0148374500 -0.0022769500
0.0006638000 0.0014210800 0.0033629300
-0.0006638000 0.0014210800 0.0033629300
0.0000000000 0.0000000000 0.0032069800
0.0001225200 0.0000000000 0.0037583700
-0.0001225200 0.0000000000 0.0037583700
0.0000000000 -0.0148374500 -0.0022769500
0.0006638000 -0.0014210800 0.0033629300
-0.0006638000 -0.0014210800 0.0033629300
0.0000000000 0.0000000000 -0.0303917700
0.0004579000 0.0000000000 -0.0044761900
-0.0004579000 0.0000000000 -0.0044761900
0.0000000000 0.0027253800 -0.0044815100
0.0001208400 0.0002640900 -0.0039098000
-0.0001208400 0.0002640900 -0.0039098000
0.0000000000 -0.0027253800 -0.0044815100
0.0001208400 -0.0002640900 -0.0039098000
-0.0001208400 -0.0002640900 -0.0039098000
-0.0352465100 0.0000000000 -0.0110819000
0.0352465100 0.0000000000 -0.0110819000
0.0000000000 0.0000000000 -0.0000387800
-0.0014340800 0.0003995600 -0.0022519900
0.0014340800 0.0003995600 -0.0022519900
0.0000000000 0.0001308200 -0.0030682600
-0.0014340800 -0.0003995600 -0.0022519900
0.0014340800 -0.0003995600 -0.0022519900
0.0000000000 -0.0001308200 -0.0030682600
-0.0079889800 0.0000000000 -0.0191539600
0.0079889800 0.0000000000 -0.0191539600
0.0000000000 0.0000000000 -0.0004522700
0.0004441500 0.0041380700 -0.0028132500
-0.0004441500 0.0041380700 -0.0028132500
0.0000000000 0.0005833400 -0.0006569600
0.0004441500 -0.0041380700 -0.0028132500
-0.0004441500 -0.0041380700 -0.0028132500
0.0000000000 -0.0005833400 -0.0006569600
-0.0000451300 0.0042105700 0.0067919900
0.0000451300 0.0042105700 0.0067919900
0.0000000000 0.0005565800 0.0011179100
0.0002467600 0.0000000000 0.0014029100
-0.0002467600 0.0000000000 0.0014029100
0.0000000000 0.0000000000 0.0006361600
-0.0000451300 -0.0042105700 0.0067919900
0.0000451300 -0.0042105700 0.0067919900
0.0000000000 -0.0005565800 0.0011179100
0.0000000000 -0.0096797100 0.0098609000
-0.0012804000 -0.0005448000 0.0019754000
0.0012804000 -0.0005448000 0.0019754000
0.0000000000 0.0000000000 0.0023147900
-0.0004260100 0.0000000000 0.0006112300
0.0004260100 0.0000000000 0.0006112300
0.0000000000 0.0096797100 0.0098609000
-0.0012804000 0.0005448000 0.0019754000
0.0012804000 0.0005448000 0.0019754000
0.0000000000 0.0000000000 -0.0343917900
-0.0099034300 0.0000000000 -0.0036297400
0.0099034300 0.0000000000 -0.0036297400
0.0000000000 -0.0067666900 -0.0034597200
-0.0008056900 -0.0008251200 -0.0010715900
0.0008056900 -0.0008251200 -0.0010715900
0.0000000000 0.0067666900 -0.0034597200
-0.0008056900 0.0008251200 -0.0010715900
0.0008056900 0.0008251200 -0.0010715900
73
0.0100000000000000 0.0000000000000000 0.0000000000000000
0.0336171500 0.0000000000 0.0112003900
-0.0314516400 0.0000000000 0.0038095900
0.0282781600 0.0000000000 -0.0044897500
0.0025727100 -0.0008737900 0.0033538900
-0.0051118200 -0.0000047500 0.0038149900
0.0024911700 0.0008843100 0.0042470400
0.0025727100 0.0008737900 0.0033538900
-0.0051118200 0.0000047500 0.0038149900
0.0024911700 -0.0008843100 0.0042470400
0.0116484300 0.0000000000 0.0036527600
-0.0032382100 0.0000000000 -0.0029288700
-0.0032074300 0.0000000000 0.0105331000
0.0006367300 0.0000177500 0.0038122600
-0.0003189200 -0.0023451500 0.0029863200
-0.0003272100 0.0023304100 0.0046394200
0.0006367300 -0.0000177500 0.0038122600
-0.0003189200 0.0023451500 0.0029863200
-0.0003272100 -0.0023304100 0.0046394200
0.0105819800 -0.0001875600 -0.0038973500
-0.0050103900 -0.0111613100 -0.0079470100
-0.0049550300 0.0111015800 0.0002690200
0.0010096900 0.0000000000 -0.0038052700
-0.0004176400 0.0000000000 -0.0043959600
-0.0004257100 0.0000000000 -0.0032373300
0.0105819800 0.0001875600 -0.0038973500
-0.0050103900 0.0111613100 -0.0079470100
-0.0049550300 -0.0111015800 0.0002690200
0.0031211000 -0.0008942000 -0.0038405200
-0.0064809900 -0.0000040100 -0.0038175300
0.0029892300 0.0009156600 -0.0037373200
0.0013161600 0.0000000000 -0.0035604200
-0.0025855100 0.0000000000 -0.0038125400
0.0012900500 0.0000000000 -0.0040592100
0.0031211000 0.0008942000 -0.0038405200
-0.0064809900 0.0000040100 -0.0038175300
0.0029892300 -0.0009156600 -0.0037373200
0.0052760100 -0.0000042800 0.0038513500
-0.0026764300 -0.0004323600 0.0025495700
-0.0026910600 0.0004251800 0.0050872300
0.0022696900 0.0000000000 0.0038254300
-0.0011291400 0.0000000000 0.0033911100
-0.0011399500 0.0000000000 0.0042438700
0.0052760100 0.0000042800 0.0038513500
-0.0026764300 0.0004323600 0.0025495700
-0.0026910600 -0.0004251800 0.0050872300
0.0010133300 -0.0076006000 0.0080589000
-0.0019957200 -0.0000153500 0.0038216200
0.0010050000 0.0075323500 -0.0003707200
0.0003100500 0.0000000000 0.0043694700
-0.0006661300 0.0000000000 0.0038164800
0.0003067400 0.0000000000 0.0032655800
0.0010133300 0.0076006000 0.0080589000
-0.0019957200 0.0000153500 0.0038216200
0.0010050000 -0.0075323500 -0.0003707200
0.0008730200 0.0000000000 0.0058572000
-0.0014240300 0.0000000000 -0.0038057900
0.0008898800 0.0000000000 -0.0133685800
0.0003053200 -0.0018919100 -0.0032710500
-0.0006167500 -0.0000046800 -0.0038147200
0.0003018000 0.0018786600 -0.0043559700
0.0003053200 0.0018919100 -0.0032710500
-0.0006167500 0.0000046800 -0.0038147200
0.0003018000 -0.0018786600 -0.0043559700
0.0398681100 0.0000000000 -0.0033606400
-0.0162959500 0.0000000000 0.0060730400
-0.0161993700 0.0000000000 -0.0136829500
0.0039964800 -0.0000026400 -0.0038345200
-0.0020697100 -0.0005551800 -0.0030178600
-0.0020818900 0.0005460000 -0.0046178100
0.0039964800 0.0000026400 -0.0038345200
-0.0020697100 0.0005551800 -0.0030178600
-0.0020818900 -0.0005460000 -0.0046178100
-0.1817395500 0.0000000000 0.0015588900
0.0713777800 0.0000000000 0.0092371100
0.0708017900 0.0000000000 -0.0091297200
-0.0053795300 -0.0001021400 0.0000336300
0.0027157400 0.0071282400 -0.0022162600
0.0027548100 -0.0070705700 0.0022125300
-0.0053795300 0.0001021400 0.0000336300
0.0027157400 -0.0071282400 -0.0022162600
0.0027548100 0.0070705700 0.0022125300
-0.0114933400 -0.0001378000 -0.0001474600
0.0045401800 0.0051361100 0.0072153500
0.0045936800 -0.0050946700 -0.0071534700
-0.0022333900 0.0000000000 -0.0000331300
0.0011756300 0.0000000000 0.0016759000
0.0011917700 0.0000000000 -0.0016774100
-0.0114933400 0.0001378000 -0.0001474600
0.0045401800 -0.0051361100 0.0072153500
0.0045936800 0.0050946700 -0.0071534700
-0.0025886000 0.0041516100 -0.0034628900
0.0051033600 0.0000095000 -0.0000075500
-0.0025565300 -0.0041012100 0.0033770300
-0.0011145300 0.0000000000 -0.0011793400
0.0022221900 0.0000000000 -0.0000065200
-0.0010990100 0.0000000000 0.0011638500
-0.0025886000 -0.0041516100 -0.0034628900
0.0051033600 -0.0000095000 -0.0000075500
-0.0025565300 0.0041012100 0.0033770300
-0.0102312200 0.0000000000 -0.0592212200
0.0203908900 0.0000000000 -0.0000206200
-0.0103855500 0.0000000000 0.0584105500
-0.0018022300 0.0051404100 0.0002780400
0.0040075800 0.0000121300 0.0000021600
-0.0017766700 -0.0050905100 -0.0002548900
-0.0018022300 -0.0051404100 0.0002780400
0.0040075800 -0.0000121300 0.0000021600
-0.0017766700 0.0050905100 -0.0002548900
73
0.0000000000000000 0.0000000000000000 0.0100000000000000
-0.0136422700 0.0000000000 0.0230621000
0.0000000000 0.0000000000 0.0042380900
0.0136422700 0.0000000000 0.0230621000
-0.0040726600 -0.0005117500 0.0066060600
0.0000000000 0.0003385600 0.0044695700
0.0040726600 -0.0005117500 0.0066060600
-0.0040726600 0.0005117500 0.0066060600
0.0000000000 -0.0003385600 0.0044695700
0.0040726600 0.0005117500 0.0066060600
0.0000000000 0.0000000000 0.0382635500
-0.0011621000 0.0000000000 0.0072555200
0.0011621000 0.0000000000 0.0072555200
0.0000000000 -0.0084326800 0.0074405800
-0.0006835000 -0.0001670400 0.0048860100
0.0006835000 -0.0001670400 0.0048860100
0.0000000000 0.0084326800 0.0074405800
-0.0006835000 0.0001670400 0.0048860100
0.0006835000 0.0001670400 0.0048860100
0.0000000000 0.0137663200 0.0150564700
0.0005167100 0.0041107900 -0.0010016500
-0.0005167100 0.0041107900 -0.0010016500
0.0000000000 0.0000000000 -0.0033076800
-0.0003357800 0.0000000000 -0.0031538400
0.0003357800 0.0000000000 -0.0031538400
0.0000000000 -0.0137663200 0.0150564700
0.0005167100 -0.0041107900 -0.0010016500
-0.0005167100 -0.0041107900 -0.0010016500
-0.0116285000 -0.0034390600 -0.0105710900
0.0000000000 0.0000973500 -0.0049241900
0.0116285000 -0.0034390600 -0.0105710900
-0.0025294800 0.0000000000 -0.0052102000
0.0000000000 0.0000000000 -0.0044453100
0.0025294800 0.0000000000 -0.0052102000
-0.0116285000 0.0034390600 -0.0105710900
0.0000000000 -0.0000973500 -0.0049241900
0.0116285000 0.0034390600 -0.0105710900
0.0000000000 -0.0010805100 -0.0059866000
-0.0010107700 0.0005086400 0.0018469000
0.0010107700 0.0005086400 0.0018469000
0.0000000000 0.0000000000 0.0015241400
-0.0005543800 0.0000000000 0.0032087600
0.0005543800 0.0000000000 0.0032087600
0.0000000000 0.0010805100 -0.0059866000
-0.0010107700 -0.0005086400 0.0018469000
0.0010107700 -0.0005086400 0.0018469000
0.0033938600 0.0115916800 -0.0029242400
0.0000000000 0.0025218000 0.0024153200
-0.0033938600 0.0115916800 -0.0029242400
-0.0000981900 0.0000000000 0.0027023300
0.0000000000 0.0000000000 0.0031804200
0.0000981900 0.0000000000 0.0027023300
0.0033938600 -0.0115916800 -0.0029242400
0.0000000000 -0.0025218000 0.0024153200
-0.0033938600 -0.0115916800 -0.0029242400
0.0010580300 0.0000000000 -0.0136381400
0.0000000000 0.0000000000 -0.0061127800
-0.0010580300 0.0000000000 -0.0136381400
-0.0005114600 0.0009949300 -0.0057918700
0.0000000000 0.0005520200 -0.0044276000
0.0005114600 0.0009949300 -0.0057918700
-0.0005114600 -0.0009949300 -0.0057918700
0.0000000000 -0.0005520200 -0.0044276000
0.0005114600 -0.0009949300 -0.0057918700
0.0000000000 0.0000000000 0.0261251300
0.0083157900 0.0000000000 -0.0002380800
-0.0083157900 0.0000000000 -0.0002380800
0.0000000000 0.0011426300 -0.0003997900
0.0001631600 0.0006800700 -0.0027571400
-0.0001631600 0.0006800700 -0.0027571400
0.0000000000 -0.0011426300 -0.0003997900
0.0001631600 -0.0006800700 -0.0027571400
-0.0001631600 -0.0006800700 -0.0027571400
0.0000000000 0.0000000000 -0.1982471900
-0.0092250600 0.0000000000 -0.0075626400
0.0092250600 0.0000000000 -0.0075626400
0.0000000000 0.0091447600 -0.0075919600
0.0022076100 -0.0022210400 -0.0013671900
-0.0022076100 -0.0022210400 -0.0013671900
0.0000000000 -0.0091447600 -0.0075919600
0.0022076100 0.0022210400 -0.0013671900
-0.0022076100 0.0022210400 -0.0013671900
0.0000000000 0.0591414500 0.0241381900
0.0072025100 -0.0002616700 -0.0023463400
-0.0072025100 -0.0002616700 -0.0023463400
0.0000000000 0.0000000000 0.0041824300
0.0016805900 0.0000000000 -0.0001053900
-0.0016805900 0.0000000000 -0.0001053900
0.0000000000 -0.0591414500 0.0241381900
0.0072025100 0.0002616700 -0.0023463400
-0.0072025100 0.0002616700 -0.0023463400
0.0034308300 -0.0034066700 0.0148538900
0.0000000000 -0.0011689400 0.0028535400
-0.0034308300 -0.0034066700 0.0148538900
0.0011741000 0.0000000000 0.0028528700
0.0000000000 0.0000000000 0.0014451700
-0.0011741000 0.0000000000 0.0028528700
0.0034308300 0.0034066700 0.0148538900
0.0000000000 0.0011689400 0.0028535400
-0.0034308300 0.0034066700 0.0148538900
-0.0584914800 0.0000000000 0.0240625100
0.0000000000 0.0000000000 0.0042604600
0.0584914800 0.0000000000 0.0240625100
0.0002707500 -0.0071660100 -0.0023050200
0.0000000000 -0.0016747600 -0.0000891700
-0.0002707500 -0.0071660100 -0.0023050200
0.0002707500 0.0071660100 -0.0023050200
0.0000000000 0.0016747600 -0.0000891700
-0.0002707500 0.0071660100 -0.0023050200

View File

@ -41,6 +41,18 @@ def ph_sno2():
log_level=1, produce_fc=True)
@pytest.fixture(scope='session')
def ph_tio2():
yaml_filename = os.path.join(current_dir, "phonopy_disp_TiO2.yaml")
force_sets_filename = os.path.join(current_dir, "FORCE_SETS_TiO2")
born_filename = os.path.join(current_dir, "BORN_SnO2")
return phonopy.load(yaml_filename,
force_sets_filename=force_sets_filename,
born_filename=born_filename,
is_compact_fc=False,
log_level=1, produce_fc=True)
@pytest.fixture(scope='session')
def convcell_sio2():
symbols = ['Si'] * 2 + ['O'] * 4

563
test/phonopy_disp_TiO2.yaml Normal file
View File

@ -0,0 +1,563 @@
phonopy:
version: 2.8.1
frequency_unit_conversion_factor: 15.633302
symmetry_tolerance: 1.00000e-05
configuration:
create_displacements: ".true."
physical_unit:
atomic_mass: "AMU"
length: "angstrom"
force_constants: "eV/angstrom^2"
space_group:
type: "I4_1/amd"
number: 141
Hall_symbol: "I 4bw 2bw -1bw"
primitive_matrix:
- [ -0.500000000000000, 0.500000000000000, 0.500000000000000 ]
- [ 0.500000000000000, -0.500000000000000, 0.500000000000000 ]
- [ 0.500000000000000, 0.500000000000000, -0.500000000000000 ]
supercell_matrix:
- [ 3, 0, 0 ]
- [ 0, 3, 0 ]
- [ 0, 0, 1 ]
primitive_cell:
lattice:
- [ -1.888070425000000, 1.888070425000000, 4.790243149999999 ] # a
- [ 1.888070425000000, -1.888070424999999, 4.790243149999999 ] # b
- [ 1.888070425000000, 1.888070424999999, -4.790243149999999 ] # c
points:
- symbol: O # 1
coordinates: [ 0.457386310000000, 0.957386310000000, 0.500000000000000 ]
mass: 15.999400
- symbol: O # 2
coordinates: [ 0.707386310000000, 0.707386310000000, 1.000000000000000 ]
mass: 15.999400
- symbol: O # 3
coordinates: [ 0.042613690000000, 0.542613690000000, 0.500000000000000 ]
mass: 15.999400
- symbol: O # 4
coordinates: [ 0.292613690000000, 0.292613690000000, 1.000000000000000 ]
mass: 15.999400
- symbol: Ti # 5
coordinates: [ 0.500000000000000, 0.500000000000000, 1.000000000000000 ]
mass: 47.867000
- symbol: Ti # 6
coordinates: [ 0.250000000000000, 0.750000000000000, 0.500000000000000 ]
mass: 47.867000
reciprocal_lattice: # without 2pi
- [ 0.000000000000000, 0.264820630300377, 0.104378835132826 ] # a*
- [ 0.264820630300377, 0.000000000000000, 0.104378835132826 ] # b*
- [ 0.264820630300377, 0.264820630300377, -0.000000000000000 ] # c*
unit_cell:
lattice:
- [ 3.776140850000000, 0.000000000000000, 0.000000000000000 ] # a
- [ 0.000000000000000, 3.776140850000000, 0.000000000000000 ] # b
- [ 0.000000000000000, 0.000000000000000, 9.580486300000000 ] # c
points:
- symbol: O # 1
coordinates: [ 0.500000000000000, 0.000000000000000, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 2
coordinates: [ 0.000000000000000, 0.000000000000000, 0.707386310000000 ]
mass: 15.999400
reduced_to: 2
- symbol: O # 3
coordinates: [ 0.000000000000000, 0.500000000000000, 0.542613690000000 ]
mass: 15.999400
reduced_to: 3
- symbol: O # 4
coordinates: [ 0.500000000000000, 0.500000000000000, 0.792613690000000 ]
mass: 15.999400
reduced_to: 4
- symbol: O # 5
coordinates: [ 0.000000000000000, 0.500000000000000, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 6
coordinates: [ 0.500000000000000, 0.500000000000000, 0.207386310000000 ]
mass: 15.999400
reduced_to: 2
- symbol: O # 7
coordinates: [ 0.500000000000000, 0.000000000000000, 0.042613690000000 ]
mass: 15.999400
reduced_to: 3
- symbol: O # 8
coordinates: [ 0.000000000000000, 0.000000000000000, 0.292613690000000 ]
mass: 15.999400
reduced_to: 4
- symbol: Ti # 9
coordinates: [ 0.000000000000000, 0.000000000000000, 0.500000000000000 ]
mass: 47.867000
reduced_to: 9
- symbol: Ti # 10
coordinates: [ 0.000000000000000, 0.500000000000000, 0.750000000000000 ]
mass: 47.867000
reduced_to: 10
- symbol: Ti # 11
coordinates: [ 0.500000000000000, 0.500000000000000, 0.000000000000000 ]
mass: 47.867000
reduced_to: 9
- symbol: Ti # 12
coordinates: [ 0.500000000000000, 0.000000000000000, 0.250000000000000 ]
mass: 47.867000
reduced_to: 10
supercell:
lattice:
- [ 11.328422549999999, 0.000000000000000, 0.000000000000000 ] # a
- [ 0.000000000000000, 11.328422549999999, 0.000000000000000 ] # b
- [ 0.000000000000000, 0.000000000000000, 9.580486300000000 ] # c
points:
- symbol: O # 1
coordinates: [ 0.166666666666667, 0.000000000000000, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 2
coordinates: [ 0.500000000000000, 0.000000000000000, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 3
coordinates: [ 0.833333333333333, 0.000000000000000, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 4
coordinates: [ 0.166666666666667, 0.333333333333333, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 5
coordinates: [ 0.500000000000000, 0.333333333333333, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 6
coordinates: [ 0.833333333333333, 0.333333333333333, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 7
coordinates: [ 0.166666666666667, 0.666666666666667, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 8
coordinates: [ 0.500000000000000, 0.666666666666667, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 9
coordinates: [ 0.833333333333333, 0.666666666666667, 0.457386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 10
coordinates: [ 0.000000000000000, 0.000000000000000, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 11
coordinates: [ 0.333333333333333, 0.000000000000000, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 12
coordinates: [ 0.666666666666667, 0.000000000000000, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 13
coordinates: [ 0.000000000000000, 0.333333333333333, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 14
coordinates: [ 0.333333333333333, 0.333333333333333, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 15
coordinates: [ 0.666666666666667, 0.333333333333333, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 16
coordinates: [ 0.000000000000000, 0.666666666666667, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 17
coordinates: [ 0.333333333333333, 0.666666666666667, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 18
coordinates: [ 0.666666666666667, 0.666666666666667, 0.707386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 19
coordinates: [ 0.000000000000000, 0.166666666666667, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 20
coordinates: [ 0.333333333333333, 0.166666666666667, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 21
coordinates: [ 0.666666666666667, 0.166666666666667, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 22
coordinates: [ 0.000000000000000, 0.500000000000000, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 23
coordinates: [ 0.333333333333333, 0.500000000000000, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 24
coordinates: [ 0.666666666666667, 0.500000000000000, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 25
coordinates: [ 0.000000000000000, 0.833333333333333, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 26
coordinates: [ 0.333333333333333, 0.833333333333333, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 27
coordinates: [ 0.666666666666667, 0.833333333333333, 0.542613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 28
coordinates: [ 0.166666666666667, 0.166666666666667, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 29
coordinates: [ 0.500000000000000, 0.166666666666667, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 30
coordinates: [ 0.833333333333333, 0.166666666666667, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 31
coordinates: [ 0.166666666666667, 0.500000000000000, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 32
coordinates: [ 0.500000000000000, 0.500000000000000, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 33
coordinates: [ 0.833333333333333, 0.500000000000000, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 34
coordinates: [ 0.166666666666667, 0.833333333333333, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 35
coordinates: [ 0.500000000000000, 0.833333333333333, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 36
coordinates: [ 0.833333333333333, 0.833333333333333, 0.792613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 37
coordinates: [ 0.000000000000000, 0.166666666666667, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 38
coordinates: [ 0.333333333333333, 0.166666666666667, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 39
coordinates: [ 0.666666666666667, 0.166666666666667, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 40
coordinates: [ 0.000000000000000, 0.500000000000000, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 41
coordinates: [ 0.333333333333333, 0.500000000000000, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 42
coordinates: [ 0.666666666666667, 0.500000000000000, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 43
coordinates: [ 0.000000000000000, 0.833333333333333, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 44
coordinates: [ 0.333333333333333, 0.833333333333333, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 45
coordinates: [ 0.666666666666667, 0.833333333333333, 0.957386310000000 ]
mass: 15.999400
reduced_to: 1
- symbol: O # 46
coordinates: [ 0.166666666666667, 0.166666666666667, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 47
coordinates: [ 0.500000000000000, 0.166666666666667, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 48
coordinates: [ 0.833333333333333, 0.166666666666667, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 49
coordinates: [ 0.166666666666667, 0.500000000000000, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 50
coordinates: [ 0.500000000000000, 0.500000000000000, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 51
coordinates: [ 0.833333333333333, 0.500000000000000, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 52
coordinates: [ 0.166666666666667, 0.833333333333333, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 53
coordinates: [ 0.500000000000000, 0.833333333333333, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 54
coordinates: [ 0.833333333333333, 0.833333333333333, 0.207386310000000 ]
mass: 15.999400
reduced_to: 10
- symbol: O # 55
coordinates: [ 0.166666666666667, 0.000000000000000, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 56
coordinates: [ 0.500000000000000, 0.000000000000000, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 57
coordinates: [ 0.833333333333333, 0.000000000000000, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 58
coordinates: [ 0.166666666666667, 0.333333333333333, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 59
coordinates: [ 0.500000000000000, 0.333333333333333, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 60
coordinates: [ 0.833333333333333, 0.333333333333333, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 61
coordinates: [ 0.166666666666667, 0.666666666666667, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 62
coordinates: [ 0.500000000000000, 0.666666666666667, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 63
coordinates: [ 0.833333333333333, 0.666666666666667, 0.042613690000000 ]
mass: 15.999400
reduced_to: 19
- symbol: O # 64
coordinates: [ 0.000000000000000, 0.000000000000000, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 65
coordinates: [ 0.333333333333333, 0.000000000000000, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 66
coordinates: [ 0.666666666666667, 0.000000000000000, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 67
coordinates: [ 0.000000000000000, 0.333333333333333, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 68
coordinates: [ 0.333333333333333, 0.333333333333333, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 69
coordinates: [ 0.666666666666667, 0.333333333333333, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 70
coordinates: [ 0.000000000000000, 0.666666666666667, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 71
coordinates: [ 0.333333333333333, 0.666666666666667, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: O # 72
coordinates: [ 0.666666666666667, 0.666666666666667, 0.292613690000000 ]
mass: 15.999400
reduced_to: 28
- symbol: Ti # 73
coordinates: [ 0.000000000000000, 0.000000000000000, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 74
coordinates: [ 0.333333333333333, 0.000000000000000, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 75
coordinates: [ 0.666666666666667, 0.000000000000000, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 76
coordinates: [ 0.000000000000000, 0.333333333333333, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 77
coordinates: [ 0.333333333333333, 0.333333333333333, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 78
coordinates: [ 0.666666666666667, 0.333333333333333, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 79
coordinates: [ 0.000000000000000, 0.666666666666667, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 80
coordinates: [ 0.333333333333333, 0.666666666666667, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 81
coordinates: [ 0.666666666666667, 0.666666666666667, 0.500000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 82
coordinates: [ 0.000000000000000, 0.166666666666667, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 83
coordinates: [ 0.333333333333333, 0.166666666666667, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 84
coordinates: [ 0.666666666666667, 0.166666666666667, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 85
coordinates: [ 0.000000000000000, 0.500000000000000, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 86
coordinates: [ 0.333333333333333, 0.500000000000000, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 87
coordinates: [ 0.666666666666667, 0.500000000000000, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 88
coordinates: [ 0.000000000000000, 0.833333333333333, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 89
coordinates: [ 0.333333333333333, 0.833333333333333, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 90
coordinates: [ 0.666666666666667, 0.833333333333333, 0.750000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 91
coordinates: [ 0.166666666666667, 0.166666666666667, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 92
coordinates: [ 0.500000000000000, 0.166666666666667, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 93
coordinates: [ 0.833333333333333, 0.166666666666667, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 94
coordinates: [ 0.166666666666667, 0.500000000000000, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 95
coordinates: [ 0.500000000000000, 0.500000000000000, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 96
coordinates: [ 0.833333333333333, 0.500000000000000, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 97
coordinates: [ 0.166666666666667, 0.833333333333333, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 98
coordinates: [ 0.500000000000000, 0.833333333333333, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 99
coordinates: [ 0.833333333333333, 0.833333333333333, 0.000000000000000 ]
mass: 47.867000
reduced_to: 73
- symbol: Ti # 100
coordinates: [ 0.166666666666667, 0.000000000000000, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 101
coordinates: [ 0.500000000000000, 0.000000000000000, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 102
coordinates: [ 0.833333333333333, 0.000000000000000, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 103
coordinates: [ 0.166666666666667, 0.333333333333333, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 104
coordinates: [ 0.500000000000000, 0.333333333333333, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 105
coordinates: [ 0.833333333333333, 0.333333333333333, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 106
coordinates: [ 0.166666666666667, 0.666666666666667, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 107
coordinates: [ 0.500000000000000, 0.666666666666667, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
- symbol: Ti # 108
coordinates: [ 0.833333333333333, 0.666666666666667, 0.250000000000000 ]
mass: 47.867000
reduced_to: 82
displacements:
- atom: 1
displacement:
[ 0.0060687317141537, 0.0060687317141537, 0.0051323474905008 ]
- atom: 1
displacement:
[ -0.0060687317141537, -0.0060687317141537, -0.0051323474905008 ]
- atom: 73
displacement:
[ 0.0076355582977273, 0.0000000000000000, 0.0064574181746273 ]
- atom: 73
displacement:
[ -0.0076355582977273, 0.0000000000000000, -0.0064574181746273 ]

View File

@ -160,3 +160,7 @@ def test_GridPoints_SnO2_with_rotations_MP(ph_sno2):
[0.125, 0.125, 0.375],
[0.375, 0.125, 0.375],
[0.375, 0.375, 0.375]], atol=1e-8)
def test_GeneralizedRegularGridPoints(ph_tio2):
pass

View File

@ -59,7 +59,7 @@ def test_magmom(convcell_cr):
assert len_sym_nonspin != len_sym_brokenspin
def test_symmetrize_borns_and_epsilon(ph_nacl):
def test_symmetrize_borns_and_epsilon_nacl(ph_nacl):
nac_params = ph_nacl.nac_params
borns, epsilon = symmetrize_borns_and_epsilon(
nac_params['born'], nac_params['dielectric'], ph_nacl.primitive)
@ -67,6 +67,14 @@ def test_symmetrize_borns_and_epsilon(ph_nacl):
np.testing.assert_allclose(epsilon, nac_params['dielectric'], atol=1e-8)
def test_symmetrize_borns_and_epsilon_tio2(ph_tio2):
nac_params = ph_tio2.nac_params
borns, epsilon = symmetrize_borns_and_epsilon(
nac_params['born'], nac_params['dielectric'], ph_tio2.primitive)
# np.testing.assert_allclose(borns, nac_params['born'], atol=1e-8)
np.testing.assert_allclose(epsilon, nac_params['dielectric'], atol=1e-8)
def test_with_pmat_and_smat(ph_nacl):
pcell = ph_nacl.primitive
scell = ph_nacl.supercell