wavefunction_analysis.polariton package
Submodules
wavefunction_analysis.polariton.condensate module
wavefunction_analysis.polariton.greens_func module
- density_of_states_e(g0, gc, coupling)[source]
density of states of the polariton states # sigma[0] and sigma[1] are the real and imaginary parts, respectively # omega is the photon energy # eta is a small phenomenological parameter
- density_of_states_p(x, sigma, omega, width=0.0001)[source]
density of states of the polariton states # sigma[0] and sigma[1] are the real and imaginary parts, respectively # omega is the photon energy # eta is a small phenomenological parameter
- greens_func_e0_gauss(x, center, width=0.0001, scaling=1.0, itype='both', appro=False)[source]
Greens function of the unperturbed exciton states disordered state energy spectrum has Gaussian distribution
- greens_func_e0_lorentz(x, center, width=0.0001, scaling=1.0, itype='both')[source]
Greens function of the unperturbed exciton states disordered state energy spectrum has Lorentzian distribution # width is a small phenomenological parameter
- greens_func_p(x, sigma, omega, width=0.0001, itype='both')[source]
Greens function of the polariton states # sigma[0] and sigma[1] are the real and imaginary parts, respectively # omega is the photon energy # eta is a small phenomenological parameter
wavefunction_analysis.polariton.qed_ks module
- get_multipole_matrix(mol, itype='dipole', dipole=None, quadrupole=None, c_lambda=None, origin=None)[source]
c_lambda: (n_mode, 3) = coupling_strength * sqrt(2.*photon_frequency)
- get_scaled_lambda(c_lambda, frequency, photon_coeff=1.0)[source]
return frequency-scaled coupling strength (c_lambda)
- class polariton(mol, xc='LDA,VWN')[source]
Bases:
RKSQED-RKS ground state, independent of photon frequency
- class polariton_cs(mol, xc='LDA,VWN')[source]
Bases:
polaritonin photon coherent states
- Gradients(*args, **kwargs)
Non-relativistic restricted Hartree-Fock gradients
- Hessian(*args, **kwargs)
Non-relativistic RKS hessian
- energy_elec(dm=None, h1e=None, vhf=None)[source]
Electronic part of RKS energy.
Note this function has side effects which cause mf.scf_summary updated.
- Parameters:
ks – an instance of DFT class
dm – 2D ndarray one-particle density matrix
h1e – 2D ndarray Core hamiltonian
- Returns:
RKS electronic energy and the 2-electron contribution
- gen_response(*args, **kwargs)[source]
Generate a function to compute the product of RHF response function and RHF density matrices.
- Kwargs:
- singlet (None or boolean)If singlet is None, response function for
orbital hessian or CPHF will be generated. If singlet is boolean, it is used in TDDFT response kernel.
- get_veff(mol=None, dm=None, *args, **kwargs)[source]
Coulomb + XC functional
Note
This function will modify the input ks object.
- Parameters:
ks – an instance of
RKSXC functional are controlled by ks.xc attribute. Attribute ks.grids might be initialized.dm – ndarray or list of ndarrays A density matrix or a list of density matrices
- Kwargs:
- dm_lastndarray or a list of ndarrays or 0
The density matrix baseline. If not 0, this function computes the increment of HF potential w.r.t. the reference HF potential matrix.
- vhf_lastndarray or a list of ndarrays or 0
The reference Vxc potential matrix.
- hermiint
Whether J, K matrix is hermitian
0 : no hermitian or symmetric1 : hermitian2 : anti-hermitian
- Returns:
matrix Veff = J + Vxc. Veff can be a list matrices, if the input dm is a list of density matrices.
- class polariton_ns(mol, xc='LDA,VWN')[source]
Bases:
polaritonin photon number states, not recommended!
- Gradients(*args, **kwargs)
Non-relativistic restricted Hartree-Fock gradients
- energy_elec(dm=None, h1e=None, vhf=None)[source]
Electronic part of RKS energy.
Note this function has side effects which cause mf.scf_summary updated.
- Parameters:
ks – an instance of DFT class
dm – 2D ndarray one-particle density matrix
h1e – 2D ndarray Core hamiltonian
- Returns:
RKS electronic energy and the 2-electron contribution
- get_veff(mol=None, dm=None, *args, **kwargs)[source]
Coulomb + XC functional
Note
This function will modify the input ks object.
- Parameters:
ks – an instance of
RKSXC functional are controlled by ks.xc attribute. Attribute ks.grids might be initialized.dm – ndarray or list of ndarrays A density matrix or a list of density matrices
- Kwargs:
- dm_lastndarray or a list of ndarrays or 0
The density matrix baseline. If not 0, this function computes the increment of HF potential w.r.t. the reference HF potential matrix.
- vhf_lastndarray or a list of ndarrays or 0
The reference Vxc potential matrix.
- hermiint
Whether J, K matrix is hermitian
0 : no hermitian or symmetric1 : hermitian2 : anti-hermitian
- Returns:
matrix Veff = J + Vxc. Veff can be a list matrices, if the input dm is a list of density matrices.
wavefunction_analysis.polariton.qed_ks_grad module
wavefunction_analysis.polariton.qed_ks_hess module
- class Hessian(mf)[source]
Bases:
Hessian- make_h1(mo_coeff, mo_occ, chkfile=None, atmlst=None, verbose=None)
- partial_hess_elec(mo_energy=None, mo_coeff=None, mo_occ=None, atmlst=None, max_memory=4000, verbose=None)
- get_multipole_matrix_d2(mol, c_lambda, origin=None)[source]
second-order analytic derivative of the multipole integrals are not implemented