Skip to content

Commit beb0384

Browse files
committedAug 8, 2020
Added missing ks_helper; size(a)[1] -> size(a,1)
1 parent 2e38365 commit beb0384

9 files changed

+245
-32
lines changed
 

‎Tutorials/04_Density_Functional_Theory/4b_LDA_kernel.ipynb

+3-2
Original file line numberDiff line numberDiff line change
@@ -150,7 +150,7 @@
150150
"display(lpos)\n",
151151
"\n",
152152
"# Copmute phi, note the number of points and function per phi changes.\n",
153-
"phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos)[1]]\n",
153+
"phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos,1)]\n",
154154
"println(\"\\nPhi Matrix\")\n",
155155
"display(phi)"
156156
]
@@ -267,7 +267,7 @@
267267
" w = np.array(block.w())\n",
268268
"\n",
269269
" # Compute ϕᴾμ!\n",
270-
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos)[1]]\n",
270+
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos,1)]\n",
271271
" \n",
272272
" # Build a local slice of D\n",
273273
" lD = D[lpos,lpos]\n",
@@ -317,6 +317,7 @@
317317
],
318318
"metadata": {
319319
"jupytext": {
320+
"encoding": "# -*- coding: utf-8 -*-",
320321
"formats": "jl:light,ipynb"
321322
},
322323
"kernelspec": {

‎Tutorials/04_Density_Functional_Theory/4b_LDA_kernel.jl

+2-2
Original file line numberDiff line numberDiff line change
@@ -69,7 +69,7 @@ println("Local basis function mapping")
6969
display(lpos)
7070

7171
# Copmute phi, note the number of points and function per phi changes.
72-
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos)[1]]
72+
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos,1)]
7373
println("\nPhi Matrix")
7474
display(phi)
7575
# -
@@ -111,7 +111,7 @@ xc_e, V = let xc_e = 0.0, rho = rho
111111
w = np.array(block.w())
112112

113113
# Compute ϕᴾμ!
114-
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos)[1]]
114+
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos,1)]
115115

116116
# Build a local slice of D
117117
lD = D[lpos,lpos]

‎Tutorials/04_Density_Functional_Theory/4c_GGA_and_Meta_GGA.ipynb

+9-8
Original file line numberDiff line numberDiff line change
@@ -235,11 +235,11 @@
235235
" w = np.array(block.w())\n",
236236
"\n",
237237
" # Compute phi!\n",
238-
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos)[1]]\n",
238+
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos,1)]\n",
239239
" \n",
240-
" phi_x = np.array(points_func.basis_values()[\"PHI_X\"])[1:npoints, 1:size(lpos)[1]]\n",
241-
" phi_y = np.array(points_func.basis_values()[\"PHI_Y\"])[1:npoints, 1:size(lpos)[1]]\n",
242-
" phi_z = np.array(points_func.basis_values()[\"PHI_Z\"])[1:npoints, 1:size(lpos)[1]]\n",
240+
" phi_x = np.array(points_func.basis_values()[\"PHI_X\"])[1:npoints, 1:size(lpos,1)]\n",
241+
" phi_y = np.array(points_func.basis_values()[\"PHI_Y\"])[1:npoints, 1:size(lpos,1)]\n",
242+
" phi_z = np.array(points_func.basis_values()[\"PHI_Z\"])[1:npoints, 1:size(lpos,1)]\n",
243243
" \n",
244244
" # Build a local slice of D\n",
245245
" lD = D[lpos, lpos]\n",
@@ -390,11 +390,11 @@
390390
" w = np.array(block.w())\n",
391391
"\n",
392392
" # Compute phi!\n",
393-
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos)[1]]\n",
393+
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:size(lpos,1)]\n",
394394
" \n",
395-
" phi_x = np.array(points_func.basis_values()[\"PHI_X\"])[1:npoints, 1:size(lpos)[1]]\n",
396-
" phi_y = np.array(points_func.basis_values()[\"PHI_Y\"])[1:npoints, 1:size(lpos)[1]]\n",
397-
" phi_z = np.array(points_func.basis_values()[\"PHI_Z\"])[1:npoints, 1:size(lpos)[1]]\n",
395+
" phi_x = np.array(points_func.basis_values()[\"PHI_X\"])[1:npoints, 1:size(lpos,1)]\n",
396+
" phi_y = np.array(points_func.basis_values()[\"PHI_Y\"])[1:npoints, 1:size(lpos,1)]\n",
397+
" phi_z = np.array(points_func.basis_values()[\"PHI_Z\"])[1:npoints, 1:size(lpos,1)]\n",
398398
" \n",
399399
" # Build a local slice of D\n",
400400
" lD = D[lpos, lpos]\n",
@@ -518,6 +518,7 @@
518518
],
519519
"metadata": {
520520
"jupytext": {
521+
"encoding": "# -*- coding: utf-8 -*-",
521522
"formats": "jl:light,ipynb"
522523
},
523524
"kernelspec": {

‎Tutorials/04_Density_Functional_Theory/4c_GGA_and_Meta_GGA.jl

+8-8
Original file line numberDiff line numberDiff line change
@@ -183,11 +183,11 @@ xc_e, V = let xc_e = xc_e, rho=rho
183183
w = np.array(block.w())
184184

185185
# Compute phi!
186-
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos)[1]]
186+
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos,1)]
187187

