|
| 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