Skip to content

Commit dd4b14c

Browse files
fchapotonsunqm
authored andcommitted
fixing a few typos
1 parent e648cc8 commit dd4b14c

Some content is hidden

Large Commits have some content hidden by default. Use the searchbox below for content that may be hidden.

59 files changed

+89
-89
lines changed

pyscf/agf2/chkfile.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -111,7 +111,7 @@ def load_agf2(chkfile):
111111
def dump_agf2(agf2, chkfile=None, key='agf2',
112112
gf=None, se=None, frozen=None, nmom=None,
113113
mo_energy=None, mo_coeff=None, mo_occ=None):
114-
''' Save the AGF2 calculatuion to a chkfile.
114+
''' Save the AGF2 calculation to a chkfile.
115115
'''
116116

117117
if mpi_helper.rank != 0:

pyscf/data/elements.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -827,7 +827,7 @@
827827
[14,36,40,28], #118 Og
828828
]
829829

830-
# This is No. of shells, not the atomic configuations
830+
# This is No. of shells, not the atomic configurations
831831
# core core+valence
832832
# core+valence = lambda nuc, l: \
833833
# int(numpy.ceil(pyscf.lib.parameters.ELEMENTS[nuc][2][l]/(4*l+2.)))

pyscf/df/df.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -166,7 +166,7 @@ def build(self):
166166
max_memory=max_memory, verbose=log)
167167
else:
168168
# Store DF tensor in blocks. This is to reduce the
169-
# initiailzation overhead
169+
# initialization overhead
170170
outcore.cholesky_eri_b(mol, cderi, dataname=self._dataname,
171171
int3c=int3c, int2c=int2c, auxmol=auxmol,
172172
max_memory=max_memory, verbose=log)

pyscf/dft/xcfun.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -833,7 +833,7 @@ def parse_token(token, suffix, search_xc_alias=False):
833833

834834
def eval_xc(xc_code, rho, spin=0, relativity=0, deriv=1, omega=None, verbose=None):
835835
r'''Interface to call xcfun library to evaluate XC functional, potential
836-
and functional derivatives. Return deriviates following libxc convention.
836+
and functional derivatives. Return derivatives following libxc convention.
837837
838838
See also :func:`pyscf.dft.libxc.eval_xc`
839839
'''

pyscf/eph/eph_fd.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -101,7 +101,7 @@ def kernel(mf, disp=1e-4, mo_rep=False, cutoff_frequency=CUTOFF_FREQUENCY, keep_
101101
omega, vec = get_mode(mf, cutoff_frequency, keep_imag_frequency)
102102
mass = mol.atom_mass_list() * MP_ME
103103
vec = rhf_eph._freq_mass_weighted_vec(vec, omega, mass)
104-
mols_a, mols_b = gen_moles(mol, disp/2.0) # generate a bunch of molecules with disp/2 on each cartesion coord
104+
mols_a, mols_b = gen_moles(mol, disp/2.0) # generate a bunch of molecules with disp/2 on each cartesian coord
105105
mfset = run_mfs(mf, mols_a, mols_b) # run mean field calculations on all these molecules
106106
vmat = get_vmat(mf, mfset, disp) # extracting <p|dV|q>/dR
107107
if mo_rep:

pyscf/fci/addons.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -224,7 +224,7 @@ def search_open_shell_det(occ_lst):
224224
ci_1[addr_x_a,addr_y_b] = numpy.sqrt(.5)
225225
ci_1[addr_y_a,addr_x_b] =-numpy.sqrt(.5)
226226
else:
227-
# TODO: Other direct-product to direct-sum transofromation
227+
# TODO: Other direct-product to direct-sum transformation
228228
# which involves CG coefficients.
229229
ci_1[addra,addrb] = 1
230230
ci0.append(ci_1.ravel())

pyscf/fci/cistring.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -200,7 +200,7 @@ def gen_linkstr_index(orb_list, nocc, strs=None, tril=False):
200200
For given string str0, index[str0] is (nocc+nocc*nvir) x 4 array.
201201
The first nocc rows [i(:occ),i(:occ),str0,sign] are occupied-occupied
202202
excitations, which do not change the string. The next nocc*nvir rows
203-
[a(:vir),i(:occ),str1,sign] are occupied-virtual exciations, starting from
203+
[a(:vir),i(:occ),str1,sign] are occupied-virtual excitations, starting from
204204
str0, annihilating i, creating a, to get str1.
205205
'''
206206
if strs is None:

pyscf/gto/mole.py

Lines changed: 3 additions & 3 deletions
Original file line numberDiff line numberDiff line change
@@ -459,7 +459,7 @@ def format_basis(basis_tab, sort_basis=True):
459459
if len(_basis) == 0:
460460
raise BasisNotFoundError('Basis not found for %s' % symb)
461461

462-
# Sort basis accroding to angular momentum. This is important for method
462+
# Sort basis according to angular momentum. This is important for method
463463
# decontract_basis, which assumes that basis functions with the same
464464
# angular momentum are grouped together. Related to issue #1620 #1770
465465
if sort_basis:
@@ -2457,7 +2457,7 @@ def build(self, dump_input=True, parse_arg=ARGPARSE,
24572457
atom=None, basis=None, unit=None, nucmod=None, ecp=None, pseudo=None,
24582458
charge=None, spin=0, symmetry=None, symmetry_subgroup=None,
24592459
cart=None, magmom=None):
2460-
'''Setup moleclue and initialize some control parameters. Whenever you
2460+
'''Setup molecule and initialize some control parameters. Whenever you
24612461
change the value of the attributes of :class:`Mole`, you need call
24622462
this function to refresh the internal data of Mole.
24632463
@@ -3800,7 +3800,7 @@ def ao2mo(self, mo_coeffs, erifile=None, dataname='eri_mo', intor='int2e',
38003800
return ao2mo.kernel(self, mo_coeffs, erifile, dataname, intor, **kwargs)
38013801

38023802
def to_cell(self, a, dimension=3):
3803-
'''Put a molecule in a cell with periodic boundary condictions
3803+
'''Put a molecule in a cell with periodic boundary conditions
38043804
38053805
Args:
38063806
a : (3,3) ndarray

pyscf/lib/dft/grid_common.c

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -242,7 +242,7 @@ int orth_components(double *xs_exp, int* bounds, double dx, double radius,
242242
}
243243
}
244244

245-
// add up contributions from all images to the referece image
245+
// add up contributions from all images to the reference image
246246
if (ngridx >= nx_per_cell) {
247247
memset(xs_exp, 0, (topl+1)*nx_per_cell*sizeof(double));
248248
int ix, l, lb, ub, size_x;

pyscf/lib/dft/xcfun_itrf.c

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -102,7 +102,7 @@ int XCFUN_eval_xc(int nfn, int *fn_id, double *fac, double *omega,
102102
rho = rho_u;
103103
err = eval_xc(fun, deriv, XC_N, np, 1, outlen, rho, output);
104104
}
105-
// xcfun computed rho*Exc[rho] for zeroth order deriviative instead of Exc[rho]
105+
// xcfun computed rho*Exc[rho] for zeroth order derivative instead of Exc[rho]
106106
for (i = 0; i < np; i++) {
107107
output[i*outlen] /= rho_u[i] + 1e-150;
108108
}

0 commit comments

Comments
 (0)