Procedures

ProcedureLocationProcedure TypeDescription
add_ecpder ecp_tool Subroutine
add_ecpint ecp_tool Subroutine
antisymmetrize_matrix mathlib Subroutine

@brief Compute A = A - A^T of a square matrix @param[inout] a square NxN matrix @param[in] n matrix dimension

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

Read more…
boysf boys Subroutine
build_pfon_density scf Subroutine
c_f_char strings Function

@brief Convert raw null-terminated C-string to Fortran string

Read more…
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 MXMOM @param[in] cp shell pair data @param[in] id current pair of primitives @param[in] r point in space to compute integrals @param[in] mxmom multiplole moment order (1-dipole, 2-quadrupole, 3-octopole) @param[inout] blk block of 1e multipole moment integrals @author Vladimir Mironov @date Sep, 2018 Initial release

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 .FALSE. compute only overlap integrals @param[inout] sblk block of 1e overlap integrals @param[inout] tblk block of 1e kinetic energy integrals @author Vladimir Mironov @date Sep, 2018 Initial release

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 MOM @param[in] cp shell pair data @param[in] id current pair of primitives @param[in] r point in space to compute integrals @param[in] mom multiplole moment order (1-dipole, 2-quadrupole, 3-octopole) @param[inout] blk block of 1e multipole moment integrals @author Vladimir Mironov @date Sep, 2018 Initial release

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

Read more…
corresponding_orbital_projection guess Subroutine

@brief Corresponding orbital projection @param[in] nproj number of orbitals from vb to projected onto @param[in] l0 number of the first orbitals from the va space to project vb to @param[in,out] va a orbitals on entry, replaced by corresponding orbitals on exit @param[in] vb b orbitals on entry, unchanged on exit @param[in] sba overlap integrals between the two bases,

Read more…
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 shi%shid>=shj%shid @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

Read more…
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

Read more…
derexc_blk mod_dft_gridint_grad Subroutine

@brief Compute grid XC contribution to the nuclear gradient

Read more…
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) )

Read more…
e_charge_repulsion util Function
eijden grd1 Subroutine

@brief Compute "energy weighted density matrix"

Read more…
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

Read more…
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

Read more…
fock_jk scf Subroutine
form_rohf_fock scf Subroutine

@brief Form the ROHF Fock matrix in MO basis.

Read more…
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.

Read more…
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

Read more…
get_states_overlap get_state_overlap_mod Subroutine

@brief Main subroutine for calculating state overlaps and derivative coupling matrix elements

Read more…
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

Read more…
get_structures_ao_overlap_C get_structures_ao_overlap_mod Subroutine

@brief C-interoperable wrapper for get_states_overlap

Read more…
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 =

Read more…
grad_ee_overlap grd1 Subroutine

@brief Compute overlap energy derivative contribution to gradient @author Vladimir Mironov @date Sep, 2018 Initial release

Read more…
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.

Read more…
grad_en_pulay grd1 Subroutine

@brief Basis function derivative contributions to gradient @details Compute derivative integrals of type =

Read more…
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 canonical orbitals by diagonalization of the basis set overlap matrix Q = S^{-1/2}, Q^T * S * Q = I @param[in] s Overlap matrix, symmetric packed format @param[out] q Matrix inverse square root, square matrix @param[in] nbf Dimeension of matrices S and Q, basis set size @param[out] qrnk Rank of matrix Q @param[in] tol optional, tolerance to remove linear dependency, default = 1.0e-8

measure_time util Subroutine
mksphar guess Subroutine

@brief Generate transformation to spherical harmonics basis

Read more…
mntoia tdhf_lib Subroutine
mo_overlap get_structures_ao_overlap_mod Subroutine

@brief Calculate Molecular Orbital (MO) overlap between two geometries

Read more…
mo_reorder scf Subroutine
mo_to_ao scf Subroutine

@brief Back-transform a symmetric operator Fmo expressed in the MO basis V to the AO basis @detail compute the transformation: Fao = S*V * Fmo * (SV)^T

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

Read more…
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.

Read more…
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) )

Read more…
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

Read more…
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

Read more…
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

Read more…
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 V @param[in] n dimension of D @param[in] ldv leading dimension of V

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

Read more…
PACK_F90 mathlib Subroutine

@brief Fortran-90 routine for packing symmetric matrix to 1D array

Read more…
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 V

print_geo get_structures_ao_overlap_mod Subroutine

@brief Print geometry information

Read more…
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

Read more…
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 V @param[in] n number of rows in V @param[in] ndim leading dimension of V @param[in] tag optional, will be printed at the beginning of each line @param[in] maxcolumns optional, number of columns to wrap printing

print_sym printing Subroutine

@brief Print symmetric matrix D in square format @param[in] d matrix to print, only lower triangle is referenced @param[in] n rank of matrix D @param[in] ld leading dimension of matrix D

print_sym_labeled printing Subroutine

@brief Print symmetric packed matrix d of dimension n @detail The rows will be labeled with basis function tags

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

Read more…
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 V1 and V2 by biorthogonality condition

run_population_analysis population_analysis Subroutine

@brief Run population analysis

Read more…
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 A = A + A^T of a square matrix @param[inout] a square NxN matrix @param[in] n matrix dimension

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 A and B

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 A is upper triangular, L if lower triangular

UNPACK_F90 mathlib Subroutine

@brief Fortran-90 routine for unpacking 1D array to symmetric matrix

Read more…
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)