188-
phi_x = np.array(points_func.basis_values()["PHI_X"])[1:npoints, 1:size(lpos)[1]]
189-
phi_y = np.array(points_func.basis_values()["PHI_Y"])[1:npoints, 1:size(lpos)[1]]
190-
phi_z = np.array(points_func.basis_values()["PHI_Z"])[1:npoints, 1:size(lpos)[1]]
188+
phi_x = np.array(points_func.basis_values()["PHI_X"])[1:npoints, 1:size(lpos,1)]
189+
phi_y = np.array(points_func.basis_values()["PHI_Y"])[1:npoints, 1:size(lpos,1)]
190+
phi_z = np.array(points_func.basis_values()["PHI_Z"])[1:npoints, 1:size(lpos,1)]
191191

192192
# Build a local slice of D
193193
lD = D[lpos, lpos]
@@ -305,11 +305,11 @@ xc_e, V = let xc_e = xc_e, rho=rho
305305
w = np.array(block.w())
306306

307307
# Compute phi!
308-
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos)[1]]
308+
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:size(lpos,1)]
309309

310-
phi_x = np.array(points_func.basis_values()["PHI_X"])[1:npoints, 1:size(lpos)[1]]
311-
phi_y = np.array(points_func.basis_values()["PHI_Y"])[1:npoints, 1:size(lpos)[1]]
312-
phi_z = np.array(points_func.basis_values()["PHI_Z"])[1:npoints, 1:size(lpos)[1]]
310+
phi_x = np.array(points_func.basis_values()["PHI_X"])[1:npoints, 1:size(lpos,1)]
311+
phi_y = np.array(points_func.basis_values()["PHI_Y"])[1:npoints, 1:size(lpos,1)]
312+
phi_z = np.array(points_func.basis_values()["PHI_Z"])[1:npoints, 1:size(lpos,1)]
313313

314314
# Build a local slice of D
315315
lD = D[lpos, lpos]

‎Tutorials/04_Density_Functional_Theory/4d_VV10.ipynb

+3-3
Original file line numberDiff line numberDiff line change
@@ -235,7 +235,7 @@
235235
" l_x = np.array(l_grid.x())\n",
236236
" l_y = np.array(l_grid.y())\n",
237237
" l_z = np.array(l_grid.z())\n",
238-
" l_npoints = size(l_w)[1]\n",
238+
" l_npoints = size(l_w,1)\n",
239239
"\n",
240240
" points_func.compute_points(l_grid)\n",
241241
"\n",
@@ -265,7 +265,7 @@
265265
" r_x = np.array(r_grid.x())\n",
266266
" r_y = np.array(r_grid.y())\n",
267267
" r_z = np.array(r_grid.z())\n",
268-
" r_npoints = size(r_w)[1]\n",
268+
" r_npoints = size(r_w,1)\n",
269269
"\n",
270270
" points_func.compute_points(r_grid)\n",
271271
"\n",
@@ -311,7 +311,7 @@
311311
" # Recompute to l_grid\n",
312312
" lpos = np.array(l_grid.functions_local_to_global()) .+ 1\n",
313313
" points_func.compute_points(l_grid)\n",
314-
" nfunctions = size(lpos)[1]\n",
314+
" nfunctions = size(lpos,1)\n",
315315
" \n",
316316
" # Integrate the LDA and GGA quantities\n",
317317
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:l_npoints, 1:nfunctions]\n",

