Procedure | Location | Procedure Type | Description |
---|---|---|---|
add_ecpder | ecp_tool | Subroutine | |
add_ecpint | ecp_tool | Subroutine | |
antisymmetrize_matrix | mathlib | Subroutine | @brief Compute |
apply_basis_C | apply_basis_mod | Subroutine | |
assignment(=) | errcode | Interface | |
atomic_structure_center | atomic_structure_m | Function | |
atomic_structure_clean | atomic_structure_m | Function | |
atomic_structure_init | atomic_structure_m | Function | |
b64_decode | base64 | Interface | |
b64_encode | base64 | Interface | |
bas_denorm_matrix | basis_tools | Interface | |
bas_norm_matrix | basis_tools | Interface | |
basis_overlap | int1 | Subroutine | @brief Compute overlap matrix between two basis sets @details Overlap integrals are computed using Gauss-Hermite quadrature formula @author Igor S. Gerasimov @date Oct, 2022 Initial release |
boysf | boys | Subroutine | |
build_pfon_density | scf | Subroutine | |
c_f_char | strings | Function | @brief Convert raw null-terminated C-string to Fortran string |
check_states_phase | get_state_overlap_mod | Subroutine | |
check_status | oqp_tagarray_driver | Subroutine | |
comp_allmult_int1_prim | mod_1e_primitives | Subroutine | @brief Compute primitive block of multipole
integrals up to an order |
comp_coulomb_dampch_int1_prim | mod_1e_primitives | Subroutine | @brief Subtract damping function term from ESP block @details Compute one-electron Coulomb integrals with the damping function: \f$ |r-r_C|^{-1} (1 - \beta e^{-\alpha(r-r_C)^2}) \f$ Only the part \f$ - |r-r_C|^{-1} \beta e^{-\alpha(r-r_C)^2}) \f$ is computed here; the other part is regular Coulomb potential computed elsewhere @param[in] cp shell pair data @param[in] id current pair of primitives @param[in] alpha dumping exponent @param[in] beta dumping function scaling factor @param[in] c coordinates of the charged particle @param[in] znuc particle charge @param[inout] vblk block of 1e Coulomb integrals @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_coulomb_der1 | mod_1e_primitives | Subroutine | @brief Compute 1e Coulomb contribution to the gradient (v.r.t. shifts of shell's centers) @param[in] nroots roots for GaussRys @param[in] cp shell pair data @param[in] c coordinates of the charged particle @param[in] znuc particle charge @param[in] dij density matrix block @param[inout] dernuc dimension(3), contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_coulomb_helfeyder1 | mod_1e_primitives | Subroutine | @brief Compute 1e Hellmann-Feynman contribution to the gradient @param[in] nroots roots for GaussRys @param[in] cp shell pair data @param[in] c coordinates of the charged particle @param[in] znuc particle charge @param[in] dij density matrix block @param[inout] derhf dimension(3), contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_coulomb_int1_prim | mod_1e_primitives | Subroutine | @brief Compute primitive block of 1e Coulomb atraction integrals @param[in] cp shell pair data @param[in] id current pair of primitives @param[in] c coordinates of the charged particle @param[in] znuc particle charge @param[inout] vblk block of 1e Coulomb integrals @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_coulpot_prim | mod_1e_primitives | Subroutine | @brief Compute sum of 1e Coulomb integrals over primitive shell pair @param[in] cp shell pair data @param[in] id current pair of primitives @param[in] c coordinates of the charged particle @param[in] den normalized density matrix block @param[inout] vsum sum of Coulomb integrals over pair of primitives @author Vladimir Mironov @date Oct, 2018 Initial release |
comp_det | get_state_overlap_mod | Function | This routine calculates the determinate of a square matrix. Gauss Elimination Method array the matrix of order norder which is to be evaluated. this subprogram destroys the matrix array norder the order of the square matrix to be evaluated. |
comp_ewaldlr_der1 | mod_1e_primitives | Subroutine | @brief Compute 1e Ewald long-range contribution to the gradient (v.r.t. shifts of shell's centers) @param[in] nroots roots for GaussRys @param[in] cp shell pair data @param[in] c coordinates of the charged particle @param[in] znuc particle charge @param[in] dij density matrix block @param[in] omega Ewald splitting parameter @param[inout] dernuc dimension(3), contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_ewaldlr_helfeyder1 | mod_1e_primitives | Subroutine | @brief Compute Ewald long-range 1e Hellmann-Feynman contribution to the gradient @param[in] nroots roots for GaussRys @param[in] cp shell pair data @param[in] c coordinates of the charged particle @param[in] znuc particle charge @param[in] dij density matrix block @param[in] omega Ewald splitting parameter @param[inout] derhf dimension(3), contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_ewaldlr_int1_prim | mod_1e_primitives | Subroutine | @brief Compute primitive block of 1e Coulomb atraction integrals for Ewald summation, long-range part @details 1e integrals using modified Coulomb potential: \f$ \frac{Erf(\omega^{1/2}|r-r_C|)}{|r-r_C|} \f$ @param[in] cp shell pair data @param[in] id current pair of primitives @param[in] c coordinates of the charged particle @param[in] znuc particle charge @param[in] omega Ewald splitting parameter @param[inout] vblk block of 1e Coulomb integrals @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_kin_ovl_int1_prim | mod_1e_primitives | Subroutine | @brief Compute primitive block of overlap and kinetic energy 1e integrals
@param[in] cp shell pair data
@param[in] id current pair of primitives
@param[in] dokinetic if |
comp_kinetic_der1 | mod_1e_primitives | Subroutine | @brief Compute 1e kinetic contribution to the gradient @param[in] cp shell pair data @param[in] dij density matrix block @param[inout] de dimension(3), contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_lz_int1_prim | mod_1e_primitives | Subroutine | @brief Compute primitive block of 1e Coulomb ESP integrals in FMO method @param[in] cp shell pair data @param[in] id current pair of primitives @param[inout] zblk block of 1e Lz-integrals @author Vladimir Mironov @date Sep, 2018 Initial release |
comp_mult_int1_prim | mod_1e_primitives | Subroutine | @brief Compute primitive block of multipole integrals of order |
comp_overlap_der1 | mod_1e_primitives | Subroutine | @brief Compute 1e overlap contribution to the gradient @param[in] cp shell pair data @param[in] dij density matrix block @param[inout] de dimension(3), contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release |
compAtGradDRho | mod_dft_gridint | Subroutine | @brief Compute XC contributions to the gradient from a grid point, GGA part @param[inout] bfGrad array of gradient contributions per basis function @param[in] fgrad XC gradient @param[in] moV MO-like orbital values @param[in] moG1 MO-like orbital gradients @author Vladimir Mironov |
compAtGradRho | mod_dft_gridint | Subroutine | @brief Compute XC contributions to the gradient from a grid point, LDA part @param[in] iPt index of a grid point @param[inout] bfGrad array of gradient contributions per basis function @param[in] fgrad XC gradient @param[in] moV MO-like orbital values @author Vladimir Mironov |
compAtGradTau | mod_dft_gridint | Subroutine | @brief Compute XC contributions to the gradient from a grid point, mGGA part @param[in] iPt index of a grid point @param[inout] bfGrad array of gradient contributinos per basis function @param[in] dedta XC energy, mGGA contribution, alpha-spin @param[in] dedtb XC energy, mGGA contribution, beta-spin @author Vladimir Mironov |
compute | mod_dft_xc_libxc | Subroutine | |
compute_first_derivs | libecpint_wrapper | Interface | |
compute_integrals | libecpint_wrapper | Interface | |
compute_states_overlap | get_state_overlap_mod | Subroutine | @brief Compute overlap integrals between MRSF response states at different MD time steps |
corresponding_orbital_projection | guess | Subroutine | @brief Corresponding orbital projection
@param[in] nproj number of orbitals from |
count_substring | strings | Function | @brief This function return count of substring in string @author Igor S. Gerasimov @date Sep, 2019 --Initial release-- @date May, 2021 Moved to strings @param substring - (in) @param string - (in) |
data_has_tags | oqp_tagarray_driver | Interface | |
density_ordered | mod_1e_primitives | Subroutine | @brief Copy density block from the triangular density matrix
@details This subroutine assumes |
density_unordered | mod_1e_primitives | Subroutine | @brief Copy density block from the triangular density matrix @details This subroutine assumes arbitrary order of shell IDs @param[in] shi first shell data @param[in] shj second shell data @param[in] dij density matrix in packed triangular form @param[out] denab density matrix block for shells shi and shj |
derexc_blk | mod_dft_gridint_grad | Subroutine | @brief Compute grid XC contribution to the nuclear gradient |
dft_fc_blk | mod_dft_fuzzycell | Subroutine | @brief Assemble numerical atomic DFT grids to a molecular grid @param[in] atmxvec array of atomic X coordinates @param[in] atmyvec array of atomic Y coordinates @param[in] atmzvec array of atomic Z coordinates @param[in] rij interatomic distances @param[in] nat number of atoms @param[in] curAt index of current atom @param[in] rad effective (e.g. Bragg-Slater) radius of current atom @param[inout] wtab normalized cell function values for LRD @param[in] aij surface shifting factors for Becke's method @author Vladimir Mironov |
dft_initialize | dft | Subroutine | |
dftclean | dft | Subroutine | |
dftder | dft | Subroutine | @brief Analytical DFT gradient |
dftexcor | dft | Subroutine | |
diag_symm_full | eigen | Subroutine | @brief Find eigenvalues and eigenvectors of symmetric matrix in full format @param[in] mode algorithm of diagonalization (not used now) @param[in] n matrix dimension @param[in,out] a matrix to be diagonalized, overwritten by the eigenvectors on the exit @param[in] lda leading dimension of the matrix @param[out] eig eigenvalues @param[out] ierr status |
diag_symm_packed | eigen | Subroutine | @brief Find eigenvalues and eigenvectors of symmetric matrix in packed format @param[in] mode algorithm of diagonalization (not used now) @param[in] n matrix dimension @param[in] ldvect leading dimension of eigenvector matrix @param[in] nvect required number of eigenvectors @param[in,out] h matrix to be diagonalized @param[out] eig eigenvalues @param[out] vector eigenvectors @param[out] ierr status |
dmatd_blk | mod_dft_gridint_energy | Subroutine | @brief Compute grid XC contribution to the Kohn-Sham matrix @param[in] coeffa MO coefficients, alpha-spin @param[in] coeffb MO coefficients, beta-spin @param[inout] fa KS matrix, alpha-spin @param[inout] fb KS matrix, beta-spin @param[out] exc XC energy @param[out] totele electronic denisty integral @param[out] totkin kinetic energy integral @param[in] mxAngMom max. needed ang. mom. value (incl. derivatives) @param[in] nbf basis set size @param[in] urohf .TRUE. if open-shell calculation @author Vladimir Mironov |
doQuadGaussHermite | mod_gauss_hermite | Subroutine | @brief Gauss-Hermite quadrature using minimum point formula @details Compute: xint = sum( w(1:npts,npts) * (h(1:npts,npts)t+dxi)(ni-1) * (h(1:npts,npts)t+dxj)(nj-1) ) yint = sum( w(1:npts,npts) * (h(1:npts,npts)*t+dyi)(ni-1) * (h(1:npts,npts)t+dyj)(nj-1) ) zint = sum( w(1:npts,npts) * (h(1:npts,npts)t+dzi)(ni-1) * (h(1:npts,npts)*t+dzj)(nj-1) ) |
e_charge_repulsion | util | Function | |
eijden | grd1 | Subroutine | @brief Compute "energy weighted density matrix" |
electric_moments | electric_moments_mod | Subroutine | |
electrostatic_potential | int1 | Subroutine | @brief Compute electronic contribution to electrostatic potential on a grid @author Vladimir Mironov @date Sep, 2023 Initial release |
errcode_t | errcode | Interface | |
esum | tdhf_lib | Subroutine | @breif Add (E_a-E_i)*Z_ai to Pmo |
f_c_char | strings | Subroutine | @brief Convert Fortran string to a raw null-terminated C-string |
fock_jk | scf | Subroutine | |
form_rohf_fock | scf | Subroutine | @brief Form the ROHF Fock matrix in MO basis. |
free_integrator | libecpint_wrapper | Interface | |
free_result | libecpint_wrapper | Interface | |
fstring | strings | Function | @brief This function return fortran allocatable string @author Igor S. Gerasimov @date April, 2022 --Initial release-- @param string - (in) C-like string |
genr22 | int2e_rotaxis | Subroutine | |
get_ab_initio_density | guess | Subroutine | @brief this will calculatte the density matrix |
get_ab_initio_orbital | guess | Subroutine | @brief Solve \f$ F C = \eps S C \f$ |
get_dcv | get_state_overlap_mod | Subroutine | @brief Compute derivative coupling vectors (DCV) using the finite difference method, typically denoted as d_IJ between states I and J. |
get_element_id | elements | Function | |
get_mrsf_transition_density | tdhf_mrsf_lib | Subroutine | |
get_mrsf_transitions | tdhf_mrsf_lib | Subroutine | |
get_radial_grid | dft_radial_grid_types | Subroutine | @brief Set the radial points and weights @param ptrad [inout] quadrature points @param wtrad [inout] quadrature weights @param rad_grid_type [in] type of radial grid @param rad_grid_type [in] which quadrature to map on the selected grid |
get_spin_square | tdhf_sf_lib | Function | |
get_state_overlap_C | get_state_overlap_mod | Subroutine | @brief C-interoperable wrapper for get_states_overlap |
get_states_overlap | get_state_overlap_mod | Subroutine | @brief Main subroutine for calculating state overlaps and derivative coupling matrix elements |
get_structures_ao_overlap | get_structures_ao_overlap_mod | Subroutine | @brief Calculate AO overlap between two different geometries @param[in,out] infos Information structure containing all necessary data |
get_structures_ao_overlap_C | get_structures_ao_overlap_mod | Subroutine | @brief C-interoperable wrapper for get_states_overlap |
get_td_transition_dipole | tdhf_energy_mod | Subroutine | |
get_trans_den | tdhf_mrsf_lib | Subroutine | |
get_transition_density | tdhf_sf_lib | Subroutine | |
get_transition_dipole | tdhf_sf_lib | Subroutine | |
get_transitions | tdhf_sf_lib | Subroutine | |
grad_1e_ecp | grd1 | Subroutine | @brief Effective core potential gradient |
grad_ee_kinetic | grd1 | Subroutine | @brief Basis function derivative contributions to gradient
@details Compute derivative integrals of type |
grad_ee_overlap | grd1 | Subroutine | @brief Compute overlap energy derivative contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release |
grad_en_hellman_feynman | grd1 | Subroutine | @brief Hellmann-Feynman force @details Compute derivative contributions due to the Hamiltonian operator change w.r.t. shifts of nuclei. The contribution of the form is evaluated by Gauss-Rys quadrature. This version handles spdfg and L shells. |
grad_en_pulay | grd1 | Subroutine | @brief Basis function derivative contributions to gradient
@details Compute derivative integrals of type |
grad_nn | grd1 | Subroutine | @brief Gradient of nuclear repulsion energy |
grd2_driver | grd2 | Subroutine | @brief The driver for the two electron gradient |
grd2_rys_compute | grd2_rys | Subroutine | |
grd2_tdhf_compute_data_t_clean | tdhf_gradient_mod | Subroutine | |
grd2_tdhf_compute_data_t_get_density | tdhf_gradient_mod | Subroutine | @brief Compute density factors for \Gamma term of 2-electron contribution to TD-DFT gradients |
grd2_tdhf_compute_data_t_init | tdhf_gradient_mod | Subroutine | |
guess_hcore | guess_hcore_mod | Subroutine | |
guess_hcore_C | guess_hcore_mod | Subroutine | |
guess_huckel | guess_huckel_mod | Subroutine | |
guess_huckel_C | guess_huckel_mod | Subroutine | |
guess_json | guess_json_mod | Subroutine | |
guess_json_C | guess_json_mod | Subroutine | |
hf_energy | hf_energy_mod | Subroutine | |
hf_gradient | hf_gradient_mod | Subroutine | |
huckel_guess | huckel | Subroutine | |
iatogen | tdhf_lib | Subroutine | |
index_ith | strings | Function | @brief This function return index of i'th substring in string @details if ind is negative, backward search will be result is equal 0 if search was failed @author Igor S. Gerasimov @date May, 2021 --Initial release-- @param substring - (in) @param string - (in) @param ith - (in) index of needed substring |
init | mod_dft_xc_libxc | Subroutine | |
init_integrator | libecpint_wrapper | Interface | |
init_integrator_instance | libecpint_wrapper | Interface | |
inivec | tdhf_lib | Subroutine | |
int1_coul | int1 | Interface | |
int1e | int1e_mod | Subroutine | @brief Calculate the basic H, S, and T 1e-integrals |
int2_mrsf_data_t_clean | tdhf_mrsf_lib | Subroutine | |
int2_mrsf_data_t_init_screen | tdhf_mrsf_lib | Subroutine | |
int2_mrsf_data_t_parallel_start | tdhf_mrsf_lib | Subroutine | |
int2_mrsf_data_t_parallel_stop | tdhf_mrsf_lib | Subroutine | |
int2_mrsf_data_t_update | tdhf_mrsf_lib | Subroutine | |
int2_rpagrd_data_t_clean | tdhf_lib | Subroutine | |
int2_rpagrd_data_t_init_screen | tdhf_lib | Subroutine | |
int2_rpagrd_data_t_parallel_start | tdhf_lib | Subroutine | |
int2_rpagrd_data_t_parallel_stop | tdhf_lib | Subroutine | |
int2_rpagrd_data_t_update | tdhf_lib | Subroutine | |
int2_rpagrd_data_t_update_hminus | tdhf_lib | Subroutine | @brief Compute H^-[V] over a set of integrals |
int2_rpagrd_data_t_update_hplus | tdhf_lib | Subroutine | @brief Compute H^+[V] over a set of integrals |
int2_rys_compute | int2e_rys | Subroutine | |
int2_td_data_t_clean | tdhf_lib | Subroutine | |
int2_td_data_t_init_screen | tdhf_lib | Subroutine | |
int2_td_data_t_parallel_start | tdhf_lib | Subroutine | |
int2_td_data_t_parallel_stop | tdhf_lib | Subroutine | |
int2_td_data_t_update | tdhf_lib | Subroutine | |
int2_tdgrd_data_t_update | tdhf_lib | Subroutine | |
ints_exchange | int2_compute | Subroutine | |
lebedev_get_grid | lebedev | Subroutine | |
libint2_build | libint_f | Subroutine | |
libint2_cleanup_eri | libint_f | Subroutine | |
libint2_init_eri | libint_f | Subroutine | |
libint2_static_cleanup | libint_f | Subroutine | |
libint2_static_init | libint_f | Subroutine | |
libint_compute_eri | int2e_libint | Subroutine | |
libint_print_eri | int2e_libint | Subroutine | |
libint_static_cleanup | int2e_libint | Subroutine | |
libint_static_init | int2e_libint | Subroutine | |
libxc_destroy | libxc | Subroutine | @brief Destroy internal variables of functional @author Igor S. Gerasimov @date Dec, 2020 - Initial release - @date Dec, 2022 Pass local functional instead of global |
libxc_input | libxc | Subroutine | @brief setting up of using libxc functionals (Analog of INPGDFT) @detail @author Igor S. Gerasimov @date July, 2019 - Initial release - @date July, 2021 Using messages module Adding optional arguments @date Dec, 2022 Pass functional instead of using global @params functional_name (in) functional's name @param infos (inout) info datatype @param functional (inout) constructing functional |
lowdin | population_analysis | Subroutine | |
matrix_invsqrt | mathlib | Subroutine | @brief Compute matrix inverse square root using SVD and removing
linear dependency
@detail This subroutine is used to obtain set of |
measure_time | util | Subroutine | |
mksphar | guess | Subroutine | @brief Generate transformation to spherical harmonics basis |
mntoia | tdhf_lib | Subroutine | |
mo_overlap | get_structures_ao_overlap_mod | Subroutine | @brief Calculate Molecular Orbital (MO) overlap between two geometries |
mo_reorder | scf | Subroutine | |
mo_to_ao | scf | Subroutine | @brief Back-transform a symmetric operator |
mo_tran_gemm_ | mod_dft_gridint | Subroutine | |
mo_tran_symm_ | mod_dft_gridint | Subroutine | |
mrinivec | tdhf_mrsf_lib | Subroutine | |
mrsf_tlf | get_state_overlap_mod | Subroutine | @brief Compute overlap integrals between CSFs of MRSF-TDDFT using TLF approximation |
mrsfcbc | tdhf_mrsf_lib | Subroutine | |
mrsfesum | tdhf_mrsf_lib | Subroutine | |
mrsfmntoia | tdhf_mrsf_lib | Subroutine | |
mrsfqroesum | tdhf_mrsf_lib | Subroutine | |
mrsfqropcal | tdhf_mrsf_lib | Subroutine | |
mrsfqrorhs | tdhf_mrsf_lib | Subroutine | |
mrsfqrowcal | tdhf_mrsf_lib | Subroutine | |
mrsfrowcal | tdhf_mrsf_lib | Subroutine | |
mrsfsp | tdhf_mrsf_lib | Subroutine | @brief Spin-pairing parts of singlet and triplet MRSF Lagrangian |
mrsfxvec | tdhf_mrsf_lib | Subroutine | @details This subroutine transforms Multi-Reference Spin-Flip (MRSF) response vectors from a compressed representation to an expanded form. It handles both singlet (mrst=1) and triplet (mrst=3) cases. |
mulliken | population_analysis | Subroutine | |
mulQuadGaussHermite | mod_gauss_hermite | Subroutine | @brief Gauss-Hermite quadrature using minimum point formula @details Compute: xint = sum( w(1:npts,npts) * (h(1:npts,npts)t+dxi)(ni-1) * (h(1:npts,npts)t+dxj)(nj-1) ) yint = sum( w(1:npts,npts) * (h(1:npts,npts)*t+dyi)(ni-1) * (h(1:npts,npts)t+dyj)(nj-1) ) zint = sum( w(1:npts,npts) * (h(1:npts,npts)t+dzi)(ni-1) * (h(1:npts,npts)*t+dzj)(nj-1) ) |
multipole_integrals | int1 | Subroutine | @brief Driver for multipole integrals @details Compute one electron multipole integrals Integrals are evaluated by Gauss-Hermite quadrature, @author Vladimir Mironov @date Feb, 2023 Initial release |
omp_hst | int1 | Subroutine | @brief Driver for conventional h, S, and T integrals @details Compute one electron integrals and core Hamiltonian, - S is evaluated by Gauss-Hermite quadrature, - T is an overlap with -2,0,+2 angular momentum shifts, - V is evaluated by Gauss-Rys quadrature, then \f$ h = T+V \f$ Also, do \f$ L_z \f$ integrals if requested |
operator(==) | errcode | Interface | |
oqp_apply_basis | apply_basis_mod | Subroutine | |
oqp_banner | oqp_banner_mod | Subroutine | |
oqp_banner_C | oqp_banner_mod | Subroutine | |
oqp_caxpy_i64 | blas_wrap | Subroutine | |
oqp_ccopy_i64 | blas_wrap | Subroutine | |
oqp_cdotc_i64 | blas_wrap | Function | |
oqp_cdotu_i64 | blas_wrap | Function | |
oqp_cgbmv_i64 | blas_wrap | Subroutine | |
oqp_cgemm_i64 | blas_wrap | Subroutine | |
oqp_cgemv_i64 | blas_wrap | Subroutine | |
oqp_cgerc_i64 | blas_wrap | Subroutine | |
oqp_cgeru_i64 | blas_wrap | Subroutine | |
oqp_chbmv_i64 | blas_wrap | Subroutine | |
oqp_chemm_i64 | blas_wrap | Subroutine | |
oqp_chemv_i64 | blas_wrap | Subroutine | |
oqp_cher2_i64 | blas_wrap | Subroutine | |
oqp_cher2k_i64 | blas_wrap | Subroutine | |
oqp_cher_i64 | blas_wrap | Subroutine | |
oqp_cherk_i64 | blas_wrap | Subroutine | |
oqp_chpmv_i64 | blas_wrap | Subroutine | |
oqp_chpr2_i64 | blas_wrap | Subroutine | |
oqp_chpr_i64 | blas_wrap | Subroutine | |
oqp_cscal_i64 | blas_wrap | Subroutine | |
oqp_csrot_i64 | blas_wrap | Subroutine | |
oqp_csscal_i64 | blas_wrap | Subroutine | |
oqp_cswap_i64 | blas_wrap | Subroutine | |
oqp_csymm_i64 | blas_wrap | Subroutine | |
oqp_csyr2k_i64 | blas_wrap | Subroutine | |
oqp_csyrk_i64 | blas_wrap | Subroutine | |
oqp_ctbmv_i64 | blas_wrap | Subroutine | |
oqp_ctbsv_i64 | blas_wrap | Subroutine | |
oqp_ctpmv_i64 | blas_wrap | Subroutine | |
oqp_ctpsv_i64 | blas_wrap | Subroutine | |
oqp_ctrmm_i64 | blas_wrap | Subroutine | |
oqp_ctrmv_i64 | blas_wrap | Subroutine | |
oqp_ctrsm_i64 | blas_wrap | Subroutine | |
oqp_ctrsv_i64 | blas_wrap | Subroutine | |
oqp_dasum_i64 | blas_wrap | Function | |
oqp_daxpy_i64 | blas_wrap | Subroutine | |
oqp_dcopy_i64 | blas_wrap | Subroutine | |
oqp_ddot_i64 | blas_wrap | Function | |
oqp_dgbmv_i64 | blas_wrap | Subroutine | |
oqp_dgemm_i64 | blas_wrap | Subroutine | |
oqp_dgemv_i64 | blas_wrap | Subroutine | |
oqp_dgeqrf_i64 | lapack_wrap | Subroutine | |
oqp_dger_i64 | blas_wrap | Subroutine | |
oqp_dgesv_i64 | lapack_wrap | Subroutine | |
oqp_dgetri_i64 | lapack_wrap | Subroutine | Compute the inverse of a real matrix using LAPACK routine dgetri. |
oqp_dgglse_i64 | lapack_wrap | Subroutine | |
oqp_dnrm2_i64 | blas_wrap | Function | |
oqp_dorgqr_i64 | lapack_wrap | Subroutine | |
oqp_dormqr_i64 | lapack_wrap | Subroutine | |
oqp_drot_i64 | blas_wrap | Subroutine | |
oqp_drotm_i64 | blas_wrap | Subroutine | |
oqp_dsbmv_i64 | blas_wrap | Subroutine | |
oqp_dscal_i64 | blas_wrap | Subroutine | |
oqp_dsdot_i64 | blas_wrap | Function | |
oqp_dspmv_i64 | blas_wrap | Subroutine | |
oqp_dspr2_i64 | blas_wrap | Subroutine | |
oqp_dspr_i64 | blas_wrap | Subroutine | |
oqp_dswap_i64 | blas_wrap | Subroutine | |
oqp_dsymm_i64 | blas_wrap | Subroutine | |
oqp_dsymv_i64 | blas_wrap | Subroutine | |
oqp_dsyr2_i64 | blas_wrap | Subroutine | |
oqp_dsyr2k_i64 | blas_wrap | Subroutine | |
oqp_dsyr_i64 | blas_wrap | Subroutine | |
oqp_dsyrk_i64 | blas_wrap | Subroutine | |
oqp_dsysv_i64 | lapack_wrap | Subroutine | |
oqp_dtbmv_i64 | blas_wrap | Subroutine | |
oqp_dtbsv_i64 | blas_wrap | Subroutine | |
oqp_dtpmv_i64 | blas_wrap | Subroutine | |
oqp_dtpsv_i64 | blas_wrap | Subroutine | |
oqp_dtpttr_i64 | lapack_wrap | Subroutine | |
oqp_dtrmm_i64 | blas_wrap | Subroutine | |
oqp_dtrmv_i64 | blas_wrap | Subroutine | |
oqp_dtrsm_i64 | blas_wrap | Subroutine | |
oqp_dtrsv_i64 | blas_wrap | Subroutine | |
oqp_dtrttp_i64 | lapack_wrap | Subroutine | |
oqp_dzasum_i64 | blas_wrap | Function | |
oqp_dznrm2_i64 | blas_wrap | Function | |
oqp_handle_get_info | c_interop | Interface | |
oqp_handle_refresh_ptr | c_interop | Subroutine | |
oqp_icamax_i64 | blas_wrap | Function | |
oqp_idamax_i64 | blas_wrap | Function | |
oqp_init | c_interop | Function | |
oqp_isamax_i64 | blas_wrap | Function | |
oqp_izamax_i64 | blas_wrap | Function | |
oqp_resp_charges | resp_mod | Subroutine | @brief Compute ESP charges fitted by modified Merz-Kollman method |
oqp_sasum_i64 | blas_wrap | Function | |
oqp_saxpy_i64 | blas_wrap | Subroutine | |
oqp_scasum_i64 | blas_wrap | Function | |
oqp_scnrm2_i64 | blas_wrap | Function | |
oqp_scopy_i64 | blas_wrap | Subroutine | |
oqp_sdot_i64 | blas_wrap | Function | |
oqp_sdsdot_i64 | blas_wrap | Function | |
oqp_sgbmv_i64 | blas_wrap | Subroutine | |
oqp_sgemm_i64 | blas_wrap | Subroutine | |
oqp_sgemv_i64 | blas_wrap | Subroutine | |
oqp_sger_i64 | blas_wrap | Subroutine | |
oqp_snrm2_i64 | blas_wrap | Function | |
oqp_srot_i64 | blas_wrap | Subroutine | |
oqp_srotm_i64 | blas_wrap | Subroutine | |
oqp_ssbmv_i64 | blas_wrap | Subroutine | |
oqp_sscal_i64 | blas_wrap | Subroutine | |
oqp_sspmv_i64 | blas_wrap | Subroutine | |
oqp_sspr2_i64 | blas_wrap | Subroutine | |
oqp_sspr_i64 | blas_wrap | Subroutine | |
oqp_sswap_i64 | blas_wrap | Subroutine | |
oqp_ssymm_i64 | blas_wrap | Subroutine | |
oqp_ssymv_i64 | blas_wrap | Subroutine | |
oqp_ssyr2_i64 | blas_wrap | Subroutine | |
oqp_ssyr2k_i64 | blas_wrap | Subroutine | |
oqp_ssyr_i64 | blas_wrap | Subroutine | |
oqp_ssyrk_i64 | blas_wrap | Subroutine | |
oqp_stbmv_i64 | blas_wrap | Subroutine | |
oqp_stbsv_i64 | blas_wrap | Subroutine | |
oqp_stpmv_i64 | blas_wrap | Subroutine | |
oqp_stpsv_i64 | blas_wrap | Subroutine | |
oqp_strmm_i64 | blas_wrap | Subroutine | |
oqp_strmv_i64 | blas_wrap | Subroutine | |
oqp_strsm_i64 | blas_wrap | Subroutine | |
oqp_strsv_i64 | blas_wrap | Subroutine | |
oqp_tdhf_z_vector | tdhf_z_vector_mod | Subroutine | |
oqp_xerbla_i64 | blas_wrap | Subroutine | |
oqp_zaxpy_i64 | blas_wrap | Subroutine | |
oqp_zcopy_i64 | blas_wrap | Subroutine | |
oqp_zdotc_i64 | blas_wrap | Function | |
oqp_zdotu_i64 | blas_wrap | Function | |
oqp_zdrot_i64 | blas_wrap | Subroutine | |
oqp_zdscal_i64 | blas_wrap | Subroutine | |
oqp_zgbmv_i64 | blas_wrap | Subroutine | |
oqp_zgemm_i64 | blas_wrap | Subroutine | |
oqp_zgemv_i64 | blas_wrap | Subroutine | |
oqp_zgerc_i64 | blas_wrap | Subroutine | |
oqp_zgeru_i64 | blas_wrap | Subroutine | |
oqp_zhbmv_i64 | blas_wrap | Subroutine | |
oqp_zhemm_i64 | blas_wrap | Subroutine | |
oqp_zhemv_i64 | blas_wrap | Subroutine | |
oqp_zher2_i64 | blas_wrap | Subroutine | |
oqp_zher2k_i64 | blas_wrap | Subroutine | |
oqp_zher_i64 | blas_wrap | Subroutine | |
oqp_zherk_i64 | blas_wrap | Subroutine | |
oqp_zhpmv_i64 | blas_wrap | Subroutine | |
oqp_zhpr2_i64 | blas_wrap | Subroutine | |
oqp_zhpr_i64 | blas_wrap | Subroutine | |
oqp_zscal_i64 | blas_wrap | Subroutine | |
oqp_zswap_i64 | blas_wrap | Subroutine | |
oqp_zsymm_i64 | blas_wrap | Subroutine | |
oqp_zsyr2k_i64 | blas_wrap | Subroutine | |
oqp_zsyrk_i64 | blas_wrap | Subroutine | |
oqp_ztbmv_i64 | blas_wrap | Subroutine | |
oqp_ztbsv_i64 | blas_wrap | Subroutine | |
oqp_ztpmv_i64 | blas_wrap | Subroutine | |
oqp_ztpsv_i64 | blas_wrap | Subroutine | |
oqp_ztrmm_i64 | blas_wrap | Subroutine | |
oqp_ztrmv_i64 | blas_wrap | Subroutine | |
oqp_ztrsm_i64 | blas_wrap | Subroutine | |
oqp_ztrsv_i64 | blas_wrap | Subroutine | |
orb_to_dens | mathlib | Subroutine | @brief Compute density matrix from a set of orbitals and respective occupation numbers
@detail Compute the transformation: D = V * X * V^T
@param[out] d density matrix
@param[in] v matrix of orbitals
@param[in] x vector of occupation numbers
@param[in] m number of columns in |
orthogonal_transform | mathlib | Subroutine | @brief Compute orthogonal transformation of a square marix @param[in] trans If trans='n' compute B = U^T * A * U If trans='t' compute B = U * A * U^T @param[in] ld Dimension of matrices @param[in] u Square orthogonal matrix @param[inout] a Matrix to transform, optionally output matrix @param[out] b Result, can be absent for in-place transform of matrix A @param[inout] wrk Scratch space, optional @author Vladimir Mironov |
orthogonal_transform2 | mathlib | Subroutine | @brief Compute orthogonal transformation of a square marix @param[in] trans If trans='n' compute B = U^T * A * U If trans='t' compute B = U * A * U^T @param[in] ld Dimension of matrices @param[in] u Square orthogonal matrix @param[in] a Matrix to transform @param[out] b Result @param[inout] wrk Scratch space @author Vladimir Mironov |
orthogonal_transform_sym | mathlib | Subroutine | @brief Compute orthogonal transformation of a symmetric marix A in packed format: B = U^T * A * U @param[in] a Matrix to transform @param[in] u Orthogonal matrix U(ldu,m) @param[in] n dimension of matrix A @param[in] m dimension of matrix B @param[in] ldu leading dimension of matrix U @param[out] b Result @param[inout] wrk Scratch space @author Vladimir Mironov |
ov_exact | get_state_overlap_mod | Subroutine | |
overlap | int1 | Subroutine | @brief Compute overlap and integrals @details Overlap integrals are computed using Gauss-Hermite quadrature formula @author Vladimir Mironov @date Mar, 2023 Initial release |
PACK_F90 | mathlib | Subroutine | @brief Fortran-90 routine for packing symmetric matrix to 1D array |
pack_matrix | mathlib | Interface | |
pcg_matvec | pcg_mod | Interface | |
pcg_optimize | pcg_mod | Subroutine | |
pcgb | tdhf_sf_lib | Subroutine | |
pcgrbpini | tdhf_sf_lib | Subroutine | |
pfon_occupations | scf | Subroutine | @brief pFON Implementation in SCF Module Author: Alireza Lashkaripour Date: January 2025 Reference paper: https://doi.org/10.1063/1.478177 This subroutine incorporates the Partial Fractional Occupation Number (pFON) method into SCF calculations, ensuring smooth occupation numbers using Fermi-Dirac distribution. It dynamically adjusts temperature and beta factors to enhance SCF convergence, particularly for near-degenerate states. |
print_eigvec_vals_labeled | printing | Subroutine | @brief print eigenvector/values, with MO symmetry labels |
print_ev_sol | printing | Subroutine | @brief Print the solution of the eigenvalue problem
@param[in] v matrix of eigenvectors, v(ldv,m)
@param[in] e array of eigenvectors, e(m)
@param[in] m dimension of column space
@param[in] n dimension of row space
@param[in] ldv leading dimension of |
print_geo | get_structures_ao_overlap_mod | Subroutine | @brief Print geometry information |
print_gradient | grd1 | Subroutine | @brief Print energy gradient vector |
print_mo_range | printing | Subroutine | @brief Printing out MOs |
print_module_info | printing | Subroutine | @brief Print MODULE information @detail Printout the information of each MODULES of OQP |
print_nac | get_state_overlap_mod | Subroutine | |
print_results | get_structures_ao_overlap_mod | Subroutine | @brief Print results of MO overlap between two geometries |
print_results | tdhf_sf_lib | Subroutine | |
print_scf_energy | scf | Subroutine | |
print_square | printing | Subroutine | @brief Print out a square matrix
@param[in] v rectanbular matrix
@param[in] m number of columns in |
print_sym | printing | Subroutine | @brief Print symmetric matrix |
print_sym_labeled | printing | Subroutine | @brief Print symmetric packed matrix |
print_sympack | printing | Subroutine | @brief Print out a symmetric matrix in packed format @param[in] d symmetric matrix in packed format @param[in] n matric dimension |
prune_basis | mod_dft_fuzzycell | Subroutine | @brief Find shells and primitives which are significant in a given set of 3D coordinates @author Vladimir Mironov |
remove_spaces | strings | Subroutine | @brief This routine remove not needed spaces from section line @detail This routine used revert reading of lines. Example, that this routine do: > DFTTYP = PBE0 BASNAM=APC4 , ACC5 < DFTTYP=PBE0 BASNAM=APC4,ACC5 @author Igor S. Gerasimov @date Sep, 2019 --Initial release-- @date May, 2021 Moved to strings @param line - (inout) worked line |
reordermos | scf | Subroutine | @brief This routine reorders orbitals to maximum overlap. |
resp_charges_C | resp_mod | Subroutine | @brief Compute ESP charges fitted by modified Merz-Kollman method @details This is a C interface for a Fortran subroutine |
rpaechk | tdhf_lib | Subroutine | @brief Remove negative eigenvalues |
rpaeig | tdhf_lib | Subroutine | @brief Diagonalize small reduced RPA matrix |
rpaexpndv | tdhf_lib | Subroutine | @brief Expand reduced vectors to real size space |
rpanewb | tdhf_lib | Subroutine | @brief Orthonormalize q(xvec_dim,ndsr*2) and append to bvec |
rpaprint | tdhf_lib | Subroutine | @brief Print current excitation energies and errors |
rparedms | tdhf_lib | Subroutine | |
rparesvec | tdhf_lib | Subroutine | @brief Construct residual vectors and check convergence |
rpavnorm | tdhf_lib | Subroutine | @brief Normalize |
run_population_analysis | population_analysis | Subroutine | @brief Run population analysis |
run_xc | mod_dft_gridint | Subroutine | |
rys_print_eri | int2e_rys | Subroutine | |
scf_driver | scf | Subroutine | |
schmd | eigen | Subroutine | |
set_bragg_slater | bragg_slater_radii | Subroutine | |
set_ecp_basis | libecpint_wrapper | Interface | |
setPts | mod_dft_xc_libxc | Subroutine | |
sfdmat | tdhf_sf_lib | Subroutine | |
sfesum | tdhf_sf_lib | Subroutine | |
sfqvec | tdhf_sf_lib | Subroutine | |
sfresvec | tdhf_sf_lib | Subroutine | |
sfroesum | tdhf_sf_lib | Subroutine | |
sfrogen | tdhf_sf_lib | Subroutine | |
sfrolhs | tdhf_sf_lib | Subroutine | |
sfromcal | tdhf_sf_lib | Subroutine | |
sfropcal | tdhf_sf_lib | Subroutine | |
sfrorhs | tdhf_sf_lib | Subroutine | |
sfrowcal | tdhf_sf_lib | Subroutine | |
shell_den_screen_mrsf | tdhf_mrsf_lib | Subroutine | |
shlrpagrd | tdhf_lib | Subroutine | |
shltd | tdhf_lib | Subroutine | |
show_message | messages | Interface | |
solve_linear_equations | mathlib | Subroutine | @brief Compute the solution to a real system of linear equations A * X = B @detai Wrapper for DSYSV from Lapack @param[in,out] A general matrix, destroyed on exit. @param[in,out] B RHS on entry. The solution on exit. @param[in] n size of the problem. @param[in] nrhs number of RHS vectors @param[in] lda leading dimension of matrix A @param[out] ierr Error flag, ierr=0 if no errors. Read DSYEV manual for details |
symmetrize_matrices | tdhf_lib | Subroutine | |
symmetrize_matrix | mathlib | Subroutine | @brief Compute |
tagarray_get_cptr | oqp_tagarray_driver | Function | |
tagarray_get_data | oqp_tagarray_driver | Interface | |
td_print_results | tdhf_energy_mod | Subroutine | |
tddft_fxc | mod_dft_gridint_fxc | Subroutine | @brief Compute derivative XC contribution to the TD-DFT KS-like matrices @param[in] basis basis set @param[in] isVecs .true. if orbitals are provided instead of density matrix @param[in] wf density matrix/orbitals @param[inout] fx fock-like matrices @param[inout] dx densities @param[in] nMtx number of density/Fock-like matrices @param[in] threshold tolerance @param[in] infos OQP metadata @author Vladimir Mironov |
tddft_gxc | mod_dft_gridint_gxc | Subroutine | @brief Compute derivative XC contribution to the TD-DFT KS-like matrices @param[in] basis basis set @param[in] isVecs .true. if orbitals are provided instead of density matrix @param[in] wf density matrix/orbitals @param[inout] fx fock-like matrices @param[inout] dx densities @param[in] nMtx number of density/Fock-like matrices @param[in] threshold tolerance @param[in] infos OQP metadata @author Vladimir Mironov |
tddft_xc_gradient | mod_dft_gridint_tdxc_grad | Subroutine | @brief Compute derivative XC contribution to the TD-DFT KS-like matrices @param[in] basis basis set @param[in] wf density matrix/orbitals @param[inout] fx fock-like matrices @param[inout] dx densities @param[in] nMtx number of density/Fock-like matrices @param[in] threshold tolerance @param[in] isGGA .TRUE. if GGA/mGGA functional used @param[in] infos OQP metadata @author Vladimir Mironov |
tdhf_1e_grad | tdhf_gradient_mod | Subroutine | |
tdhf_2e_grad | tdhf_gradient_mod | Subroutine | @brief The driver for the two electron gradient |
tdhf_energy | tdhf_energy_mod | Subroutine | |
tdhf_energy_C | tdhf_energy_mod | Subroutine | |
tdhf_gradient | tdhf_gradient_mod | Subroutine | |
tdhf_gradient_C | tdhf_gradient_mod | Subroutine | |
tdhf_mrsf_energy | tdhf_mrsf_energy_mod | Subroutine | |
tdhf_mrsf_energy_C | tdhf_mrsf_energy_mod | Subroutine | |
tdhf_sf_energy | tdhf_sf_energy_mod | Subroutine | |
tdhf_sf_energy_C | tdhf_sf_energy_mod | Subroutine | |
tdhf_unrelaxed_density | tdhf_lib | Subroutine | @brief Compute unrelaxed difference density matrix for R-TDDFT |
tdhf_z_vector_C | tdhf_z_vector_mod | Subroutine | |
tlf_exp | get_state_overlap_mod | Subroutine | |
to_lower | strings | Function | @brief return string in lower case @author Igor S. Gerasimov @date Sep, 2021 --Initial release-- @param line - (inout) |
to_upper | strings | Function | @brief return string in upper case @author Igor S. Gerasimov @date Sep, 2019 --Initial release-- @date May, 2021 Moved to strings @date Sep, 2021 subroutine -> function @param line - (in) |
traceprod_sym_packed | mathlib | Function | @brief Compute the trace of the product of two symmetric matrices in packed format
@detail The trace is actually an inner product of matrices, assuming they are vectors
@param[in] a first matrix
@param[in] b second matrix
@param[in] n dimension of matrices |
trfrmb | tdhf_sf_lib | Subroutine | |
triangular_to_full | mathlib | Subroutine | @brief Fill the upper/lower triangle of the symmetric matrix
@param[inout] a square NxN matrix in triangular form
@param[in] n matrix dimension
@param[in] uplo U if |
UNPACK_F90 | mathlib | Subroutine | @brief Fortran-90 routine for unpacking 1D array to symmetric matrix |
unpack_matrix | mathlib | Interface | |
update_rectangular_matrix | mod_1e_primitives | Subroutine | @brief Add contribution of the 1e-integral block to the rectangular matrix @param[in] shi first shell data @param[in] shj second shell data @param[in] mblk square block of 1e integrals passed as 1D array @param[inout] m rectangular matrix of 1-e integral contribution @author Igor S. Gerasimov @date Oct, 2022 Initial release |
update_triang_matrix | mod_1e_primitives | Subroutine | @brief Add contribution of the 1e-integral block to the triangular matrix @param[in] shi first shell data @param[in] shj second shell data @param[in] mblk square block of 1e integrals passed as 1D array @param[inout] m packed triangular matrix of 1e integral contribution @author Vladimir Mironov @date Sep, 2018 Initial release |
utddft_fxc | mod_dft_gridint_fxc | Subroutine | @brief Compute derivative XC contribution to the TD-DFT KS-like matrices @param[in] basis basis set @param[in] isVecs .true. if orbitals are provided instead of density matrix @param[in] wf density matrix/orbitals @param[inout] fx fock-like matrices @param[inout] dx densities @param[in] nMtx number of density/Fock-like matrices @param[in] threshold tolerance @param[in] isGGA .TRUE. if GGA/mGGA functional used @param[in] infos OQP metadata @author Vladimir Mironov |
utddft_xc_gradient | mod_dft_gridint_tdxc_grad | Subroutine | @brief Compute derivative XC contribution to the TD-DFT KS-like matrices @param[in] basis basis set @param[in] wf density matrix/orbitals @param[inout] fx fock-like matrices @param[inout] dx densities @param[in] nMtx number of density/Fock-like matrices @param[in] threshold tolerance @param[in] isGGA .TRUE. if GGA/mGGA functional used @param[in] infos OQP metadata @author Vladimir Mironov |
xc_der1 | mod_dft_gridint | Subroutine | @brief Get first derivative of the XC functional @param[in] xce XC engine @param[in] beta Whether to return spin-polarized quantities @param[out] d_r dE_xc / d_rho (alpha, beta) @param[out] d_s dE_xc / d_sigma (alpha-alpha, beta-beta, alpha-beta) @param[out] d_t dE_xc / d_tau (alpha, beta) |
xc_der2_contr | mod_dft_gridint | Subroutine | @brief Get second derivative of the XC functional contracted with response densities @param[in] xce XC engine @param[in] beta Whether to return spin-polarized quantities @param[in] d_r \delta_rho (alpha, beta) @param[in] d_s \delta_sigma (alpha-alpha, beta-beta, alpha-beta) @param[in] d_t \delta_tau (alpha, beta) @param[out] f_r \sum_i d2E_xc / (d_rho * d_zeta_i) (alpha, beta) @param[out] f_s \sum_i d2E_xc / (d_sigma * d_zeta_i) (alpha-alpha, beta-beta, alpha-beta) @param[out] f_t \sum_i d2E_xc / (d_tau * d_zeta_i) (alpha, beta) |
xc_der3_contr | mod_dft_gridint | Subroutine | @brief Get third derivative of the XC functional contracted with response densities, spin-polarized version @param[in] xce XC engine @param[in] d_r \delta_rho (alpha, beta) @param[in] d_s \delta_sigma (alpha-alpha, beta-beta, alpha-beta) @param[in] d_t \delta_tau (alpha, beta) @param[in] ss (\nabla\rho(T)\nabla\rho(T)) (alpha-alpha, beta-beta, alpha-beta) @param[out] g_r \sum_i,j d2E_xc / (d_rho * d_zeta_id_zeta_j) (alpha, beta) @param[out] g_s \sum_i,j d2E_xc / (d_sigma * d_zeta_id_zeta_j) (alpha-alpha, beta-beta, alpha-beta) @param[out] g_t \sum_i,j d2E_xc / (d_tau * d_zeta_id_zeta_j) (alpha, beta) |