call~~graph~~CallGraph interface~assignment(=) assignment(=) interface~b64_decode b64_decode interface~b64_encode b64_encode interface~bas_denorm_matrix bas_denorm_matrix interface~bas_norm_matrix bas_norm_matrix interface~compute_first_derivs compute_first_derivs interface~compute_integrals compute_integrals interface~data_has_tags data_has_tags interface~errcode_t errcode_t interface~free_integrator free_integrator interface~free_result free_result interface~init_integrator init_integrator interface~init_integrator_instance init_integrator_instance interface~int1_coul int1_coul interface~operator(==) operator(==) interface~oqp_handle_get_info oqp_handle_get_info interface~pack_matrix pack_matrix proc~pack_f90 PACK_F90 interface~pack_matrix->proc~pack_f90 interface~pcg_matvec pcg_matvec interface~set_ecp_basis set_ecp_basis interface~show_message show_message interface~tagarray_get_data tagarray_get_data interface~unpack_matrix unpack_matrix proc~unpack_f90 UNPACK_F90 interface~unpack_matrix->proc~unpack_f90 none~allreduce par_env_t%allreduce none~par_env_t_allreduce_byte par_env_t%par_env_t_allreduce_byte none~allreduce->none~par_env_t_allreduce_byte none~par_env_t_allreduce_c_bool par_env_t%par_env_t_allreduce_c_bool none~allreduce->none~par_env_t_allreduce_c_bool none~par_env_t_allreduce_dp_1d par_env_t%par_env_t_allreduce_dp_1d none~allreduce->none~par_env_t_allreduce_dp_1d none~par_env_t_allreduce_dp_2d par_env_t%par_env_t_allreduce_dp_2d none~allreduce->none~par_env_t_allreduce_dp_2d none~par_env_t_allreduce_dp_3d par_env_t%par_env_t_allreduce_dp_3d none~allreduce->none~par_env_t_allreduce_dp_3d none~par_env_t_allreduce_dp_4d par_env_t%par_env_t_allreduce_dp_4d none~allreduce->none~par_env_t_allreduce_dp_4d none~par_env_t_allreduce_dp_scalar par_env_t%par_env_t_allreduce_dp_scalar none~allreduce->none~par_env_t_allreduce_dp_scalar none~par_env_t_allreduce_int32_1d par_env_t%par_env_t_allreduce_int32_1d none~allreduce->none~par_env_t_allreduce_int32_1d none~par_env_t_allreduce_int32_scalar par_env_t%par_env_t_allreduce_int32_scalar none~allreduce->none~par_env_t_allreduce_int32_scalar none~par_env_t_allreduce_int64_1d par_env_t%par_env_t_allreduce_int64_1d none~allreduce->none~par_env_t_allreduce_int64_1d none~par_env_t_allreduce_int64_scalar par_env_t%par_env_t_allreduce_int64_scalar none~allreduce->none~par_env_t_allreduce_int64_scalar none~aoval basis_set%aoval none~compaov basis_set%compAOv none~aoval->none~compaov none~compaovg basis_set%compAOvg none~aoval->none~compaovg none~compaovgg basis_set%compAOvgg none~aoval->none~compaovgg none~bcast par_env_t%bcast none~par_env_t_bcast_byte par_env_t%par_env_t_bcast_byte none~bcast->none~par_env_t_bcast_byte none~par_env_t_bcast_c_bool par_env_t%par_env_t_bcast_c_bool none~bcast->none~par_env_t_bcast_c_bool none~par_env_t_bcast_dp_1d par_env_t%par_env_t_bcast_dp_1d none~bcast->none~par_env_t_bcast_dp_1d none~par_env_t_bcast_dp_2d par_env_t%par_env_t_bcast_dp_2d none~bcast->none~par_env_t_bcast_dp_2d none~par_env_t_bcast_dp_3d par_env_t%par_env_t_bcast_dp_3d none~bcast->none~par_env_t_bcast_dp_3d none~par_env_t_bcast_dp_4d par_env_t%par_env_t_bcast_dp_4d none~bcast->none~par_env_t_bcast_dp_4d none~par_env_t_bcast_dp_scalar par_env_t%par_env_t_bcast_dp_scalar none~bcast->none~par_env_t_bcast_dp_scalar none~par_env_t_bcast_int32_1d par_env_t%par_env_t_bcast_int32_1d none~bcast->none~par_env_t_bcast_int32_1d none~par_env_t_bcast_int32_scalar par_env_t%par_env_t_bcast_int32_scalar none~bcast->none~par_env_t_bcast_int32_scalar none~par_env_t_bcast_int64_1d par_env_t%par_env_t_bcast_int64_1d none~bcast->none~par_env_t_bcast_int64_1d none~par_env_t_bcast_int64_scalar par_env_t%par_env_t_bcast_int64_scalar none~bcast->none~par_env_t_bcast_int64_scalar none~comprdrho xc_engine_t%compRDRho none~comprrho xc_engine_t%compRRho none~comprtau xc_engine_t%compRTau none~screen int2_compute_data_t%screen none~screen_ijkl~2 int2_fock_data_t%screen_ijkl none~screen->none~screen_ijkl~2 none~screen_ij~2 int2_fock_data_t%screen_ij none~screen->none~screen_ij~2 none~screen~2 int2_td_data_t%screen none~screen~2->none~screen_ijkl~2 none~screen~2->none~screen_ij~2 none~screen~3 int2_mrsf_data_t%screen none~screen~3->none~screen_ijkl~2 none~screen~3->none~screen_ij~2 none~screen~4 int2_fock_data_t%screen none~screen~4->none~screen_ijkl~2 none~screen~4->none~screen_ij~2 none~screen~5 int2_rhf_data_t%screen none~screen~5->none~screen_ijkl~2 none~screen~5->none~screen_ij~2 none~screen~6 int2_urohf_data_t%screen none~screen~6->none~screen_ijkl~2 none~screen~6->none~screen_ij~2 none~screen~7 int2_rpagrd_data_t%screen none~screen~7->none~screen_ijkl~2 none~screen~7->none~screen_ij~2 none~screen~8 int2_tdgrd_data_t%screen none~screen~8->none~screen_ijkl~2 none~screen~8->none~screen_ij~2 none~set_atoms information%set_atoms none~set_atoms_arr information%set_atoms_arr none~set_atoms->none~set_atoms_arr none~set_atoms_atm information%set_atoms_atm none~set_atoms->none~set_atoms_atm proc~add_ecpder add_ecpder proc~add_ecpder->interface~compute_first_derivs proc~add_ecpder->interface~free_integrator proc~add_ecpder->interface~free_result proc~add_ecpder->interface~init_integrator proc~add_ecpder->interface~init_integrator_instance proc~add_ecpder->interface~set_ecp_basis none~bf_to_shell basis_set%bf_to_shell proc~add_ecpder->none~bf_to_shell proc~add_ecpint add_ecpint proc~add_ecpint->interface~compute_integrals proc~add_ecpint->interface~free_integrator proc~add_ecpint->interface~free_result proc~add_ecpint->interface~init_integrator proc~add_ecpint->interface~init_integrator_instance proc~add_ecpint->interface~set_ecp_basis proc~add_ecpint->none~bf_to_shell proc~antisymmetrize_matrix antisymmetrize_matrix proc~apply_basis_c apply_basis_C proc~apply_basis_c->interface~oqp_handle_get_info proc~oqp_apply_basis oqp_apply_basis proc~apply_basis_c->proc~oqp_apply_basis proc~atomic_structure_center atomic_structure%atomic_structure_center proc~to_upper to_upper proc~atomic_structure_center->proc~to_upper proc~atomic_structure_clean atomic_structure%atomic_structure_clean proc~atomic_structure_init atomic_structure%atomic_structure_init proc~atomic_structure_init->proc~atomic_structure_clean proc~basis_overlap basis_overlap proc~comp_kin_ovl_int1_prim comp_kin_ovl_int1_prim proc~basis_overlap->proc~comp_kin_ovl_int1_prim proc~update_rectangular_matrix update_rectangular_matrix proc~basis_overlap->proc~update_rectangular_matrix none~alloc2 shpair_t%alloc2 proc~basis_overlap->none~alloc2 none~fetch_by_id shell_t%fetch_by_id proc~basis_overlap->none~fetch_by_id none~shell_pair2 shpair_t%shell_pair2 proc~basis_overlap->none~shell_pair2 proc~boysf boysf fgrid fgrid proc~boysf->fgrid igrid igrid proc~boysf->igrid irgrd irgrd proc~boysf->irgrd rfinc rfinc proc~boysf->rfinc rmr rmr proc~boysf->rmr tlgm tlgm proc~boysf->tlgm xgrid xgrid proc~boysf->xgrid proc~build_pfon_density build_pfon_density proc~build_pfon_density->interface~pack_matrix proc~c_f_char c_f_char proc~check_states_phase check_states_phase proc~check_status check_status proc~check_status->interface~show_message get_status_message get_status_message proc~check_status->get_status_message proc~comp_allmult_int1_prim comp_allmult_int1_prim proc~mulquadgausshermite mulQuadGaussHermite proc~comp_allmult_int1_prim->proc~mulquadgausshermite proc~comp_coulomb_dampch_int1_prim comp_coulomb_dampch_int1_prim none~evaluate rys_root_t%evaluate proc~comp_coulomb_dampch_int1_prim->none~evaluate proc~comp_coulomb_der1 comp_coulomb_der1 proc~comp_coulomb_der1->none~evaluate proc~comp_coulomb_helfeyder1 comp_coulomb_helfeyder1 proc~comp_coulomb_helfeyder1->none~evaluate proc~comp_coulomb_int1_prim comp_coulomb_int1_prim proc~comp_coulomb_int1_prim->none~evaluate proc~comp_coulpot_prim comp_coulpot_prim proc~comp_coulpot_prim->none~evaluate proc~comp_det comp_det proc~comp_ewaldlr_der1 comp_ewaldlr_der1 proc~comp_ewaldlr_der1->none~evaluate proc~comp_ewaldlr_helfeyder1 comp_ewaldlr_helfeyder1 proc~comp_ewaldlr_helfeyder1->none~evaluate proc~comp_ewaldlr_int1_prim comp_ewaldlr_int1_prim proc~comp_ewaldlr_int1_prim->none~evaluate proc~doquadgausshermite doQuadGaussHermite proc~comp_kin_ovl_int1_prim->proc~doquadgausshermite proc~comp_kinetic_der1 comp_kinetic_der1 proc~comp_kinetic_der1->proc~doquadgausshermite proc~comp_lz_int1_prim comp_lz_int1_prim proc~comp_lz_int1_prim->proc~doquadgausshermite proc~comp_mult_int1_prim comp_mult_int1_prim proc~comp_mult_int1_prim->proc~mulquadgausshermite proc~comp_overlap_der1 comp_overlap_der1 proc~comp_overlap_der1->proc~doquadgausshermite proc~compatgraddrho compAtGradDRho proc~compatgradrho compAtGradRho proc~compatgradtau compAtGradTau proc~compute_states_overlap compute_states_overlap proc~mrsf_tlf mrsf_tlf proc~compute_states_overlap->proc~mrsf_tlf proc~compute~2 xc_libxc_t%compute none~calc_evfxc functional_t%calc_evfxc proc~compute~2->none~calc_evfxc none~calc_evxc functional_t%calc_evxc proc~compute~2->none~calc_evxc none~calc_xc functional_t%calc_xc proc~compute~2->none~calc_xc none~scalexc xc_lib_t%scalexc proc~compute~2->none~scalexc proc~corresponding_orbital_projection corresponding_orbital_projection proc~corresponding_orbital_projection->interface~show_message proc~diag_symm_full diag_symm_full proc~corresponding_orbital_projection->proc~diag_symm_full proc~oqp_dgemm_i64 oqp_dgemm_i64 proc~corresponding_orbital_projection->proc~oqp_dgemm_i64 proc~oqp_dswap_i64 oqp_dswap_i64 proc~corresponding_orbital_projection->proc~oqp_dswap_i64 proc~oqp_dsyrk_i64 oqp_dsyrk_i64 proc~corresponding_orbital_projection->proc~oqp_dsyrk_i64 proc~schmd schmd proc~corresponding_orbital_projection->proc~schmd proc~count_substring count_substring proc~density_ordered density_ordered proc~density_unordered density_unordered proc~derexc_blk derexc_blk proc~run_xc run_xc proc~derexc_blk->proc~run_xc none~clean~19 xc_consumer_grad_t%clean proc~derexc_blk->none~clean~19 none~init~14 par_env_t%init proc~derexc_blk->none~init~14 proc~dft_fc_blk dft_fc_blk none~getbyid list_grid_3d_t%getByID proc~dft_fc_blk->none~getbyid none~set~2 partition_function%set proc~dft_fc_blk->none~set~2 proc~dft_initialize dft_initialize proc~dft_initialize->interface~show_message proc~dft_initialize->proc~c_f_char proc~dft_initialize->proc~dft_fc_blk proc~get_radial_grid get_radial_grid proc~dft_initialize->proc~get_radial_grid proc~libxc_input libxc_input proc~dft_initialize->proc~libxc_input proc~set_bragg_slater set_bragg_slater proc~dft_initialize->proc~set_bragg_slater none~add_atomic_grid dft_grid_t%add_atomic_grid proc~dft_initialize->none~add_atomic_grid none~add_grid sorted_grid_t%add_grid proc~dft_initialize->none~add_grid none~compress dft_grid_t%compress proc~dft_initialize->none~compress none~find_neighbours dft_grid_t%find_neighbours proc~dft_initialize->none~find_neighbours none~reset dft_grid_t%reset proc~dft_initialize->none~reset none~set_screening basis_set%set_screening proc~dft_initialize->none~set_screening proc~dftclean dftclean proc~libxc_destroy libxc_destroy proc~dftclean->proc~libxc_destroy proc~dftder dftder proc~dftder->interface~show_message proc~dftder->interface~tagarray_get_data proc~dftder->interface~unpack_matrix proc~dftder->proc~check_status proc~dftder->proc~derexc_blk proc~dftexcor dftexcor proc~dmatd_blk dmatd_blk proc~dftexcor->proc~dmatd_blk proc~diag_symm_full->interface~show_message dsyev dsyev proc~diag_symm_full->dsyev proc~diag_symm_packed diag_symm_packed proc~diag_symm_packed->interface~show_message dspev dspev proc~diag_symm_packed->dspev dspevx dspevx proc~diag_symm_packed->dspevx proc~dmatd_blk->proc~run_xc none~clean~14 xc_consumer_ks_t%clean proc~dmatd_blk->none~clean~14 proc~dmatd_blk->none~init~14 abrt abrt proc~doquadgausshermite->abrt proc~e_charge_repulsion e_charge_repulsion proc~eijden eijden proc~eijden->interface~data_has_tags proc~eijden->interface~tagarray_get_data proc~eijden->interface~unpack_matrix proc~orthogonal_transform_sym orthogonal_transform_sym proc~eijden->proc~orthogonal_transform_sym proc~electric_moments electric_moments proc~electric_moments->interface~show_message proc~electric_moments->interface~tagarray_get_data proc~electric_moments->proc~check_status proc~multipole_integrals multipole_integrals proc~electric_moments->proc~multipole_integrals proc~traceprod_sym_packed traceprod_sym_packed proc~electric_moments->proc~traceprod_sym_packed proc~triangular_to_full triangular_to_full proc~electric_moments->proc~triangular_to_full proc~electrostatic_potential electrostatic_potential proc~electrostatic_potential->interface~bas_denorm_matrix proc~electrostatic_potential->interface~bas_norm_matrix proc~electrostatic_potential->proc~comp_coulpot_prim proc~electrostatic_potential->proc~density_ordered none~alloc~2 shpair_t%alloc proc~electrostatic_potential->none~alloc~2 proc~electrostatic_potential->none~fetch_by_id none~shell_pair shpair_t%shell_pair proc~electrostatic_potential->none~shell_pair proc~esum esum proc~f_c_char f_c_char proc~fock_jk fock_jk proc~measure_time measure_time proc~fock_jk->proc~measure_time none~clean~18 int2_compute_t%clean proc~fock_jk->none~clean~18 none~init~16 int2_compute_t%init proc~fock_jk->none~init~16 none~run~6 int2_compute_t%run proc~fock_jk->none~run~6 none~set_screening~2 int2_compute_t%set_screening proc~fock_jk->none~set_screening~2 proc~form_rohf_fock form_rohf_fock proc~form_rohf_fock->interface~pack_matrix proc~form_rohf_fock->interface~unpack_matrix proc~orthogonal_transform2 orthogonal_transform2 proc~form_rohf_fock->proc~orthogonal_transform2 proc~form_rohf_fock->proc~orthogonal_transform_sym proc~form_rohf_fock->proc~triangular_to_full dsymm dsymm proc~form_rohf_fock->dsymm proc~fstring fstring proc~genr22 genr22 proc~genr22->fgrid proc~genr22->rfinc proc~genr22->rmr proc~genr22->xgrid proc~get_ab_initio_density get_ab_initio_density proc~get_ab_initio_density->interface~show_message proc~orb_to_dens orb_to_dens proc~get_ab_initio_density->proc~orb_to_dens proc~get_ab_initio_orbital get_ab_initio_orbital proc~get_ab_initio_orbital->interface~show_message proc~get_ab_initio_orbital->interface~unpack_matrix proc~get_ab_initio_orbital->proc~diag_symm_full proc~get_ab_initio_orbital->proc~oqp_dgemm_i64 proc~orthogonal_transform orthogonal_transform proc~get_ab_initio_orbital->proc~orthogonal_transform proc~get_dcv get_dcv proc~get_element_id get_element_id proc~get_element_id->proc~to_upper proc~get_mrsf_transition_density get_mrsf_transition_density proc~get_mrsf_transition_density->interface~show_message proc~get_trans_den get_trans_den proc~get_mrsf_transition_density->proc~get_trans_den proc~get_mrsf_transitions get_mrsf_transitions set set proc~get_radial_grid->set transform transform proc~get_radial_grid->transform proc~get_spin_square get_spin_square proc~get_spin_square->interface~pack_matrix proc~get_spin_square->interface~show_message proc~get_spin_square->interface~unpack_matrix proc~get_spin_square->proc~oqp_dgemm_i64 proc~symmetrize_matrix symmetrize_matrix proc~get_spin_square->proc~symmetrize_matrix proc~get_spin_square->proc~traceprod_sym_packed proc~get_state_overlap_c get_state_overlap_C proc~get_state_overlap_c->interface~oqp_handle_get_info proc~get_states_overlap get_states_overlap proc~get_state_overlap_c->proc~get_states_overlap proc~get_states_overlap->interface~data_has_tags proc~get_states_overlap->interface~show_message proc~get_states_overlap->interface~tagarray_get_data proc~get_states_overlap->proc~check_states_phase proc~get_states_overlap->proc~compute_states_overlap proc~get_states_overlap->proc~get_dcv proc~get_states_overlap->proc~measure_time proc~mrsfxvec mrsfxvec proc~get_states_overlap->proc~mrsfxvec remove_records remove_records proc~get_states_overlap->remove_records reserve_data reserve_data proc~get_states_overlap->reserve_data proc~get_structures_ao_overlap get_structures_ao_overlap proc~get_structures_ao_overlap->interface~data_has_tags proc~get_structures_ao_overlap->interface~tagarray_get_data proc~get_structures_ao_overlap->proc~basis_overlap proc~get_structures_ao_overlap->proc~measure_time proc~mo_overlap mo_overlap proc~get_structures_ao_overlap->proc~mo_overlap proc~print_geo print_geo proc~get_structures_ao_overlap->proc~print_geo proc~print_results print_results proc~get_structures_ao_overlap->proc~print_results proc~get_structures_ao_overlap->remove_records proc~get_structures_ao_overlap->reserve_data proc~get_structures_ao_overlap_c get_structures_ao_overlap_C proc~get_structures_ao_overlap_c->interface~oqp_handle_get_info proc~get_structures_ao_overlap_c->proc~get_structures_ao_overlap proc~get_td_transition_dipole get_td_transition_dipole proc~get_td_transition_dipole->interface~pack_matrix proc~get_td_transition_dipole->interface~show_message proc~get_td_transition_dipole->proc~atomic_structure_center proc~iatogen iatogen proc~get_td_transition_dipole->proc~iatogen proc~get_td_transition_dipole->proc~multipole_integrals proc~get_td_transition_dipole->proc~orthogonal_transform proc~get_td_transition_dipole->proc~symmetrize_matrix proc~get_td_transition_dipole->proc~traceprod_sym_packed proc~get_transition_density get_transition_density proc~get_transition_density->interface~show_message proc~get_transition_density->proc~iatogen proc~get_transition_dipole get_transition_dipole proc~get_transition_dipole->interface~pack_matrix proc~get_transition_dipole->interface~show_message proc~get_transition_dipole->proc~atomic_structure_center proc~get_transition_dipole->proc~multipole_integrals proc~get_transition_dipole->proc~orthogonal_transform proc~get_transition_dipole->proc~symmetrize_matrix proc~get_transition_dipole->proc~traceprod_sym_packed proc~get_transitions get_transitions proc~grad_1e_ecp grad_1e_ecp proc~grad_1e_ecp->none~bcast proc~grad_1e_ecp->proc~add_ecpder proc~grad_1e_ecp->none~init~14 proc~grad_ee_kinetic grad_ee_kinetic proc~grad_ee_kinetic->interface~bas_norm_matrix proc~grad_ee_kinetic->interface~unpack_matrix proc~grad_ee_kinetic->proc~comp_kinetic_der1 proc~grad_ee_kinetic->none~alloc~2 proc~grad_ee_kinetic->none~fetch_by_id proc~grad_ee_kinetic->none~shell_pair proc~grad_ee_overlap grad_ee_overlap proc~grad_ee_overlap->interface~bas_norm_matrix proc~grad_ee_overlap->interface~unpack_matrix proc~grad_ee_overlap->proc~comp_overlap_der1 proc~grad_ee_overlap->none~alloc~2 proc~grad_ee_overlap->none~fetch_by_id proc~grad_ee_overlap->none~shell_pair proc~grad_en_hellman_feynman grad_en_hellman_feynman proc~grad_en_hellman_feynman->interface~bas_norm_matrix proc~grad_en_hellman_feynman->interface~unpack_matrix proc~grad_en_hellman_feynman->proc~comp_coulomb_helfeyder1 proc~grad_en_hellman_feynman->none~alloc~2 proc~grad_en_hellman_feynman->none~fetch_by_id proc~grad_en_hellman_feynman->none~shell_pair proc~grad_en_pulay grad_en_pulay proc~grad_en_pulay->interface~bas_norm_matrix proc~grad_en_pulay->interface~unpack_matrix proc~grad_en_pulay->proc~comp_coulomb_der1 proc~grad_en_pulay->none~alloc~2 proc~grad_en_pulay->none~fetch_by_id proc~grad_en_pulay->none~shell_pair proc~grad_nn grad_nn proc~grd2_driver grd2_driver proc~grd2_driver->interface~show_message proc~grd2_driver->none~allreduce proc~grd2_rys_compute grd2_rys_compute proc~grd2_driver->proc~grd2_rys_compute proc~ints_exchange ints_exchange proc~grd2_driver->proc~ints_exchange get_density get_density proc~grd2_driver->get_density none~alloc int2_pair_storage%alloc proc~grd2_driver->none~alloc none~clean~24 grd2_int_data_t%clean proc~grd2_driver->none~clean~24 none~compute int2_pair_storage%compute proc~grd2_driver->none~compute proc~grd2_driver->none~init~14 none~set int2_cutoffs_t%set proc~grd2_driver->none~set none~set_ids~2 grd2_int_data_t%set_ids proc~grd2_driver->none~set_ids~2 proc~grd2_rys_compute->none~evaluate proc~grd2_tdhf_compute_data_t_clean grd2_tdhf_compute_data_t%grd2_tdhf_compute_data_t_clean proc~grd2_tdhf_compute_data_t_get_density grd2_tdhf_compute_data_t%grd2_tdhf_compute_data_t_get_density proc~grd2_tdhf_compute_data_t_init grd2_tdhf_compute_data_t%grd2_tdhf_compute_data_t_init proc~grd2_tdhf_compute_data_t_init->proc~grd2_tdhf_compute_data_t_clean proc~guess_hcore guess_hcore proc~guess_hcore->interface~data_has_tags proc~guess_hcore->interface~show_message proc~guess_hcore->interface~tagarray_get_data proc~guess_hcore->proc~get_ab_initio_density proc~guess_hcore->proc~get_ab_initio_orbital proc~matrix_invsqrt matrix_invsqrt proc~guess_hcore->proc~matrix_invsqrt proc~guess_hcore->proc~measure_time proc~print_module_info print_module_info proc~guess_hcore->proc~print_module_info proc~guess_hcore->remove_records proc~guess_hcore->reserve_data proc~guess_hcore_c guess_hcore_C proc~guess_hcore_c->interface~oqp_handle_get_info proc~guess_hcore_c->proc~guess_hcore proc~guess_huckel guess_huckel proc~guess_huckel->interface~data_has_tags proc~guess_huckel->interface~tagarray_get_data proc~guess_huckel->none~bcast proc~guess_huckel->proc~get_ab_initio_density proc~huckel_guess huckel_guess proc~guess_huckel->proc~huckel_guess proc~guess_huckel->proc~measure_time proc~guess_huckel->proc~print_module_info none~barrier par_env_t%barrier proc~guess_huckel->none~barrier none~from_file basis_set%from_file proc~guess_huckel->none~from_file proc~guess_huckel->none~init~14 proc~guess_huckel->remove_records proc~guess_huckel->reserve_data proc~guess_huckel_c guess_huckel_C proc~guess_huckel_c->interface~oqp_handle_get_info proc~guess_huckel_c->proc~guess_huckel proc~guess_json guess_json proc~guess_json->interface~data_has_tags proc~guess_json->interface~tagarray_get_data proc~guess_json->none~bcast proc~guess_json->proc~get_ab_initio_density proc~guess_json->proc~measure_time proc~guess_json->proc~print_module_info proc~guess_json->none~barrier proc~guess_json->none~init~14 proc~guess_json->reserve_data proc~guess_json_c guess_json_C proc~guess_json_c->interface~oqp_handle_get_info proc~guess_json_c->proc~guess_json proc~hf_energy hf_energy proc~hf_energy->proc~check_status proc~hf_energy->proc~dft_initialize proc~hf_energy->proc~dftclean proc~hf_energy->proc~print_module_info proc~scf_driver scf_driver proc~hf_energy->proc~scf_driver get_status get_status proc~hf_energy->get_status proc~hf_energy->remove_records proc~hf_energy->reserve_data proc~hf_gradient hf_gradient proc~hf_gradient->interface~show_message proc~hf_gradient->interface~tagarray_get_data proc~hf_gradient->proc~check_status proc~hf_gradient->proc~dft_initialize proc~hf_gradient->proc~dftclean proc~hf_gradient->proc~dftder proc~hf_gradient->proc~eijden proc~hf_gradient->proc~grad_1e_ecp proc~hf_gradient->proc~grad_ee_kinetic proc~hf_gradient->proc~grad_ee_overlap proc~hf_gradient->proc~grad_en_hellman_feynman proc~hf_gradient->proc~grad_en_pulay proc~hf_gradient->proc~grad_nn proc~hf_gradient->proc~grd2_driver proc~hf_gradient->proc~measure_time proc~print_gradient print_gradient proc~hf_gradient->proc~print_gradient proc~hf_gradient->proc~print_module_info clean clean proc~hf_gradient->clean init init proc~hf_gradient->init proc~huckel_guess->interface~show_message proc~huckel_guess->interface~unpack_matrix proc~huckel_guess->proc~basis_overlap proc~huckel_guess->proc~corresponding_orbital_projection proc~huckel_guess->proc~diag_symm_full proc~huckel_guess->proc~matrix_invsqrt proc~mksphar mksphar proc~huckel_guess->proc~mksphar proc~huckel_guess->proc~oqp_dgemm_i64 proc~oqp_dgeqrf_i64 oqp_dgeqrf_i64 proc~huckel_guess->proc~oqp_dgeqrf_i64 proc~oqp_dormqr_i64 oqp_dormqr_i64 proc~huckel_guess->proc~oqp_dormqr_i64 proc~oqp_dsymm_i64 oqp_dsymm_i64 proc~huckel_guess->proc~oqp_dsymm_i64 proc~huckel_guess->proc~orthogonal_transform_sym proc~overlap overlap proc~huckel_guess->proc~overlap proc~index_ith index_ith proc~init xc_libxc_t%init none~clean~13 xc_lib_t%clean proc~init->none~clean~13 none~resetenergy xc_lib_t%resetEnergy proc~init->none~resetenergy proc~inivec inivec proc~int1e int1e proc~int1e->interface~data_has_tags proc~int1e->interface~tagarray_get_data proc~omp_hst omp_hst proc~int1e->proc~omp_hst proc~int1e->proc~print_module_info proc~print_sym_labeled print_sym_labeled proc~int1e->proc~print_sym_labeled proc~int1e->remove_records proc~int1e->reserve_data proc~int2_mrsf_data_t_clean int2_mrsf_data_t%int2_mrsf_data_t_clean proc~int2_mrsf_data_t_init_screen int2_mrsf_data_t%int2_mrsf_data_t_init_screen proc~shell_den_screen_mrsf shell_den_screen_mrsf proc~int2_mrsf_data_t_init_screen->proc~shell_den_screen_mrsf proc~int2_mrsf_data_t_parallel_start int2_mrsf_data_t%int2_mrsf_data_t_parallel_start proc~int2_mrsf_data_t_parallel_start->proc~int2_mrsf_data_t_init_screen proc~int2_mrsf_data_t_parallel_stop int2_mrsf_data_t%int2_mrsf_data_t_parallel_stop proc~int2_mrsf_data_t_parallel_stop->none~allreduce proc~int2_mrsf_data_t_update int2_mrsf_data_t%int2_mrsf_data_t_update proc~int2_rpagrd_data_t_clean int2_rpagrd_data_t%int2_rpagrd_data_t_clean proc~int2_rpagrd_data_t_init_screen int2_rpagrd_data_t%int2_rpagrd_data_t_init_screen proc~shlrpagrd shlrpagrd proc~int2_rpagrd_data_t_init_screen->proc~shlrpagrd proc~int2_rpagrd_data_t_parallel_start int2_rpagrd_data_t%int2_rpagrd_data_t_parallel_start proc~int2_rpagrd_data_t_parallel_start->proc~int2_rpagrd_data_t_init_screen proc~int2_rpagrd_data_t_parallel_stop int2_rpagrd_data_t%int2_rpagrd_data_t_parallel_stop proc~int2_rpagrd_data_t_parallel_stop->none~allreduce proc~symmetrize_matrices symmetrize_matrices proc~int2_rpagrd_data_t_parallel_stop->proc~symmetrize_matrices proc~int2_rpagrd_data_t_update int2_rpagrd_data_t%int2_rpagrd_data_t_update proc~int2_rpagrd_data_t_update_hminus int2_rpagrd_data_t%int2_rpagrd_data_t_update_hminus proc~int2_rpagrd_data_t_update->proc~int2_rpagrd_data_t_update_hminus proc~int2_rpagrd_data_t_update_hplus int2_rpagrd_data_t%int2_rpagrd_data_t_update_hplus proc~int2_rpagrd_data_t_update->proc~int2_rpagrd_data_t_update_hplus proc~int2_rys_compute int2_rys_compute proc~int2_rys_compute->none~evaluate proc~int2_td_data_t_clean int2_td_data_t%int2_td_data_t_clean proc~int2_td_data_t_init_screen int2_td_data_t%int2_td_data_t_init_screen proc~shltd shltd proc~int2_td_data_t_init_screen->proc~shltd proc~int2_td_data_t_parallel_start int2_td_data_t%int2_td_data_t_parallel_start proc~int2_td_data_t_parallel_start->proc~int2_td_data_t_init_screen proc~int2_td_data_t_parallel_stop int2_td_data_t%int2_td_data_t_parallel_stop proc~int2_td_data_t_parallel_stop->none~allreduce proc~int2_td_data_t_parallel_stop->proc~symmetrize_matrix proc~int2_td_data_t_update int2_td_data_t%int2_td_data_t_update proc~int2_tdgrd_data_t_update int2_tdgrd_data_t%int2_tdgrd_data_t_update proc~ints_exchange->interface~show_message proc~ints_exchange->proc~genr22 proc~ints_exchange->proc~int2_rys_compute proc~libint_compute_eri libint_compute_eri proc~ints_exchange->proc~libint_compute_eri libint2_cleanup_eri libint2_cleanup_eri proc~ints_exchange->libint2_cleanup_eri libint2_init_eri libint2_init_eri proc~ints_exchange->libint2_init_eri proc~ints_exchange->none~alloc none~clean~2 int2_rys_data_t%clean proc~ints_exchange->none~clean~2 proc~ints_exchange->none~compute none~init~2 int2_rys_data_t%init proc~ints_exchange->none~init~2 proc~ints_exchange->none~set none~set_ids int2_rys_data_t%set_ids proc~ints_exchange->none~set_ids proc~lebedev_get_grid lebedev_get_grid proc~lebedev_get_grid->interface~show_message proc~libint2_build libint2_build proc~libint2_cleanup_eri libint2_cleanup_eri proc~libint2_init_eri libint2_init_eri proc~libint2_static_cleanup libint2_static_cleanup proc~libint2_static_init libint2_static_init ab_x ab_x proc~libint_compute_eri->ab_x ab_y ab_y proc~libint_compute_eri->ab_y ab_z ab_z proc~libint_compute_eri->ab_z alpha1over_zetapluseta alpha1over_zetapluseta proc~libint_compute_eri->alpha1over_zetapluseta alpha1rho_over_zeta2 alpha1rho_over_zeta2 proc~libint_compute_eri->alpha1rho_over_zeta2 alpha2over_zetapluseta alpha2over_zetapluseta proc~libint_compute_eri->alpha2over_zetapluseta alpha2rho_over_zeta2 alpha2rho_over_zeta2 proc~libint_compute_eri->alpha2rho_over_zeta2 alpha3over_zetapluseta alpha3over_zetapluseta proc~libint_compute_eri->alpha3over_zetapluseta alpha3rho_over_eta2 alpha3rho_over_eta2 proc~libint_compute_eri->alpha3rho_over_eta2 alpha4over_zetapluseta alpha4over_zetapluseta proc~libint_compute_eri->alpha4over_zetapluseta alpha4rho_over_eta2 alpha4rho_over_eta2 proc~libint_compute_eri->alpha4rho_over_eta2 cd_x cd_x proc~libint_compute_eri->cd_x cd_y cd_y proc~libint_compute_eri->cd_y cd_z cd_z proc~libint_compute_eri->cd_z f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_0 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_0 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_0 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_1 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_1 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_1 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_10 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_10 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_10 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_11 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_11 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_11 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_12 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_12 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_12 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_13 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_13 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_13 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_14 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_14 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_14 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_15 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_15 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_15 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_16 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_16 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_16 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_17 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_17 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_17 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_18 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_18 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_18 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_19 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_19 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_19 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_2 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_2 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_2 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_20 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_20 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_20 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_3 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_3 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_3 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_4 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_4 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_4 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_5 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_5 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_5 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_6 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_6 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_6 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_7 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_7 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_7 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_8 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_8 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_8 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_9 f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_9 proc~libint_compute_eri->f_ab_s___0__s___1___twoprep_s___0__s___1___ab__up_9 proc~libint_compute_eri->fgrid proc~libint_compute_eri->igrid proc~libint_compute_eri->irgrd oo2e oo2e proc~libint_compute_eri->oo2e oo2z oo2z proc~libint_compute_eri->oo2z oo2ze oo2ze proc~libint_compute_eri->oo2ze pa_x pa_x proc~libint_compute_eri->pa_x pa_y pa_y proc~libint_compute_eri->pa_y pa_z pa_z proc~libint_compute_eri->pa_z qc_x qc_x proc~libint_compute_eri->qc_x qc_y qc_y proc~libint_compute_eri->qc_y qc_z qc_z proc~libint_compute_eri->qc_z proc~libint_compute_eri->rfinc rho12_over_alpha1 rho12_over_alpha1 proc~libint_compute_eri->rho12_over_alpha1 rho12_over_alpha2 rho12_over_alpha2 proc~libint_compute_eri->rho12_over_alpha2 rho34_over_alpha3 rho34_over_alpha3 proc~libint_compute_eri->rho34_over_alpha3 rho34_over_alpha4 rho34_over_alpha4 proc~libint_compute_eri->rho34_over_alpha4 proc~libint_compute_eri->rmr roe roe proc~libint_compute_eri->roe roz roz proc~libint_compute_eri->roz two_alpha0_bra two_alpha0_bra proc~libint_compute_eri->two_alpha0_bra two_alpha0_ket two_alpha0_ket proc~libint_compute_eri->two_alpha0_ket two_alpha1bra two_alpha1bra proc~libint_compute_eri->two_alpha1bra two_alpha1ket two_alpha1ket proc~libint_compute_eri->two_alpha1ket wp_x wp_x proc~libint_compute_eri->wp_x wp_y wp_y proc~libint_compute_eri->wp_y wp_z wp_z proc~libint_compute_eri->wp_z wq_x wq_x proc~libint_compute_eri->wq_x wq_y wq_y proc~libint_compute_eri->wq_y wq_z wq_z proc~libint_compute_eri->wq_z proc~libint_print_eri libint_print_eri proc~libint_static_cleanup libint_static_cleanup libint2_static_cleanup libint2_static_cleanup proc~libint_static_cleanup->libint2_static_cleanup proc~libint_static_init libint_static_init libint2_static_init libint2_static_init proc~libint_static_init->libint2_static_init none~destroy~2 functional_t%destroy proc~libxc_destroy->none~destroy~2 proc~libxc_input->interface~show_message none~add_functional functional_t%add_functional proc~libxc_input->none~add_functional none~can_calculate functional_t%can_calculate proc~libxc_input->none~can_calculate xc_f03_reference xc_f03_reference proc~libxc_input->xc_f03_reference xc_f03_reference_doi xc_f03_reference_doi proc~libxc_input->xc_f03_reference_doi xc_f03_version_string xc_f03_version_string proc~libxc_input->xc_f03_version_string proc~lowdin lowdin proc~lowdin->interface~show_message proc~run_population_analysis run_population_analysis proc~lowdin->proc~run_population_analysis none~bf_label basis_set%bf_label proc~lowdin->none~bf_label proc~matrix_invsqrt->interface~show_message proc~matrix_invsqrt->proc~diag_symm_packed proc~mksphar->interface~show_message proc~mntoia mntoia proc~mntoia->proc~oqp_dgemm_i64 dgemm dgemm proc~mo_overlap->dgemm proc~mo_reorder mo_reorder proc~reordermos reordermos proc~mo_reorder->proc~reordermos proc~mo_reorder->dgemm proc~mo_to_ao mo_to_ao proc~mo_to_ao->interface~pack_matrix proc~mo_to_ao->interface~unpack_matrix proc~mo_to_ao->proc~oqp_dgemm_i64 proc~mo_to_ao->proc~oqp_dsymm_i64 proc~mo_tran_gemm_ mo_tran_gemm_ proc~mo_tran_gemm_->proc~oqp_dgemm_i64 proc~mo_tran_symm_ mo_tran_symm_ proc~mo_tran_symm_->proc~oqp_dsymm_i64 proc~mrinivec mrinivec proc~ov_exact ov_exact proc~mrsf_tlf->proc~ov_exact proc~tlf_exp tlf_exp proc~mrsf_tlf->proc~tlf_exp proc~mrsfcbc mrsfcbc proc~mrsfcbc->interface~show_message proc~mrsfcbc->proc~oqp_dgemm_i64 proc~mrsfesum mrsfesum proc~mrsfesum->interface~show_message proc~mrsfesum->proc~oqp_dgemm_i64 proc~mrsfmntoia mrsfmntoia proc~mrsfmntoia->interface~show_message proc~mrsfmntoia->proc~oqp_dgemm_i64 proc~oqp_dgemv_i64 oqp_dgemv_i64 proc~mrsfmntoia->proc~oqp_dgemv_i64 proc~mrsfqroesum mrsfqroesum proc~mrsfqropcal mrsfqropcal proc~mrsfqrorhs mrsfqrorhs proc~mrsfqrorhs->proc~oqp_dgemm_i64 proc~mrsfqrowcal mrsfqrowcal proc~mrsfrowcal mrsfrowcal proc~mrsfsp mrsfsp proc~mrsfsp->interface~show_message proc~mrsfsp->proc~oqp_dgemm_i64 proc~mrsfxvec->interface~show_message proc~mulliken mulliken proc~mulliken->interface~show_message proc~mulliken->proc~run_population_analysis proc~mulliken->none~bf_label proc~mulquadgausshermite->abrt proc~multipole_integrals->interface~bas_norm_matrix proc~multipole_integrals->interface~show_message proc~multipole_integrals->proc~comp_allmult_int1_prim proc~multipole_integrals->proc~print_sym_labeled proc~update_triang_matrix update_triang_matrix proc~multipole_integrals->proc~update_triang_matrix proc~multipole_integrals->none~alloc~2 proc~multipole_integrals->none~fetch_by_id proc~multipole_integrals->none~shell_pair proc~omp_hst->interface~bas_norm_matrix proc~omp_hst->interface~int1_coul proc~omp_hst->none~bcast proc~omp_hst->proc~add_ecpint proc~omp_hst->proc~comp_kin_ovl_int1_prim proc~omp_hst->proc~comp_lz_int1_prim proc~omp_hst->proc~print_sym_labeled proc~omp_hst->proc~update_triang_matrix proc~omp_hst->none~alloc~2 proc~omp_hst->none~fetch_by_id proc~omp_hst->none~init~14 proc~omp_hst->none~shell_pair proc~oqp_apply_basis->interface~data_has_tags proc~oqp_apply_basis->interface~tagarray_get_data proc~oqp_apply_basis->none~bcast map_shell2basis_set map_shell2basis_set proc~oqp_apply_basis->map_shell2basis_set proc~oqp_apply_basis->none~init~14 print_basis print_basis proc~oqp_apply_basis->print_basis proc~oqp_banner oqp_banner proc~oqp_banner->interface~data_has_tags proc~oqp_banner->interface~tagarray_get_data none~get_hostnames par_env_t%get_hostnames proc~oqp_banner->none~get_hostnames proc~oqp_banner->none~init~14 proc~oqp_banner_c oqp_banner_C proc~oqp_banner_c->interface~oqp_handle_get_info proc~oqp_banner_c->proc~oqp_banner proc~oqp_caxpy_i64 oqp_caxpy_i64 proc~oqp_caxpy_i64->interface~show_message caxpy caxpy proc~oqp_caxpy_i64->caxpy proc~oqp_ccopy_i64 oqp_ccopy_i64 proc~oqp_ccopy_i64->interface~show_message ccopy ccopy proc~oqp_ccopy_i64->ccopy proc~oqp_cdotc_i64 oqp_cdotc_i64 proc~oqp_cdotc_i64->interface~show_message cdotc cdotc proc~oqp_cdotc_i64->cdotc proc~oqp_cdotu_i64 oqp_cdotu_i64 proc~oqp_cdotu_i64->interface~show_message cdotu cdotu proc~oqp_cdotu_i64->cdotu proc~oqp_cgbmv_i64 oqp_cgbmv_i64 proc~oqp_cgbmv_i64->interface~show_message cgbmv cgbmv proc~oqp_cgbmv_i64->cgbmv proc~oqp_cgemm_i64 oqp_cgemm_i64 proc~oqp_cgemm_i64->interface~show_message cgemm cgemm proc~oqp_cgemm_i64->cgemm proc~oqp_cgemv_i64 oqp_cgemv_i64 proc~oqp_cgemv_i64->interface~show_message cgemv cgemv proc~oqp_cgemv_i64->cgemv proc~oqp_cgerc_i64 oqp_cgerc_i64 proc~oqp_cgerc_i64->interface~show_message cgerc cgerc proc~oqp_cgerc_i64->cgerc proc~oqp_cgeru_i64 oqp_cgeru_i64 proc~oqp_cgeru_i64->interface~show_message cgeru cgeru proc~oqp_cgeru_i64->cgeru proc~oqp_chbmv_i64 oqp_chbmv_i64 proc~oqp_chbmv_i64->interface~show_message chbmv chbmv proc~oqp_chbmv_i64->chbmv proc~oqp_chemm_i64 oqp_chemm_i64 proc~oqp_chemm_i64->interface~show_message chemm chemm proc~oqp_chemm_i64->chemm proc~oqp_chemv_i64 oqp_chemv_i64 proc~oqp_chemv_i64->interface~show_message chemv chemv proc~oqp_chemv_i64->chemv proc~oqp_cher2_i64 oqp_cher2_i64 proc~oqp_cher2_i64->interface~show_message cher2 cher2 proc~oqp_cher2_i64->cher2 proc~oqp_cher2k_i64 oqp_cher2k_i64 proc~oqp_cher2k_i64->interface~show_message cher2k cher2k proc~oqp_cher2k_i64->cher2k proc~oqp_cher_i64 oqp_cher_i64 proc~oqp_cher_i64->interface~show_message cher cher proc~oqp_cher_i64->cher proc~oqp_cherk_i64 oqp_cherk_i64 proc~oqp_cherk_i64->interface~show_message cherk cherk proc~oqp_cherk_i64->cherk proc~oqp_chpmv_i64 oqp_chpmv_i64 proc~oqp_chpmv_i64->interface~show_message chpmv chpmv proc~oqp_chpmv_i64->chpmv proc~oqp_chpr2_i64 oqp_chpr2_i64 proc~oqp_chpr2_i64->interface~show_message chpr2 chpr2 proc~oqp_chpr2_i64->chpr2 proc~oqp_chpr_i64 oqp_chpr_i64 proc~oqp_chpr_i64->interface~show_message chpr chpr proc~oqp_chpr_i64->chpr proc~oqp_cscal_i64 oqp_cscal_i64 proc~oqp_cscal_i64->interface~show_message cscal cscal proc~oqp_cscal_i64->cscal proc~oqp_csrot_i64 oqp_csrot_i64 proc~oqp_csrot_i64->interface~show_message csrot csrot proc~oqp_csrot_i64->csrot proc~oqp_csscal_i64 oqp_csscal_i64 proc~oqp_csscal_i64->interface~show_message csscal csscal proc~oqp_csscal_i64->csscal proc~oqp_cswap_i64 oqp_cswap_i64 proc~oqp_cswap_i64->interface~show_message cswap cswap proc~oqp_cswap_i64->cswap proc~oqp_csymm_i64 oqp_csymm_i64 proc~oqp_csymm_i64->interface~show_message csymm csymm proc~oqp_csymm_i64->csymm proc~oqp_csyr2k_i64 oqp_csyr2k_i64 proc~oqp_csyr2k_i64->interface~show_message csyr2k csyr2k proc~oqp_csyr2k_i64->csyr2k proc~oqp_csyrk_i64 oqp_csyrk_i64 proc~oqp_csyrk_i64->interface~show_message csyrk csyrk proc~oqp_csyrk_i64->csyrk proc~oqp_ctbmv_i64 oqp_ctbmv_i64 proc~oqp_ctbmv_i64->interface~show_message ctbmv ctbmv proc~oqp_ctbmv_i64->ctbmv proc~oqp_ctbsv_i64 oqp_ctbsv_i64 proc~oqp_ctbsv_i64->interface~show_message ctbsv ctbsv proc~oqp_ctbsv_i64->ctbsv proc~oqp_ctpmv_i64 oqp_ctpmv_i64 proc~oqp_ctpmv_i64->interface~show_message ctpmv ctpmv proc~oqp_ctpmv_i64->ctpmv proc~oqp_ctpsv_i64 oqp_ctpsv_i64 proc~oqp_ctpsv_i64->interface~show_message ctpsv ctpsv proc~oqp_ctpsv_i64->ctpsv proc~oqp_ctrmm_i64 oqp_ctrmm_i64 proc~oqp_ctrmm_i64->interface~show_message ctrmm ctrmm proc~oqp_ctrmm_i64->ctrmm proc~oqp_ctrmv_i64 oqp_ctrmv_i64 proc~oqp_ctrmv_i64->interface~show_message ctrmv ctrmv proc~oqp_ctrmv_i64->ctrmv proc~oqp_ctrsm_i64 oqp_ctrsm_i64 proc~oqp_ctrsm_i64->interface~show_message ctrsm ctrsm proc~oqp_ctrsm_i64->ctrsm proc~oqp_ctrsv_i64 oqp_ctrsv_i64 proc~oqp_ctrsv_i64->interface~show_message ctrsv ctrsv proc~oqp_ctrsv_i64->ctrsv proc~oqp_dasum_i64 oqp_dasum_i64 proc~oqp_dasum_i64->interface~show_message dasum dasum proc~oqp_dasum_i64->dasum proc~oqp_daxpy_i64 oqp_daxpy_i64 proc~oqp_daxpy_i64->interface~show_message daxpy daxpy proc~oqp_daxpy_i64->daxpy proc~oqp_dcopy_i64 oqp_dcopy_i64 proc~oqp_dcopy_i64->interface~show_message dcopy dcopy proc~oqp_dcopy_i64->dcopy proc~oqp_ddot_i64 oqp_ddot_i64 proc~oqp_ddot_i64->interface~show_message ddot ddot proc~oqp_ddot_i64->ddot proc~oqp_dgbmv_i64 oqp_dgbmv_i64 proc~oqp_dgbmv_i64->interface~show_message dgbmv dgbmv proc~oqp_dgbmv_i64->dgbmv proc~oqp_dgemm_i64->interface~show_message proc~oqp_dgemm_i64->dgemm proc~oqp_dgemv_i64->interface~show_message dgemv dgemv proc~oqp_dgemv_i64->dgemv proc~oqp_dgeqrf_i64->interface~show_message dgeqrf dgeqrf proc~oqp_dgeqrf_i64->dgeqrf proc~oqp_dger_i64 oqp_dger_i64 proc~oqp_dger_i64->interface~show_message dger dger proc~oqp_dger_i64->dger proc~oqp_dgesv_i64 oqp_dgesv_i64 proc~oqp_dgesv_i64->interface~show_message dgesv dgesv proc~oqp_dgesv_i64->dgesv proc~oqp_dgetri_i64 oqp_dgetri_i64 proc~oqp_dgetri_i64->interface~show_message dgetri dgetri proc~oqp_dgetri_i64->dgetri proc~oqp_dgglse_i64 oqp_dgglse_i64 proc~oqp_dgglse_i64->interface~show_message dgglse dgglse proc~oqp_dgglse_i64->dgglse proc~oqp_dnrm2_i64 oqp_dnrm2_i64 proc~oqp_dnrm2_i64->interface~show_message dnrm2 dnrm2 proc~oqp_dnrm2_i64->dnrm2 proc~oqp_dorgqr_i64 oqp_dorgqr_i64 proc~oqp_dorgqr_i64->interface~show_message dorgqr dorgqr proc~oqp_dorgqr_i64->dorgqr proc~oqp_dormqr_i64->interface~show_message dormqr dormqr proc~oqp_dormqr_i64->dormqr proc~oqp_drot_i64 oqp_drot_i64 proc~oqp_drot_i64->interface~show_message drot drot proc~oqp_drot_i64->drot proc~oqp_drotm_i64 oqp_drotm_i64 proc~oqp_drotm_i64->interface~show_message drotm drotm proc~oqp_drotm_i64->drotm proc~oqp_dsbmv_i64 oqp_dsbmv_i64 proc~oqp_dsbmv_i64->interface~show_message dsbmv dsbmv proc~oqp_dsbmv_i64->dsbmv proc~oqp_dscal_i64 oqp_dscal_i64 proc~oqp_dscal_i64->interface~show_message dscal dscal proc~oqp_dscal_i64->dscal proc~oqp_dsdot_i64 oqp_dsdot_i64 proc~oqp_dsdot_i64->interface~show_message dsdot dsdot proc~oqp_dsdot_i64->dsdot proc~oqp_dspmv_i64 oqp_dspmv_i64 proc~oqp_dspmv_i64->interface~show_message dspmv dspmv proc~oqp_dspmv_i64->dspmv proc~oqp_dspr2_i64 oqp_dspr2_i64 proc~oqp_dspr2_i64->interface~show_message dspr2 dspr2 proc~oqp_dspr2_i64->dspr2 proc~oqp_dspr_i64 oqp_dspr_i64 proc~oqp_dspr_i64->interface~show_message dspr dspr proc~oqp_dspr_i64->dspr proc~oqp_dswap_i64->interface~show_message dswap dswap proc~oqp_dswap_i64->dswap proc~oqp_dsymm_i64->interface~show_message proc~oqp_dsymm_i64->dsymm proc~oqp_dsymv_i64 oqp_dsymv_i64 proc~oqp_dsymv_i64->interface~show_message dsymv dsymv proc~oqp_dsymv_i64->dsymv proc~oqp_dsyr2_i64 oqp_dsyr2_i64 proc~oqp_dsyr2_i64->interface~show_message dsyr2 dsyr2 proc~oqp_dsyr2_i64->dsyr2 proc~oqp_dsyr2k_i64 oqp_dsyr2k_i64 proc~oqp_dsyr2k_i64->interface~show_message dsyr2k dsyr2k proc~oqp_dsyr2k_i64->dsyr2k proc~oqp_dsyr_i64 oqp_dsyr_i64 proc~oqp_dsyr_i64->interface~show_message dsyr dsyr proc~oqp_dsyr_i64->dsyr proc~oqp_dsyrk_i64->interface~show_message dsyrk dsyrk proc~oqp_dsyrk_i64->dsyrk proc~oqp_dsysv_i64 oqp_dsysv_i64 proc~oqp_dsysv_i64->interface~show_message dsysv dsysv proc~oqp_dsysv_i64->dsysv proc~oqp_dtbmv_i64 oqp_dtbmv_i64 proc~oqp_dtbmv_i64->interface~show_message dtbmv dtbmv proc~oqp_dtbmv_i64->dtbmv proc~oqp_dtbsv_i64 oqp_dtbsv_i64 proc~oqp_dtbsv_i64->interface~show_message dtbsv dtbsv proc~oqp_dtbsv_i64->dtbsv proc~oqp_dtpmv_i64 oqp_dtpmv_i64 proc~oqp_dtpmv_i64->interface~show_message dtpmv dtpmv proc~oqp_dtpmv_i64->dtpmv proc~oqp_dtpsv_i64 oqp_dtpsv_i64 proc~oqp_dtpsv_i64->interface~show_message dtpsv dtpsv proc~oqp_dtpsv_i64->dtpsv proc~oqp_dtpttr_i64 oqp_dtpttr_i64 proc~oqp_dtpttr_i64->interface~show_message dtpttr dtpttr proc~oqp_dtpttr_i64->dtpttr proc~oqp_dtrmm_i64 oqp_dtrmm_i64 proc~oqp_dtrmm_i64->interface~show_message dtrmm dtrmm proc~oqp_dtrmm_i64->dtrmm proc~oqp_dtrmv_i64 oqp_dtrmv_i64 proc~oqp_dtrmv_i64->interface~show_message dtrmv dtrmv proc~oqp_dtrmv_i64->dtrmv proc~oqp_dtrsm_i64 oqp_dtrsm_i64 proc~oqp_dtrsm_i64->interface~show_message dtrsm dtrsm proc~oqp_dtrsm_i64->dtrsm proc~oqp_dtrsv_i64 oqp_dtrsv_i64 proc~oqp_dtrsv_i64->interface~show_message dtrsv dtrsv proc~oqp_dtrsv_i64->dtrsv proc~oqp_dtrttp_i64 oqp_dtrttp_i64 proc~oqp_dtrttp_i64->interface~show_message dtrttp dtrttp proc~oqp_dtrttp_i64->dtrttp proc~oqp_dzasum_i64 oqp_dzasum_i64 proc~oqp_dzasum_i64->interface~show_message dzasum dzasum proc~oqp_dzasum_i64->dzasum proc~oqp_dznrm2_i64 oqp_dznrm2_i64 proc~oqp_dznrm2_i64->interface~show_message dznrm2 dznrm2 proc~oqp_dznrm2_i64->dznrm2 proc~oqp_handle_refresh_ptr oqp_handle_refresh_ptr proc~oqp_icamax_i64 oqp_icamax_i64 proc~oqp_icamax_i64->interface~show_message icamax icamax proc~oqp_icamax_i64->icamax proc~oqp_idamax_i64 oqp_idamax_i64 proc~oqp_idamax_i64->interface~show_message idamax idamax proc~oqp_idamax_i64->idamax proc~oqp_init oqp_init proc~oqp_init->proc~oqp_handle_refresh_ptr new new proc~oqp_init->new proc~oqp_isamax_i64 oqp_isamax_i64 proc~oqp_isamax_i64->interface~show_message isamax isamax proc~oqp_isamax_i64->isamax proc~oqp_izamax_i64 oqp_izamax_i64 proc~oqp_izamax_i64->interface~show_message izamax izamax proc~oqp_izamax_i64->izamax proc~oqp_resp_charges oqp_resp_charges proc~oqp_resp_charges->interface~data_has_tags proc~oqp_resp_charges->interface~show_message proc~oqp_resp_charges->interface~tagarray_get_data proc~oqp_resp_charges->proc~electrostatic_potential proc~oqp_resp_charges->proc~lebedev_get_grid proc~oqp_resp_charges->proc~oqp_dgemm_i64 proc~oqp_resp_charges->proc~oqp_dgemv_i64 proc~oqp_resp_charges->proc~oqp_dgesv_i64 proc~oqp_sasum_i64 oqp_sasum_i64 proc~oqp_sasum_i64->interface~show_message sasum sasum proc~oqp_sasum_i64->sasum proc~oqp_saxpy_i64 oqp_saxpy_i64 proc~oqp_saxpy_i64->interface~show_message saxpy saxpy proc~oqp_saxpy_i64->saxpy proc~oqp_scasum_i64 oqp_scasum_i64 proc~oqp_scasum_i64->interface~show_message scasum scasum proc~oqp_scasum_i64->scasum proc~oqp_scnrm2_i64 oqp_scnrm2_i64 proc~oqp_scnrm2_i64->interface~show_message scnrm2 scnrm2 proc~oqp_scnrm2_i64->scnrm2 proc~oqp_scopy_i64 oqp_scopy_i64 proc~oqp_scopy_i64->interface~show_message scopy scopy proc~oqp_scopy_i64->scopy proc~oqp_sdot_i64 oqp_sdot_i64 proc~oqp_sdot_i64->interface~show_message sdot sdot proc~oqp_sdot_i64->sdot proc~oqp_sdsdot_i64 oqp_sdsdot_i64 proc~oqp_sdsdot_i64->interface~show_message sdsdot sdsdot proc~oqp_sdsdot_i64->sdsdot proc~oqp_sgbmv_i64 oqp_sgbmv_i64 proc~oqp_sgbmv_i64->interface~show_message sgbmv sgbmv proc~oqp_sgbmv_i64->sgbmv proc~oqp_sgemm_i64 oqp_sgemm_i64 proc~oqp_sgemm_i64->interface~show_message sgemm sgemm proc~oqp_sgemm_i64->sgemm proc~oqp_sgemv_i64 oqp_sgemv_i64 proc~oqp_sgemv_i64->interface~show_message sgemv sgemv proc~oqp_sgemv_i64->sgemv proc~oqp_sger_i64 oqp_sger_i64 proc~oqp_sger_i64->interface~show_message sger sger proc~oqp_sger_i64->sger proc~oqp_snrm2_i64 oqp_snrm2_i64 proc~oqp_snrm2_i64->interface~show_message snrm2 snrm2 proc~oqp_snrm2_i64->snrm2 proc~oqp_srot_i64 oqp_srot_i64 proc~oqp_srot_i64->interface~show_message srot srot proc~oqp_srot_i64->srot proc~oqp_srotm_i64 oqp_srotm_i64 proc~oqp_srotm_i64->interface~show_message srotm srotm proc~oqp_srotm_i64->srotm proc~oqp_ssbmv_i64 oqp_ssbmv_i64 proc~oqp_ssbmv_i64->interface~show_message ssbmv ssbmv proc~oqp_ssbmv_i64->ssbmv proc~oqp_sscal_i64 oqp_sscal_i64 proc~oqp_sscal_i64->interface~show_message sscal sscal proc~oqp_sscal_i64->sscal proc~oqp_sspmv_i64 oqp_sspmv_i64 proc~oqp_sspmv_i64->interface~show_message sspmv sspmv proc~oqp_sspmv_i64->sspmv proc~oqp_sspr2_i64 oqp_sspr2_i64 proc~oqp_sspr2_i64->interface~show_message sspr2 sspr2 proc~oqp_sspr2_i64->sspr2 proc~oqp_sspr_i64 oqp_sspr_i64 proc~oqp_sspr_i64->interface~show_message sspr sspr proc~oqp_sspr_i64->sspr proc~oqp_sswap_i64 oqp_sswap_i64 proc~oqp_sswap_i64->interface~show_message sswap sswap proc~oqp_sswap_i64->sswap proc~oqp_ssymm_i64 oqp_ssymm_i64 proc~oqp_ssymm_i64->interface~show_message ssymm ssymm proc~oqp_ssymm_i64->ssymm proc~oqp_ssymv_i64 oqp_ssymv_i64 proc~oqp_ssymv_i64->interface~show_message ssymv ssymv proc~oqp_ssymv_i64->ssymv proc~oqp_ssyr2_i64 oqp_ssyr2_i64 proc~oqp_ssyr2_i64->interface~show_message ssyr2 ssyr2 proc~oqp_ssyr2_i64->ssyr2 proc~oqp_ssyr2k_i64 oqp_ssyr2k_i64 proc~oqp_ssyr2k_i64->interface~show_message ssyr2k ssyr2k proc~oqp_ssyr2k_i64->ssyr2k proc~oqp_ssyr_i64 oqp_ssyr_i64 proc~oqp_ssyr_i64->interface~show_message ssyr ssyr proc~oqp_ssyr_i64->ssyr proc~oqp_ssyrk_i64 oqp_ssyrk_i64 proc~oqp_ssyrk_i64->interface~show_message ssyrk ssyrk proc~oqp_ssyrk_i64->ssyrk proc~oqp_stbmv_i64 oqp_stbmv_i64 proc~oqp_stbmv_i64->interface~show_message stbmv stbmv proc~oqp_stbmv_i64->stbmv proc~oqp_stbsv_i64 oqp_stbsv_i64 proc~oqp_stbsv_i64->interface~show_message stbsv stbsv proc~oqp_stbsv_i64->stbsv proc~oqp_stpmv_i64 oqp_stpmv_i64 proc~oqp_stpmv_i64->interface~show_message stpmv stpmv proc~oqp_stpmv_i64->stpmv proc~oqp_stpsv_i64 oqp_stpsv_i64 proc~oqp_stpsv_i64->interface~show_message stpsv stpsv proc~oqp_stpsv_i64->stpsv proc~oqp_strmm_i64 oqp_strmm_i64 proc~oqp_strmm_i64->interface~show_message strmm strmm proc~oqp_strmm_i64->strmm proc~oqp_strmv_i64 oqp_strmv_i64 proc~oqp_strmv_i64->interface~show_message strmv strmv proc~oqp_strmv_i64->strmv proc~oqp_strsm_i64 oqp_strsm_i64 proc~oqp_strsm_i64->interface~show_message strsm strsm proc~oqp_strsm_i64->strsm proc~oqp_strsv_i64 oqp_strsv_i64 proc~oqp_strsv_i64->interface~show_message strsv strsv proc~oqp_strsv_i64->strsv proc~oqp_tdhf_z_vector oqp_tdhf_z_vector proc~oqp_tdhf_z_vector->interface~data_has_tags proc~oqp_tdhf_z_vector->interface~pack_matrix proc~oqp_tdhf_z_vector->interface~show_message proc~oqp_tdhf_z_vector->interface~tagarray_get_data proc~oqp_tdhf_z_vector->interface~unpack_matrix proc~oqp_tdhf_z_vector->proc~dft_initialize proc~oqp_tdhf_z_vector->proc~dftclean proc~oqp_tdhf_z_vector->proc~iatogen proc~oqp_tdhf_z_vector->proc~int2_rpagrd_data_t_clean proc~oqp_tdhf_z_vector->proc~measure_time proc~oqp_tdhf_z_vector->proc~oqp_dgemm_i64 proc~oqp_tdhf_z_vector->proc~oqp_dsyr2k_i64 proc~oqp_tdhf_z_vector->proc~orthogonal_transform proc~oqp_tdhf_z_vector->proc~print_module_info proc~oqp_tdhf_z_vector->proc~symmetrize_matrix proc~tddft_fxc tddft_fxc proc~oqp_tdhf_z_vector->proc~tddft_fxc proc~tddft_gxc tddft_gxc proc~oqp_tdhf_z_vector->proc~tddft_gxc proc~tdhf_unrelaxed_density tdhf_unrelaxed_density proc~oqp_tdhf_z_vector->proc~tdhf_unrelaxed_density proc~oqp_tdhf_z_vector->proc~triangular_to_full none~clean~17 int2_fock_data_t%clean proc~oqp_tdhf_z_vector->none~clean~17 proc~oqp_tdhf_z_vector->none~init~16 proc~oqp_tdhf_z_vector->none~run~6 proc~oqp_tdhf_z_vector->none~set_screening~2 none~step pcg_t%step proc~oqp_tdhf_z_vector->none~step proc~oqp_tdhf_z_vector->remove_records proc~oqp_tdhf_z_vector->reserve_data proc~oqp_xerbla_i64 oqp_xerbla_i64 proc~oqp_xerbla_i64->interface~show_message xerbla xerbla proc~oqp_xerbla_i64->xerbla proc~oqp_zaxpy_i64 oqp_zaxpy_i64 proc~oqp_zaxpy_i64->interface~show_message zaxpy zaxpy proc~oqp_zaxpy_i64->zaxpy proc~oqp_zcopy_i64 oqp_zcopy_i64 proc~oqp_zcopy_i64->interface~show_message zcopy zcopy proc~oqp_zcopy_i64->zcopy proc~oqp_zdotc_i64 oqp_zdotc_i64 proc~oqp_zdotc_i64->interface~show_message zdotc zdotc proc~oqp_zdotc_i64->zdotc proc~oqp_zdotu_i64 oqp_zdotu_i64 proc~oqp_zdotu_i64->interface~show_message zdotu zdotu proc~oqp_zdotu_i64->zdotu proc~oqp_zdrot_i64 oqp_zdrot_i64 proc~oqp_zdrot_i64->interface~show_message zdrot zdrot proc~oqp_zdrot_i64->zdrot proc~oqp_zdscal_i64 oqp_zdscal_i64 proc~oqp_zdscal_i64->interface~show_message zdscal zdscal proc~oqp_zdscal_i64->zdscal proc~oqp_zgbmv_i64 oqp_zgbmv_i64 proc~oqp_zgbmv_i64->interface~show_message zgbmv zgbmv proc~oqp_zgbmv_i64->zgbmv proc~oqp_zgemm_i64 oqp_zgemm_i64 proc~oqp_zgemm_i64->interface~show_message zgemm zgemm proc~oqp_zgemm_i64->zgemm proc~oqp_zgemv_i64 oqp_zgemv_i64 proc~oqp_zgemv_i64->interface~show_message zgemv zgemv proc~oqp_zgemv_i64->zgemv proc~oqp_zgerc_i64 oqp_zgerc_i64 proc~oqp_zgerc_i64->interface~show_message zgerc zgerc proc~oqp_zgerc_i64->zgerc proc~oqp_zgeru_i64 oqp_zgeru_i64 proc~oqp_zgeru_i64->interface~show_message zgeru zgeru proc~oqp_zgeru_i64->zgeru proc~oqp_zhbmv_i64 oqp_zhbmv_i64 proc~oqp_zhbmv_i64->interface~show_message zhbmv zhbmv proc~oqp_zhbmv_i64->zhbmv proc~oqp_zhemm_i64 oqp_zhemm_i64 proc~oqp_zhemm_i64->interface~show_message zhemm zhemm proc~oqp_zhemm_i64->zhemm proc~oqp_zhemv_i64 oqp_zhemv_i64 proc~oqp_zhemv_i64->interface~show_message zhemv zhemv proc~oqp_zhemv_i64->zhemv proc~oqp_zher2_i64 oqp_zher2_i64 proc~oqp_zher2_i64->interface~show_message zher2 zher2 proc~oqp_zher2_i64->zher2 proc~oqp_zher2k_i64 oqp_zher2k_i64 proc~oqp_zher2k_i64->interface~show_message zher2k zher2k proc~oqp_zher2k_i64->zher2k proc~oqp_zher_i64 oqp_zher_i64 proc~oqp_zher_i64->interface~show_message zher zher proc~oqp_zher_i64->zher proc~oqp_zherk_i64 oqp_zherk_i64 proc~oqp_zherk_i64->interface~show_message zherk zherk proc~oqp_zherk_i64->zherk proc~oqp_zhpmv_i64 oqp_zhpmv_i64 proc~oqp_zhpmv_i64->interface~show_message zhpmv zhpmv proc~oqp_zhpmv_i64->zhpmv proc~oqp_zhpr2_i64 oqp_zhpr2_i64 proc~oqp_zhpr2_i64->interface~show_message zhpr2 zhpr2 proc~oqp_zhpr2_i64->zhpr2 proc~oqp_zhpr_i64 oqp_zhpr_i64 proc~oqp_zhpr_i64->interface~show_message zhpr zhpr proc~oqp_zhpr_i64->zhpr proc~oqp_zscal_i64 oqp_zscal_i64 proc~oqp_zscal_i64->interface~show_message zscal zscal proc~oqp_zscal_i64->zscal proc~oqp_zswap_i64 oqp_zswap_i64 proc~oqp_zswap_i64->interface~show_message zswap zswap proc~oqp_zswap_i64->zswap proc~oqp_zsymm_i64 oqp_zsymm_i64 proc~oqp_zsymm_i64->interface~show_message zsymm zsymm proc~oqp_zsymm_i64->zsymm proc~oqp_zsyr2k_i64 oqp_zsyr2k_i64 proc~oqp_zsyr2k_i64->interface~show_message zsyr2k zsyr2k proc~oqp_zsyr2k_i64->zsyr2k proc~oqp_zsyrk_i64 oqp_zsyrk_i64 proc~oqp_zsyrk_i64->interface~show_message zsyrk zsyrk proc~oqp_zsyrk_i64->zsyrk proc~oqp_ztbmv_i64 oqp_ztbmv_i64 proc~oqp_ztbmv_i64->interface~show_message ztbmv ztbmv proc~oqp_ztbmv_i64->ztbmv proc~oqp_ztbsv_i64 oqp_ztbsv_i64 proc~oqp_ztbsv_i64->interface~show_message ztbsv ztbsv proc~oqp_ztbsv_i64->ztbsv proc~oqp_ztpmv_i64 oqp_ztpmv_i64 proc~oqp_ztpmv_i64->interface~show_message ztpmv ztpmv proc~oqp_ztpmv_i64->ztpmv proc~oqp_ztpsv_i64 oqp_ztpsv_i64 proc~oqp_ztpsv_i64->interface~show_message ztpsv ztpsv proc~oqp_ztpsv_i64->ztpsv proc~oqp_ztrmm_i64 oqp_ztrmm_i64 proc~oqp_ztrmm_i64->interface~show_message ztrmm ztrmm proc~oqp_ztrmm_i64->ztrmm proc~oqp_ztrmv_i64 oqp_ztrmv_i64 proc~oqp_ztrmv_i64->interface~show_message ztrmv ztrmv proc~oqp_ztrmv_i64->ztrmv proc~oqp_ztrsm_i64 oqp_ztrsm_i64 proc~oqp_ztrsm_i64->interface~show_message ztrsm ztrsm proc~oqp_ztrsm_i64->ztrsm proc~oqp_ztrsv_i64 oqp_ztrsv_i64 proc~oqp_ztrsv_i64->interface~show_message ztrsv ztrsv proc~oqp_ztrsv_i64->ztrsv proc~orb_to_dens->interface~pack_matrix proc~orb_to_dens->proc~oqp_dsyr2k_i64 proc~orthogonal_transform->interface~show_message proc~orthogonal_transform->proc~oqp_dgemm_i64 proc~orthogonal_transform2->interface~show_message proc~orthogonal_transform2->proc~oqp_dgemm_i64 proc~orthogonal_transform_sym->interface~show_message proc~orthogonal_transform_sym->proc~oqp_dgemm_i64 proc~orthogonal_transform_sym->proc~oqp_dsymm_i64 proc~orthogonal_transform_sym->proc~oqp_dtpttr_i64 proc~orthogonal_transform_sym->proc~oqp_dtrttp_i64 proc~ov_exact->proc~comp_det proc~overlap->proc~comp_kin_ovl_int1_prim proc~overlap->proc~update_triang_matrix proc~overlap->none~alloc~2 proc~overlap->none~fetch_by_id proc~overlap->none~shell_pair proc~pack_f90->interface~show_message proc~pack_f90->proc~oqp_dtrttp_i64 proc~pcg_optimize pcg_optimize proc~pcg_optimize->interface~show_message none~init~3 pcg_t%init proc~pcg_optimize->none~init~3 proc~pcg_optimize->none~step proc~pcgb pcgb proc~pcgrbpini pcgrbpini proc~pfon_occupations pfon_occupations proc~print_eigvec_vals_labeled print_eigvec_vals_labeled proc~print_eigvec_vals_labeled->interface~data_has_tags proc~print_eigvec_vals_labeled->interface~tagarray_get_data proc~print_eigvec_vals_labeled->none~bf_label proc~print_ev_sol print_ev_sol proc~print_mo_range print_mo_range proc~print_mo_range->proc~print_eigvec_vals_labeled proc~print_nac print_nac proc~print_results~2 print_results proc~print_scf_energy print_scf_energy proc~print_square print_square proc~print_sym print_sym proc~print_sym_labeled->none~bf_label proc~print_sympack print_sympack proc~prune_basis prune_basis proc~remove_spaces remove_spaces proc~reordermos->dswap proc~resp_charges_c resp_charges_C proc~resp_charges_c->interface~oqp_handle_get_info proc~resp_charges_c->proc~oqp_resp_charges proc~rpaechk rpaechk proc~rpaeig rpaeig proc~rpaeig->proc~diag_symm_packed proc~rpaeig->proc~oqp_dgemm_i64 proc~rpaeig->proc~oqp_dtrttp_i64 proc~rpaexpndv rpaexpndv proc~rpaexpndv->proc~oqp_dgemm_i64 proc~rpanewb rpanewb proc~rpaprint rpaprint proc~rparedms rparedms proc~rparedms->proc~oqp_dgemm_i64 proc~rparesvec rparesvec proc~rpavnorm rpavnorm proc~run_population_analysis->interface~data_has_tags proc~run_population_analysis->interface~show_message proc~run_population_analysis->interface~tagarray_get_data proc~run_population_analysis->interface~unpack_matrix proc~run_population_analysis->proc~diag_symm_packed proc~run_population_analysis->proc~oqp_dgemm_i64 proc~run_xc->none~allreduce none~compaos xc_engine_t%compAOs proc~run_xc->none~compaos none~compxc xc_engine_t%compXC proc~run_xc->none~compxc none~getslicenonzero dft_grid_t%getSliceNonZero proc~run_xc->none~getslicenonzero none~getstats xc_engine_t%getStats proc~run_xc->none~getstats none~init~18 xc_engine_t%init proc~run_xc->none~init~18 none~pruneaos xc_engine_t%pruneAOs proc~run_xc->none~pruneaos none~resetpointers xc_engine_t%resetPointers proc~run_xc->none~resetpointers parallel_start parallel_start proc~run_xc->parallel_start parallel_stop parallel_stop proc~run_xc->parallel_stop postUpdate postUpdate proc~run_xc->postUpdate update update proc~run_xc->update proc~rys_print_eri rys_print_eri proc~scf_driver->interface~data_has_tags proc~scf_driver->interface~show_message proc~scf_driver->interface~tagarray_get_data proc~scf_driver->interface~unpack_matrix proc~scf_driver->none~bcast proc~scf_driver->proc~build_pfon_density proc~scf_driver->proc~dftexcor proc~scf_driver->proc~e_charge_repulsion proc~scf_driver->proc~form_rohf_fock proc~scf_driver->proc~get_ab_initio_density proc~scf_driver->proc~get_ab_initio_orbital proc~scf_driver->proc~matrix_invsqrt proc~scf_driver->proc~measure_time proc~scf_driver->proc~mo_reorder proc~scf_driver->proc~mo_to_ao proc~scf_driver->proc~pfon_occupations proc~scf_driver->proc~print_mo_range proc~scf_driver->proc~print_scf_energy proc~scf_driver->proc~traceprod_sym_packed none~add_data scf_conv%add_data proc~scf_driver->none~add_data proc~scf_driver->none~clean~18 none~get_fock scf_conv_result%get_fock proc~scf_driver->none~get_fock proc~scf_driver->none~init~16 proc~scf_driver->none~run~6 proc~scf_driver->none~set_screening~2 proc~schmd->interface~show_message proc~schmd->proc~oqp_dgeqrf_i64 proc~schmd->proc~oqp_dorgqr_i64 proc~setpts xc_libxc_t%setPts proc~sfdmat sfdmat proc~sfdmat->interface~pack_matrix proc~sfdmat->proc~iatogen proc~sfdmat->proc~oqp_dgemm_i64 proc~sfdmat->proc~orthogonal_transform proc~sfesum sfesum proc~sfqvec sfqvec proc~sfresvec sfresvec proc~sfresvec->proc~oqp_dgemm_i64 proc~sfroesum sfroesum proc~sfrogen sfrogen proc~sfrolhs sfrolhs proc~sfromcal sfromcal proc~sfropcal sfropcal proc~sfrorhs sfrorhs proc~sfrorhs->proc~oqp_dgemm_i64 proc~sfrowcal sfrowcal proc~sfrowcal->proc~oqp_dgemm_i64 proc~solve_linear_equations solve_linear_equations proc~solve_linear_equations->interface~show_message proc~solve_linear_equations->proc~oqp_dsysv_i64 proc~symmetrize_matrices->proc~symmetrize_matrix proc~tagarray_get_cptr tagarray_get_cptr dimensions dimensions proc~tagarray_get_cptr->dimensions get_record_info get_record_info proc~tagarray_get_cptr->get_record_info proc~tagarray_get_cptr->get_status proc~td_print_results td_print_results proc~tddft_fxc->proc~run_xc proc~tddft_fxc->proc~triangular_to_full none~clean~21 xc_consumer_tde_t%clean proc~tddft_fxc->none~clean~21 proc~tddft_fxc->none~init~14 proc~tddft_gxc->proc~run_xc proc~tddft_gxc->proc~triangular_to_full proc~tddft_gxc->none~clean~21 proc~tddft_gxc->none~init~14 proc~tddft_xc_gradient tddft_xc_gradient proc~tddft_xc_gradient->proc~run_xc none~clean~23 xc_consumer_tdg_t%clean proc~tddft_xc_gradient->none~clean~23 proc~tddft_xc_gradient->none~init~14 proc~tdhf_1e_grad tdhf_1e_grad proc~tdhf_1e_grad->interface~data_has_tags proc~tdhf_1e_grad->interface~show_message proc~tdhf_1e_grad->interface~tagarray_get_data proc~tdhf_1e_grad->proc~eijden proc~tdhf_1e_grad->proc~grad_1e_ecp proc~tdhf_1e_grad->proc~grad_ee_kinetic proc~tdhf_1e_grad->proc~grad_ee_overlap proc~tdhf_1e_grad->proc~grad_en_hellman_feynman proc~tdhf_1e_grad->proc~grad_en_pulay proc~tdhf_1e_grad->proc~grad_nn proc~tdhf_2e_grad tdhf_2e_grad proc~tdhf_2e_grad->interface~show_message proc~tdhf_2e_grad->proc~grd2_driver proc~tdhf_2e_grad->clean proc~tdhf_2e_grad->init proc~tdhf_energy tdhf_energy proc~tdhf_energy->interface~data_has_tags proc~tdhf_energy->interface~show_message proc~tdhf_energy->interface~tagarray_get_data proc~tdhf_energy->proc~dft_initialize proc~tdhf_energy->proc~dftclean proc~tdhf_energy->proc~esum proc~tdhf_energy->proc~get_td_transition_dipole proc~tdhf_energy->proc~iatogen proc~tdhf_energy->proc~inivec proc~tdhf_energy->proc~measure_time proc~tdhf_energy->proc~mntoia proc~tdhf_energy->proc~orthogonal_transform proc~tdhf_energy->proc~print_module_info proc~tdhf_energy->proc~rpaechk proc~tdhf_energy->proc~rpaeig proc~tdhf_energy->proc~rpaexpndv proc~tdhf_energy->proc~rpanewb proc~tdhf_energy->proc~rpaprint proc~tdhf_energy->proc~rparedms proc~tdhf_energy->proc~rparesvec proc~tdhf_energy->proc~rpavnorm proc~tdhf_energy->proc~symmetrize_matrix proc~tdhf_energy->proc~td_print_results proc~tdhf_energy->proc~tddft_fxc proc~tdhf_energy->none~clean~18 proc~tdhf_energy->none~init~16 proc~tdhf_energy->none~run~6 proc~tdhf_energy->none~set_screening~2 proc~tdhf_energy->remove_records proc~tdhf_energy->reserve_data proc~tdhf_energy_c tdhf_energy_C proc~tdhf_energy_c->interface~oqp_handle_get_info proc~tdhf_energy_c->proc~tdhf_energy proc~tdhf_gradient tdhf_gradient proc~tdhf_gradient->interface~data_has_tags proc~tdhf_gradient->interface~show_message proc~tdhf_gradient->interface~tagarray_get_data proc~tdhf_gradient->interface~unpack_matrix proc~tdhf_gradient->proc~dft_initialize proc~tdhf_gradient->proc~dftclean proc~tdhf_gradient->proc~iatogen proc~tdhf_gradient->proc~measure_time proc~tdhf_gradient->proc~orthogonal_transform proc~tdhf_gradient->proc~print_gradient proc~tdhf_gradient->proc~print_module_info proc~tdhf_gradient->proc~symmetrize_matrix proc~tdhf_gradient->proc~tddft_xc_gradient proc~tdhf_gradient->proc~tdhf_1e_grad proc~tdhf_gradient->proc~tdhf_2e_grad proc~tdhf_gradient_c tdhf_gradient_C proc~tdhf_gradient_c->interface~oqp_handle_get_info proc~tdhf_gradient_c->proc~tdhf_gradient proc~tdhf_mrsf_energy tdhf_mrsf_energy proc~tdhf_mrsf_energy->interface~data_has_tags proc~tdhf_mrsf_energy->interface~show_message proc~tdhf_mrsf_energy->interface~tagarray_get_data proc~tdhf_mrsf_energy->interface~unpack_matrix proc~tdhf_mrsf_energy->proc~get_mrsf_transition_density proc~tdhf_mrsf_energy->proc~get_mrsf_transitions proc~tdhf_mrsf_energy->proc~get_transition_density proc~tdhf_mrsf_energy->proc~get_transition_dipole proc~tdhf_mrsf_energy->proc~get_transitions proc~tdhf_mrsf_energy->proc~iatogen proc~tdhf_mrsf_energy->proc~inivec proc~tdhf_mrsf_energy->proc~measure_time proc~tdhf_mrsf_energy->proc~mntoia proc~tdhf_mrsf_energy->proc~mrinivec proc~tdhf_mrsf_energy->proc~mrsfcbc proc~tdhf_mrsf_energy->proc~mrsfesum proc~tdhf_mrsf_energy->proc~mrsfmntoia proc~tdhf_mrsf_energy->proc~mrsfqroesum proc~tdhf_mrsf_energy->proc~oqp_dgemm_i64 proc~tdhf_mrsf_energy->proc~orthogonal_transform proc~tdhf_mrsf_energy->proc~orthogonal_transform_sym proc~tdhf_mrsf_energy->proc~print_module_info proc~tdhf_mrsf_energy->proc~print_results~2 proc~tdhf_mrsf_energy->proc~rpaechk proc~tdhf_mrsf_energy->proc~rpaeig proc~tdhf_mrsf_energy->proc~rpanewb proc~tdhf_mrsf_energy->proc~rpaprint proc~tdhf_mrsf_energy->proc~rparedms proc~tdhf_mrsf_energy->proc~rpavnorm proc~tdhf_mrsf_energy->proc~sfqvec proc~tdhf_mrsf_energy->proc~sfresvec proc~trfrmb trfrmb proc~tdhf_mrsf_energy->proc~trfrmb proc~tdhf_mrsf_energy->none~clean~18 proc~tdhf_mrsf_energy->none~init~16 proc~tdhf_mrsf_energy->none~run~6 proc~tdhf_mrsf_energy->none~set_screening~2 proc~tdhf_mrsf_energy->remove_records proc~tdhf_mrsf_energy->reserve_data proc~tdhf_mrsf_energy_c tdhf_mrsf_energy_C proc~tdhf_mrsf_energy_c->interface~oqp_handle_get_info proc~tdhf_mrsf_energy_c->proc~tdhf_mrsf_energy proc~tdhf_sf_energy tdhf_sf_energy proc~tdhf_sf_energy->interface~data_has_tags proc~tdhf_sf_energy->interface~show_message proc~tdhf_sf_energy->interface~tagarray_get_data proc~tdhf_sf_energy->interface~unpack_matrix proc~tdhf_sf_energy->proc~get_spin_square proc~tdhf_sf_energy->proc~get_transition_density proc~tdhf_sf_energy->proc~get_transition_dipole proc~tdhf_sf_energy->proc~get_transitions proc~tdhf_sf_energy->proc~iatogen proc~tdhf_sf_energy->proc~inivec proc~tdhf_sf_energy->proc~measure_time proc~tdhf_sf_energy->proc~mntoia proc~tdhf_sf_energy->proc~oqp_dgemm_i64 proc~tdhf_sf_energy->proc~orthogonal_transform_sym proc~tdhf_sf_energy->proc~print_module_info proc~tdhf_sf_energy->proc~print_results~2 proc~tdhf_sf_energy->proc~rpaechk proc~tdhf_sf_energy->proc~rpaeig proc~tdhf_sf_energy->proc~rpanewb proc~tdhf_sf_energy->proc~rpaprint proc~tdhf_sf_energy->proc~rparedms proc~tdhf_sf_energy->proc~rpavnorm proc~tdhf_sf_energy->proc~sfdmat proc~tdhf_sf_energy->proc~sfesum proc~tdhf_sf_energy->proc~sfqvec proc~tdhf_sf_energy->proc~sfresvec proc~tdhf_sf_energy->proc~sfroesum proc~tdhf_sf_energy->proc~trfrmb proc~tdhf_sf_energy->none~clean~18 proc~tdhf_sf_energy->none~init~16 proc~tdhf_sf_energy->none~run~6 proc~tdhf_sf_energy->none~set_screening~2 proc~tdhf_sf_energy->remove_records proc~tdhf_sf_energy->reserve_data proc~tdhf_sf_energy_c tdhf_sf_energy_C proc~tdhf_sf_energy_c->interface~oqp_handle_get_info proc~tdhf_sf_energy_c->proc~tdhf_sf_energy proc~tdhf_unrelaxed_density->interface~pack_matrix proc~tdhf_unrelaxed_density->proc~oqp_dgemm_i64 proc~tdhf_unrelaxed_density->proc~orthogonal_transform proc~tdhf_z_vector_c tdhf_z_vector_C proc~tdhf_z_vector_c->interface~oqp_handle_get_info proc~tdhf_z_vector_c->proc~oqp_tdhf_z_vector proc~to_lower to_lower proc~trfrmb->proc~oqp_dgemm_i64 proc~triangular_to_full->interface~show_message proc~unpack_f90->interface~show_message proc~unpack_f90->proc~oqp_dtpttr_i64 proc~utddft_fxc utddft_fxc proc~utddft_fxc->proc~run_xc proc~utddft_fxc->proc~triangular_to_full proc~utddft_fxc->none~clean~21 proc~utddft_xc_gradient utddft_xc_gradient proc~utddft_xc_gradient->proc~run_xc proc~utddft_xc_gradient->none~clean~23 proc~utddft_xc_gradient->none~init~14 proc~xc_der1 xc_der1 proc~xc_der2_contr xc_der2_contr proc~xc_der3_contr xc_der3_contr
Help