‎Tutorials/04_Density_Functional_Theory/4d_VV10.jl

+3-3
Original file line numberDiff line numberDiff line change
@@ -131,7 +131,7 @@ function compute_vv10(D, Vpot)
131131
l_x = np.array(l_grid.x())
132132
l_y = np.array(l_grid.y())
133133
l_z = np.array(l_grid.z())
134-
l_npoints = size(l_w)[1]
134+
l_npoints = size(l_w,1)
135135

136136
points_func.compute_points(l_grid)
137137

@@ -161,7 +161,7 @@ function compute_vv10(D, Vpot)
161161
r_x = np.array(r_grid.x())
162162
r_y = np.array(r_grid.y())
163163
r_z = np.array(r_grid.z())
164-
r_npoints = size(r_w)[1]
164+
r_npoints = size(r_w,1)
165165

166166
points_func.compute_points(r_grid)
167167

@@ -207,7 +207,7 @@ function compute_vv10(D, Vpot)
207207
# Recompute to l_grid
208208
lpos = np.array(l_grid.functions_local_to_global()) .+ 1
209209
points_func.compute_points(l_grid)
210-
nfunctions = size(lpos)[1]
210+
nfunctions = size(lpos,1)
211211

212212
# Integrate the LDA and GGA quantities
213213
phi = np.array(points_func.basis_values()["PHI"])[1:l_npoints, 1:nfunctions]

‎Tutorials/04_Density_Functional_Theory/4e_GRAC.ipynb

+3-3
Original file line numberDiff line numberDiff line change
@@ -136,7 +136,7 @@
136136
" x = np.array(grid.x())\n",
137137
" y = np.array(grid.y())\n",
138138
" z = np.array(grid.z())\n",
139-
" npoints = size(z)[1]\n",
139+
" npoints = size(z,1)\n",
140140
"\n",
141141
" # Get radial information\n",
142142
" R = @. (x^2 + y^2 + z^2)^0.5\n",
@@ -363,11 +363,11 @@
363363
" # Grid data\n",
364364
" grid = Vpot.get_block(x-1)\n",
365365
" w = np.array(grid.w())\n",
366-
" npoints = size(w)[1]\n",
366+
" npoints = size(w,1)\n",
367367
"\n",
368368
" points_func.compute_points(grid)\n",
369369
" lpos = np.array(grid.functions_local_to_global()) .+ 1\n",
370-
" nfunctions = size(lpos)[1]\n",
370+
" nfunctions = size(lpos,1)\n",
371371
" \n",
372372
" phi = np.array(points_func.basis_values()[\"PHI\"])[1:npoints, 1:nfunctions]\n",
373373
" \n",

‎Tutorials/04_Density_Functional_Theory/4e_GRAC.jl

+3-3
Original file line numberDiff line numberDiff line change
@@ -98,7 +98,7 @@ function one_electron_radial(matrices, Vpot)
9898
x = np.array(grid.x())
9999
y = np.array(grid.y())
100100
z = np.array(grid.z())
101-
npoints = size(z)[1]
101+
npoints = size(z,1)
102102

103103
# Get radial information
104104
R = @. (x^2 + y^2 + z^2)^0.5
@@ -223,11 +223,11 @@ function compute_V_GRAC(D, Vpot)
223223
# Grid data
224224
grid = Vpot.get_block(x-1)
225225
w = np.array(grid.w())
226-
npoints = size(w)[1]
226+
npoints = size(w,1)
227227

228228
points_func.compute_points(grid)
229229
lpos = np.array(grid.functions_local_to_global()) .+ 1
230-
nfunctions = size(lpos)[1]
230+
nfunctions = size(lpos,1)
231231

232232
phi = np.array(points_func.basis_values()["PHI"])[1:npoints, 1:nfunctions]
233233

