pyscf.adc package¶
Submodules¶
pyscf.adc.uadc module¶
Unrestricted algebraic diagrammatic construction
-
class
pyscf.adc.uadc.
UADC
(mf, frozen=None, mo_coeff=None, mo_occ=None)¶ Bases:
pyscf.lib.misc.StreamObject
Ground state calculations
- Attributes:
- verboseint
Print level. Default value equals to
Mole.verbose
- max_memoryfloat or int
Allowed memory in MB. Default value equals to
Mole.max_memory
- incore_completebool
Avoid all I/O. Default is False.
- methodstring
nth-order ADC method. Options are : ADC(2), ADC(2)-X, ADC(3). Default is ADC(2).
>>> mol = gto.M(atom = 'H 0 0 0; F 0 0 1.1', basis = 'ccpvdz') >>> mf = scf.RHF(mol).run() >>> myadc = adc.UADC(mf).run()
Saved results
- e_corrfloat
MPn correlation correction
- e_totfloat
Total energy (HF + correlation)
- t1, t2 :
T amplitudes t1[i,a], t2[i,j,a,b] (i,j in occ, a,b in virt)
-
compute_amplitudes
(eris)¶
-
compute_energy
(t1, t2, eris)¶
-
dump_flags
(verbose=None)¶
-
dump_flags_gs
(verbose=None)¶
-
ea_adc
(nroots=1, guess=None)¶
-
incore_complete
= False¶
-
ip_adc
(nroots=1, guess=None)¶
-
kernel
()¶ Kernel function is the main driver of a method. Every method should define the kernel function as the entry of the calculation. Note the return value of kernel function is not strictly defined. It can be anything related to the method (such as the energy, the wave-function, the DFT mesh grids etc.).
-
class
pyscf.adc.uadc.
UADCEA
(adc)¶ Bases:
pyscf.adc.uadc.UADC
unrestricted ADC for EA energies and spectroscopic amplitudes
- Attributes:
- verboseint
Print level. Default value equals to
Mole.verbose
- max_memoryfloat or int
Allowed memory in MB. Default value equals to
Mole.max_memory
- incore_completebool
Avoid all I/O. Default is False.
- methodstring
nth-order ADC method. Options are : ADC(2), ADC(2)-X, ADC(3). Default is ADC(2).
- conv_tolfloat
Convergence threshold for Davidson iterations. Default is 1e-12.
- max_cycleint
Number of Davidson iterations. Default is 50.
- max_spaceint
Space size to hold trial vectors for Davidson iterative diagonalization. Default is 12.
- Kwargs:
- nrootsint
Number of roots (eigenvalues) requested. Default value is 1.
>>> myadc = adc.UADC(mf).run() >>> myadcea = adc.UADC(myadc).run()
Saved results
- e_eafloat or list of floats
EA energy (eigenvalue). For nroots = 1, it is a single float number. If nroots > 1, it is a list of floats for the lowest nroots eigenvalues.
- v_iparray
Eigenvectors for each EA transition.
- p_eafloat
Spectroscopic amplitudes for each EA transition.
-
compute_trans_moments
(orb, spin='alpha')¶
-
gen_matvec
(imds=None, eris=None)¶
-
get_diag
(M_ab=None)¶
-
get_imds
(eris=None)¶
-
get_init_guess
(nroots=1, diag=None, ascending=True)¶
-
get_spec_factors
(T, U, nroots=1)¶
-
get_trans_moments
()¶
-
kernel
(nroots=1, guess=None, eris=None, verbose=None)¶ Kernel function is the main driver of a method. Every method should define the kernel function as the entry of the calculation. Note the return value of kernel function is not strictly defined. It can be anything related to the method (such as the energy, the wave-function, the DFT mesh grids etc.).
-
matvec
(M_ab=None, eris=None)¶
-
class
pyscf.adc.uadc.
UADCIP
(adc)¶ Bases:
pyscf.adc.uadc.UADC
unrestricted ADC for IP energies and spectroscopic amplitudes
- Attributes:
- verboseint
Print level. Default value equals to
Mole.verbose
- max_memoryfloat or int
Allowed memory in MB. Default value equals to
Mole.max_memory
- incore_completebool
Avoid all I/O. Default is False.
- methodstring
nth-order ADC method. Options are : ADC(2), ADC(2)-X, ADC(3). Default is ADC(2).
- conv_tolfloat
Convergence threshold for Davidson iterations. Default is 1e-12.
- max_cycleint
Number of Davidson iterations. Default is 50.
- max_spaceint
Space size to hold trial vectors for Davidson iterative diagonalization. Default is 12.
- Kwargs:
- nrootsint
Number of roots (eigenvalues) requested. Default value is 1.
>>> myadc = adc.UADC(mf).run() >>> myadcip = adc.UADC(myadc).run()
Saved results
- e_ipfloat or list of floats
IP energy (eigenvalue). For nroots = 1, it is a single float number. If nroots > 1, it is a list of floats for the lowest nroots eigenvalues.
- v_iparray
Eigenvectors for each IP transition.
- p_ipfloat
Spectroscopic amplitudes for each IP transition.
-
compute_trans_moments
(orb, spin='alpha')¶
-
gen_matvec
(imds=None, eris=None)¶
-
get_diag
(M_ij=None)¶
-
get_imds
(eris=None)¶
-
get_init_guess
(nroots=1, diag=None, ascending=True)¶
-
get_spec_factors
(T, U, nroots=1)¶
-
get_trans_moments
()¶
-
kernel
(nroots=1, guess=None, eris=None, verbose=None)¶ Kernel function is the main driver of a method. Every method should define the kernel function as the entry of the calculation. Note the return value of kernel function is not strictly defined. It can be anything related to the method (such as the energy, the wave-function, the DFT mesh grids etc.).
-
matvec
(M_ij=None, eris=None)¶
-
pyscf.adc.uadc.
compute_amplitudes
(myadc, eris)¶
-
pyscf.adc.uadc.
compute_amplitudes_energy
(myadc, eris, verbose=None)¶
-
pyscf.adc.uadc.
compute_energy
(myadc, t1, t2, eris)¶
-
pyscf.adc.uadc.
ea_adc_diag
(adc, M_ab=None)¶
-
pyscf.adc.uadc.
ea_adc_matvec
(adc, M_ab=None, eris=None)¶
-
pyscf.adc.uadc.
ea_compute_trans_moments
(adc, orb, spin='alpha')¶
-
pyscf.adc.uadc.
get_imds_ea
(adc, eris=None)¶
-
pyscf.adc.uadc.
get_imds_ip
(adc, eris=None)¶
-
pyscf.adc.uadc.
get_spec_factors
(adc, T, U, nroots=1)¶
-
pyscf.adc.uadc.
get_trans_moments
(adc)¶
-
pyscf.adc.uadc.
ip_adc_diag
(adc, M_ij=None)¶
-
pyscf.adc.uadc.
ip_adc_matvec
(adc, M_ij=None, eris=None)¶
-
pyscf.adc.uadc.
ip_compute_trans_moments
(adc, orb, spin='alpha')¶
-
pyscf.adc.uadc.
kernel
(adc, nroots=1, guess=None, eris=None, verbose=None)¶
pyscf.adc.uadc_ao2mo module¶
-
pyscf.adc.uadc_ao2mo.
transform_integrals_incore
(myadc)¶
-
pyscf.adc.uadc_ao2mo.
unpack_eri_1
(eri, norb)¶
-
pyscf.adc.uadc_ao2mo.
unpack_eri_2
(eri, norb1, norb2)¶
-
pyscf.adc.uadc_ao2mo.
unpack_eri_2s
(eri, norb)¶
Module contents¶
Algebraic Diagrammatic Construction¶
-
pyscf.adc.
ADC
(mf, frozen=None, mo_coeff=None, mo_occ=None)¶ Ground state calculations
- Attributes:
- verboseint
Print level. Default value equals to
Mole.verbose
- max_memoryfloat or int
Allowed memory in MB. Default value equals to
Mole.max_memory
- incore_completebool
Avoid all I/O. Default is False.
- methodstring
nth-order ADC method. Options are : ADC(2), ADC(2)-X, ADC(3). Default is ADC(2).
>>> mol = gto.M(atom = 'H 0 0 0; F 0 0 1.1', basis = 'ccpvdz') >>> mf = scf.RHF(mol).run() >>> myadc = adc.UADC(mf).run()
Saved results
- e_corrfloat
MPn correlation correction
- e_totfloat
Total energy (HF + correlation)
- t1, t2 :
T amplitudes t1[i,a], t2[i,j,a,b] (i,j in occ, a,b in virt)
-
pyscf.adc.
UADC
(mf, frozen=None, mo_coeff=None, mo_occ=None)¶ Ground state calculations
- Attributes:
- verboseint
Print level. Default value equals to
Mole.verbose
- max_memoryfloat or int
Allowed memory in MB. Default value equals to
Mole.max_memory
- incore_completebool
Avoid all I/O. Default is False.
- methodstring
nth-order ADC method. Options are : ADC(2), ADC(2)-X, ADC(3). Default is ADC(2).
>>> mol = gto.M(atom = 'H 0 0 0; F 0 0 1.1', basis = 'ccpvdz') >>> mf = scf.RHF(mol).run() >>> myadc = adc.UADC(mf).run()
Saved results
- e_corrfloat
MPn correlation correction
- e_totfloat
Total energy (HF + correlation)
- t1, t2 :
T amplitudes t1[i,a], t2[i,j,a,b] (i,j in occ, a,b in virt)