Original file line numberDiff line numberDiff line change
@@ -0,0 +1,211 @@
1+
#! A simple Psi4 input script to compute a SCF reference using Psi4's libJK
2+
3+
psi4 = pyimport("psi4")
4+
np = pyimport("numpy") # used only to cast to Psi4 arrays
5+
6+
build_superfunctional = nothing
7+
if VersionNumber(psi4.__version__) >= v"1.3a1"
8+
build_superfunctional = psi4.driver.dft.build_superfunctional
9+
else
10+
build_superfunctional = psi4.driver.dft_funcs.build_superfunctional
11+
end
12+
13+
function psi4view(psi4matrix)
14+
# Assumes Float64 type, C ordering
15+
if !hasproperty(psi4matrix,:__array_interface__)
16+
throw(ArgumentError("Input matrix cannot be accessed. Cannot be an rvalue"))
17+
end
18+
array_interface = psi4matrix.__array_interface__
19+
array_interface["data"][2] == false || @warn "Not writable"
20+
array_interface["strides"] == nothing || @warn "Different ordering than C"
21+
array_interface["typestr"] == "<f8" || @warn "Not little-endian Float64 eltype"
22+
ptr = array_interface["data"][1]
23+
shape = reverse(array_interface["shape"])
24+
ndims = length(shape)
25+
permutedims(unsafe_wrap(Array{Float64,ndims}, Ptr{Float64}(ptr), shape), reverse(1:ndims))
26+
end
27+
28+
# Diagonalize routine
29+
function build_orbitals(diag, A, ndocc)
30+
Fp = psi4.core.triplet(A, diag, A, true, false, true)
31+
32+
#A_view = psi4view(A)
33+
#nbf = size(A_view,1)
34+
nbf = A.shape[1]
35+
Cp = psi4.core.Matrix(nbf, nbf)
36+
eigvecs = psi4.core.Vector(nbf)
37+
Fp.diagonalize(Cp, eigvecs, psi4.core.DiagonalizeOrder.Ascending)
38+
39+
C = psi4.core.doublet(A, Cp, false, false)
40+
C_jl = np.asarray(C)
41+
42+
#Cocc = psi4.core.Matrix(nbf, ndocc)
43+
#Cocc_view = psi4view(Cocc) # returns C ordering
44+
#Cocc_view .= C_jl[:,1:ndocc] # or reverse because C ordering
45+
#Cocc.np[:] = C.np[:, 1:ndocc] # It is not going to work
46+
Cocc_jl = zeros(nbf,ndocc)
47+
Cocc_jl .= C_jl[:,1:ndocc] # or reverse because C ordering
48+
Cocc = psi4.core.Matrix.from_array(Cocc_jl)
49+
50+
D = psi4.core.doublet(Cocc, Cocc, false, true)
51+
52+
C, Cocc, D, eigvecs
53+
end
54+
55+
function ks_solver(alias, mol, options, V_builder::Function,
56+
jk_type="DF", output="output.dat", restricted=true)
57+
58+
# Build our molecule
59+
mol = mol.clone()
60+
mol.reset_point_group("c1")
61+
mol.fix_orientation(true)
62+
mol.fix_com(true)
63+
mol.update_geometry()
64+
65+
# Set options
66+
psi4.set_output_file(output)
67+
68+
psi4.core.prepare_options_for_module("SCF")
69+
psi4.set_options(options)
70+
psi4.core.set_global_option("SCF_TYPE", jk_type)
71+
72+
maxiter = 20
73+
E_conv = psi4.core.get_option("SCF", "E_CONVERGENCE")
74+
D_conv = psi4.core.get_option("SCF", "D_CONVERGENCE")
75+
76+
# Integral generation from Psi4's MintsHelper
77+
wfn = psi4.core.Wavefunction.build(mol, psi4.core.get_global_option("BASIS"))
78+
mints = psi4.core.MintsHelper(wfn.basisset())
79+
S = mints.ao_overlap()
80+
81+
# Build the V Potential
82+
sup = build_superfunctional(alias, restricted)[1]
83+
sup.set_deriv(2)
84+
sup.allocate()
85+
86+
vname = "RV"
87+
if !restricted
88+
vname = "UV"
89+
end
90+
Vpot = psi4.core.VBase.build(wfn.basisset(), sup, vname)
91+
Vpot.initialize()
92+
93+
# Get nbf and ndocc for closed shell molecules
94+
nbf = wfn.nso()
95+
ndocc = wfn.nalpha()
96+
if wfn.nalpha() != wfn.nbeta()
97+
error("Only valid for RHF wavefunctions!")
98+
end
99+
100+
println("\nNumber of occupied orbitals: ", ndocc)
101+
println("Number of basis functions: ", nbf)
102+
103+
# Build H_core
104+
V = mints.ao_potential()
105+
T = mints.ao_kinetic()
106+
H = T.clone()
107+
H.add(V)
108+
109+
# Orthogonalizer A = S^(-1/2)
110+
A = mints.ao_overlap()
111+
A.power(-0.5, 1.e-14)
112+
113+
# Build core orbitals
114+
C, Cocc, D, eigs = build_orbitals(H, A, ndocc)
115+
116+
# Setup data for DIIS
117+
#t = @elapsed begin
118+
E = 0.0
119+
Enuc = mol.nuclear_repulsion_energy()
120+
Eold = 0.0
121+
122+
# Initialize the JK object
123+
jk = psi4.core.JK.build(wfn.basisset())
124+
jk.set_memory(Int(1.25e8)) # 1GB
125+
jk.initialize()
126+
jk.print_header()
127+
128+
diis_obj = psi4.p4util.solvers.DIIS(max_vec=3, removal_policy="largest")
129+
#end
130+
131+
#println("\nTotal time taken for setup: $t seconds")
132+
133+
println("\nStarting SCF iterations:")
134+
135+
println("\n Iter Energy XC E Delta E D RMS\n")
136+
SCF_E = 0.0
137+
#t = @elapsed begin
138+
139+
for SCF_ITER in 1:maxiter
140+
141+
# Compute JK
142+
jk.C_left_add(Cocc)
143+
jk.compute()
144+
jk.C_clear()
145+
146+
# Build Fock matrix
147+
F = H.clone()
148+
F.axpy(2.0, jk.J()[1])
149+
F.axpy(-Vpot.functional().x_alpha(), jk.K()[1])
150+
151+
# Build V
152+
ks_e = 0.0
153+
154+
Vpot.set_D([D])
155+
Vpot.properties()[1].set_pointers(D)
156+
V = V_builder(D, Vpot)
157+
if isnothing(V)
158+
ks_e = 0.0
159+
else
160+
ks_e, V = V
161+
V = psi4.core.Matrix.from_array(V)
162+
end
163+
164+
F.axpy(1.0, V)
165+
166+
# DIIS error build and update
167+
diis_e = psi4.core.triplet(F, D, S, false, false, false)
168+
diis_e.subtract(psi4.core.triplet(S, D, F, false, false, false))
169+
diis_e = psi4.core.triplet(A, diis_e, A, false, false, false)
170+
171+
diis_obj.add(F, diis_e)
172+
173+
dRMS = diis_e.rms()
174+
175+
# SCF energy and update
176+
SCF_E = 2H.vector_dot(D)
177+
SCF_E += 2jk.J()[1].vector_dot(D)
178+
SCF_E -= Vpot.functional().x_alpha() * jk.K()[1].vector_dot(D)
179+
SCF_E += ks_e
180+
SCF_E += Enuc
181+
182+
printfmt("SCF Iter{1:3d}: {2:18.14f} {3:11.7f} {4:1.5E} {5:1.5E}\n",
183+
SCF_ITER, SCF_E, ks_e, (SCF_E - Eold), dRMS)
184+
if abs(SCF_E - Eold) < E_conv && dRMS < D_conv
185+
break
186+
end
187+
188+
Eold = SCF_E
189+
190+
# DIIS extrapolate
191+
F = diis_obj.extrapolate()
192+
193+
# Diagonalize Fock matrix
194+
C, Cocc, D, eigs = build_orbitals(F, A, ndocc)
195+
196+
if SCF_ITER == maxiter
197+
error("Maximum number of SCF cycles exceeded.")
198+
end
199+
end
200+
#end
201+
202+
#println("\nTotal time for SCF iterations: $t seconds.")
203+
204+
printfmt("\nFinal SCF energy: {:.8f} hartree \n", SCF_E)
205+
206+
data = Dict()
207+
data["Da"] = D
208+
data["Ca"] = C
209+
data["eigenvalues"] = eigs
210+
SCF_E, data
211+
end

0 commit comments

Comments
 (0)
Please sign in to comment.