2015-11-24 11:16:14 +01:00
|
|
|
BEGIN_TEMPLATE
|
|
|
|
|
|
|
|
subroutine pt2_epstein_nesbet ($arguments)
|
2014-05-18 22:46:38 +02:00
|
|
|
use bitmasks
|
|
|
|
implicit none
|
2015-11-24 11:16:14 +01:00
|
|
|
$declarations
|
2015-11-19 17:16:24 +01:00
|
|
|
|
2014-05-18 22:46:38 +02:00
|
|
|
BEGIN_DOC
|
|
|
|
! compute the standard Epstein-Nesbet perturbative first order coefficient and second order energetic contribution
|
|
|
|
!
|
2014-05-28 23:12:00 +02:00
|
|
|
! for the various N_st states.
|
2014-05-18 22:46:38 +02:00
|
|
|
!
|
|
|
|
! c_pert(i) = <psi(i)|H|det_pert>/( E(i) - <det_pert|H|det_pert> )
|
|
|
|
!
|
|
|
|
! e_2_pert(i) = <psi(i)|H|det_pert>^2/( E(i) - <det_pert|H|det_pert> )
|
|
|
|
!
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
integer :: i,j
|
2015-11-24 17:01:09 +01:00
|
|
|
double precision :: diag_H_mat_elem_fock, h
|
2015-11-24 11:16:14 +01:00
|
|
|
double precision :: i_H_psi_array(N_st)
|
2014-10-15 15:19:34 +02:00
|
|
|
PROVIDE selection_criterion
|
|
|
|
|
2014-05-18 22:46:38 +02:00
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
2015-11-19 17:16:24 +01:00
|
|
|
!call i_H_psi(det_pert,psi_selectors,psi_selectors_coef,Nint,N_det_selectors,psi_selectors_size,N_st,i_H_psi_array)
|
2015-11-20 09:26:45 +01:00
|
|
|
call i_H_psi_minilist(det_pert,minilist,idx_minilist,N_minilist,psi_selectors_coef,Nint,N_minilist,psi_selectors_size,N_st,i_H_psi_array)
|
2015-11-19 17:16:24 +01:00
|
|
|
|
|
|
|
|
2015-11-24 17:01:09 +01:00
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
2014-05-28 23:12:00 +02:00
|
|
|
do i =1,N_st
|
2016-04-01 23:33:58 +02:00
|
|
|
if(electronic_energy(i)>h.and.electronic_energy(i).ne.0.d0)then
|
2014-06-01 22:03:26 +02:00
|
|
|
c_pert(i) = -1.d0
|
|
|
|
e_2_pert(i) = selection_criterion*selection_criterion_factor*2.d0
|
2016-04-01 23:33:58 +02:00
|
|
|
else if (dabs(electronic_energy(i) - h) > 1.d-6) then
|
|
|
|
c_pert(i) = i_H_psi_array(i) / (electronic_energy(i) - h)
|
2014-05-30 18:07:04 +02:00
|
|
|
H_pert_diag(i) = h*c_pert(i)*c_pert(i)
|
2014-05-27 17:30:44 +02:00
|
|
|
e_2_pert(i) = c_pert(i) * i_H_psi_array(i)
|
|
|
|
else
|
2014-05-30 18:07:04 +02:00
|
|
|
c_pert(i) = -1.d0
|
|
|
|
e_2_pert(i) = -dabs(i_H_psi_array(i))
|
|
|
|
H_pert_diag(i) = h
|
2014-05-27 17:30:44 +02:00
|
|
|
endif
|
|
|
|
enddo
|
2014-05-18 22:46:38 +02:00
|
|
|
|
|
|
|
end
|
|
|
|
|
2016-08-26 18:00:49 +02:00
|
|
|
|
|
|
|
subroutine pt2_decontracted ($arguments)
|
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
$declarations
|
|
|
|
|
|
|
|
BEGIN_DOC
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
integer :: i,j
|
|
|
|
double precision :: diag_H_mat_elem_fock, h
|
|
|
|
double precision :: i_H_psi_array(N_st)
|
|
|
|
double precision :: coef_pert
|
|
|
|
PROVIDE selection_criterion
|
|
|
|
|
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
|
|
|
!call i_H_psi(det_pert,psi_selectors,psi_selectors_coef,Nint,N_det_selectors,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
call i_H_psi_pert_new_minilist(det_pert,minilist,idx_minilist,N_minilist,psi_selectors_coef,Nint,N_minilist,psi_selectors_size,N_st,i_H_psi_array,coef_pert)
|
2016-11-02 16:11:13 +01:00
|
|
|
H_pert_diag = 0.d0
|
2016-08-26 18:00:49 +02:00
|
|
|
|
|
|
|
|
|
|
|
c_pert(1) = coef_pert
|
|
|
|
e_2_pert(1) = coef_pert * i_H_psi_array(1)
|
|
|
|
! print*,coef_pert,i_H_psi_array(1)
|
|
|
|
|
|
|
|
end
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
2015-11-24 11:16:14 +01:00
|
|
|
subroutine pt2_epstein_nesbet_2x2 ($arguments)
|
2014-05-18 22:46:38 +02:00
|
|
|
use bitmasks
|
|
|
|
implicit none
|
2015-11-24 11:16:14 +01:00
|
|
|
$declarations
|
2015-11-19 17:16:24 +01:00
|
|
|
|
2014-05-18 22:46:38 +02:00
|
|
|
BEGIN_DOC
|
|
|
|
! compute the Epstein-Nesbet 2x2 diagonalization coefficient and energetic contribution
|
|
|
|
!
|
2014-05-28 23:12:00 +02:00
|
|
|
! for the various N_st states.
|
2014-05-18 22:46:38 +02:00
|
|
|
!
|
|
|
|
! e_2_pert(i) = 0.5 * (( <det_pert|H|det_pert> - E(i) ) - sqrt( ( <det_pert|H|det_pert> - E(i)) ^2 + 4 <psi(i)|H|det_pert>^2 )
|
|
|
|
!
|
|
|
|
! c_pert(i) = e_2_pert(i)/ <psi(i)|H|det_pert>
|
|
|
|
!
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
integer :: i,j
|
2015-11-24 17:01:09 +01:00
|
|
|
double precision :: diag_H_mat_elem_fock,delta_e, h
|
2015-11-24 11:16:14 +01:00
|
|
|
double precision :: i_H_psi_array(N_st)
|
2014-05-18 22:46:38 +02:00
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
2014-10-15 15:19:34 +02:00
|
|
|
|
2016-08-26 18:00:49 +02:00
|
|
|
call i_H_psi(det_pert,psi_selectors,psi_selectors_coef,Nint,N_det_selectors,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
!call i_H_psi_minilist(det_pert,minilist,idx_minilist,N_minilist,psi_selectors_coef,Nint,N_minilist,psi_selectors_size,N_st,i_H_psi_array)
|
2015-11-19 14:38:41 +01:00
|
|
|
|
2015-11-24 17:01:09 +01:00
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
2014-05-28 23:12:00 +02:00
|
|
|
do i =1,N_st
|
2014-06-03 19:14:12 +02:00
|
|
|
if (i_H_psi_array(i) /= 0.d0) then
|
2016-04-01 23:33:58 +02:00
|
|
|
delta_e = h - electronic_energy(i)
|
2014-06-03 19:14:12 +02:00
|
|
|
if (delta_e > 0.d0) then
|
|
|
|
e_2_pert(i) = 0.5d0 * (delta_e - dsqrt(delta_e * delta_e + 4.d0 * i_H_psi_array(i) * i_H_psi_array(i)))
|
|
|
|
else
|
|
|
|
e_2_pert(i) = 0.5d0 * (delta_e + dsqrt(delta_e * delta_e + 4.d0 * i_H_psi_array(i) * i_H_psi_array(i)))
|
|
|
|
endif
|
|
|
|
if (dabs(i_H_psi_array(i)) > 1.d-6) then
|
|
|
|
c_pert(i) = e_2_pert(i)/i_H_psi_array(i)
|
|
|
|
else
|
|
|
|
c_pert(i) = 0.d0
|
|
|
|
endif
|
|
|
|
H_pert_diag(i) = h*c_pert(i)*c_pert(i)
|
2016-08-26 18:00:49 +02:00
|
|
|
! print*, 'N_det,N_det_selectors = ',N_det,N_det_selectors
|
|
|
|
! print*, 'threshold_selectors',threshold_selectors
|
|
|
|
! print*, delta_e,i_H_psi_array(1)
|
|
|
|
! double precision :: hij,accu
|
|
|
|
! accu = 0.d0
|
|
|
|
! do j = 1, N_det
|
|
|
|
! call i_H_j(det_pert,psi_selectors(1,1,j),N_int,hij)
|
|
|
|
! print*, 'psi_selectors_coef(j,1 = ',psi_selectors_coef(j,1),psi_coef(j,1)
|
|
|
|
! call debug_det(psi_det(1,1,i),N_int)
|
|
|
|
! call debug_det(psi_selectors(1,1,i),N_int)
|
|
|
|
! accu += psi_selectors_coef(j,1) * hij
|
|
|
|
! enddo
|
|
|
|
! print*, 'accu,ihpsi0',accu,i_H_psi_array(1)
|
|
|
|
! stop
|
2014-05-26 13:09:32 +02:00
|
|
|
else
|
2014-06-03 19:14:12 +02:00
|
|
|
e_2_pert(i) = 0.d0
|
|
|
|
c_pert(i) = 0.d0
|
|
|
|
H_pert_diag(i) = 0.d0
|
2014-05-26 13:09:32 +02:00
|
|
|
endif
|
2014-05-18 22:46:38 +02:00
|
|
|
enddo
|
2016-08-26 18:00:49 +02:00
|
|
|
! if( e_2_pert(1) .ne. 0.d0)then
|
|
|
|
! print*,' e_2_pert(1) ', e_2_pert(1)
|
|
|
|
! endif
|
2014-05-21 16:37:54 +02:00
|
|
|
|
2014-05-18 22:46:38 +02:00
|
|
|
end
|
2015-11-24 11:16:14 +01:00
|
|
|
|
2016-11-02 16:01:01 +01:00
|
|
|
|
|
|
|
|
|
|
|
subroutine pt2_epstein_nesbet_2x2_no_ci_diag($arguments)
|
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
$declarations
|
|
|
|
|
|
|
|
BEGIN_DOC
|
|
|
|
! compute the Epstein-Nesbet 2x2 diagonalization coefficient and energetic contribution
|
|
|
|
!
|
|
|
|
! for the various N_st states.
|
|
|
|
!
|
|
|
|
! e_2_pert(i) = 0.5 * (( <det_pert|H|det_pert> - E(i) ) - sqrt( ( <det_pert|H|det_pert> - E(i)) ^2 + 4 <psi(i)|H|det_pert>^2 )
|
|
|
|
!
|
|
|
|
! c_pert(i) = e_2_pert(i)/ <psi(i)|H|det_pert>
|
|
|
|
!
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
integer :: i,j
|
|
|
|
double precision :: diag_H_mat_elem_fock,delta_e, h
|
|
|
|
double precision :: i_H_psi_array(N_st)
|
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
2016-11-02 21:46:12 +01:00
|
|
|
PROVIDE psi_energy
|
2016-11-02 16:01:01 +01:00
|
|
|
|
|
|
|
call i_H_psi(det_pert,psi_selectors,psi_selectors_coef,Nint,N_det_selectors,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
!call i_H_psi_minilist(det_pert,minilist,idx_minilist,N_minilist,psi_selectors_coef,Nint,N_minilist,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
|
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
|
|
|
do i =1,N_st
|
|
|
|
if (i_H_psi_array(i) /= 0.d0) then
|
2016-11-02 21:46:12 +01:00
|
|
|
delta_e = h - psi_energy(i)
|
2016-11-02 16:01:01 +01:00
|
|
|
if (delta_e > 0.d0) then
|
|
|
|
e_2_pert(i) = 0.5d0 * (delta_e - dsqrt(delta_e * delta_e + 4.d0 * i_H_psi_array(i) * i_H_psi_array(i)))
|
|
|
|
else
|
|
|
|
e_2_pert(i) = 0.5d0 * (delta_e + dsqrt(delta_e * delta_e + 4.d0 * i_H_psi_array(i) * i_H_psi_array(i)))
|
|
|
|
endif
|
|
|
|
if (dabs(i_H_psi_array(i)) > 1.d-6) then
|
|
|
|
c_pert(i) = e_2_pert(i)/i_H_psi_array(i)
|
|
|
|
else
|
|
|
|
c_pert(i) = 0.d0
|
|
|
|
endif
|
|
|
|
H_pert_diag(i) = h*c_pert(i)*c_pert(i)
|
|
|
|
else
|
|
|
|
e_2_pert(i) = 0.d0
|
|
|
|
c_pert(i) = 0.d0
|
|
|
|
H_pert_diag(i) = 0.d0
|
|
|
|
endif
|
|
|
|
enddo
|
|
|
|
|
|
|
|
end
|
|
|
|
|
|
|
|
|
|
|
|
|
2015-11-24 11:16:14 +01:00
|
|
|
subroutine pt2_moller_plesset ($arguments)
|
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
$declarations
|
|
|
|
|
|
|
|
BEGIN_DOC
|
|
|
|
! compute the standard Moller-Plesset perturbative first order coefficient and second order energetic contribution
|
|
|
|
!
|
|
|
|
! for the various n_st states.
|
|
|
|
!
|
|
|
|
! c_pert(i) = <psi(i)|H|det_pert>/(difference of orbital energies)
|
|
|
|
!
|
|
|
|
! e_2_pert(i) = <psi(i)|H|det_pert>^2/(difference of orbital energies)
|
|
|
|
!
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
integer :: i,j
|
2015-11-24 17:01:09 +01:00
|
|
|
double precision :: diag_H_mat_elem_fock
|
2015-11-24 11:16:14 +01:00
|
|
|
integer :: exc(0:2,2,2)
|
|
|
|
integer :: degree
|
|
|
|
double precision :: phase,delta_e,h
|
|
|
|
double precision :: i_H_psi_array(N_st)
|
|
|
|
integer :: h1,h2,p1,p2,s1,s2
|
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
|
|
|
call get_excitation(ref_bitmask,det_pert,exc,degree,phase,Nint)
|
|
|
|
if (degree == 2) then
|
|
|
|
call decode_exc(exc,degree,h1,p1,h2,p2,s1,s2)
|
2015-12-11 15:09:19 +01:00
|
|
|
delta_e = (Fock_matrix_diag_mo(h1) - Fock_matrix_diag_mo(p1)) + &
|
|
|
|
(Fock_matrix_diag_mo(h2) - Fock_matrix_diag_mo(p2))
|
2015-11-24 11:16:14 +01:00
|
|
|
delta_e = 1.d0/delta_e
|
2016-03-11 23:27:39 +01:00
|
|
|
! print*,'h1,p1',h1,p1
|
|
|
|
! print*,'h2,p2',h2,p2
|
2015-11-24 11:16:14 +01:00
|
|
|
else if (degree == 1) then
|
|
|
|
call decode_exc(exc,degree,h1,p1,h2,p2,s1,s2)
|
|
|
|
delta_e = Fock_matrix_diag_mo(h1) - Fock_matrix_diag_mo(p1)
|
|
|
|
delta_e = 1.d0/delta_e
|
|
|
|
else
|
|
|
|
delta_e = 0.d0
|
|
|
|
endif
|
|
|
|
|
2015-12-09 18:53:38 +01:00
|
|
|
if (delta_e /= 0.d0) then
|
|
|
|
call i_H_psi_minilist(det_pert,minilist,idx_minilist,N_minilist,psi_selectors_coef,Nint,N_minilist,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
|
|
|
else
|
|
|
|
i_H_psi_array(:) = 0.d0
|
|
|
|
h = 0.d0
|
|
|
|
endif
|
2015-12-11 15:09:19 +01:00
|
|
|
do i =1,N_st
|
2015-11-24 11:16:14 +01:00
|
|
|
H_pert_diag(i) = h
|
2016-10-11 19:03:23 +02:00
|
|
|
! if(dabs(i_H_psi_array(i)).gt.1.d-8)then
|
|
|
|
! print*, i_H_psi_array(i)
|
|
|
|
! call debug_det(det_pert,N_int)
|
|
|
|
! print*, h1,p1,h2,p2,s1,s2
|
|
|
|
! endif
|
2015-11-24 11:16:14 +01:00
|
|
|
c_pert(i) = i_H_psi_array(i) *delta_e
|
|
|
|
e_2_pert(i) = c_pert(i) * i_H_psi_array(i)
|
|
|
|
enddo
|
|
|
|
|
|
|
|
end
|
2015-11-24 11:40:49 +01:00
|
|
|
|
|
|
|
|
|
|
|
subroutine pt2_epstein_nesbet_SC2_projected ($arguments)
|
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
$declarations
|
|
|
|
BEGIN_DOC
|
|
|
|
! compute the Epstein-Nesbet perturbative first order coefficient and second order energetic contribution
|
|
|
|
!
|
|
|
|
! for the various N_st states,
|
|
|
|
!
|
|
|
|
! but with the correction in the denominator
|
|
|
|
!
|
|
|
|
! comming from the interaction of that determinant with all the others determinants
|
|
|
|
!
|
|
|
|
! that can be repeated by repeating all the double excitations
|
|
|
|
!
|
2016-04-01 23:33:58 +02:00
|
|
|
! : you repeat all the correlation energy already taken into account in electronic_energy(1)
|
2015-11-24 11:40:49 +01:00
|
|
|
!
|
|
|
|
! that could be repeated to this determinant.
|
|
|
|
!
|
|
|
|
! In addition, for the perturbative energetic contribution you have the standard second order
|
|
|
|
!
|
|
|
|
! e_2_pert = <psi_i|H|det_pert>^2/(Delta_E)
|
|
|
|
!
|
|
|
|
! and also the purely projected contribution
|
|
|
|
!
|
|
|
|
! H_pert_diag = <HF|H|det_pert> c_pert
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
double precision :: i_H_psi_array(N_st)
|
|
|
|
integer :: idx_repeat(0:ndet)
|
|
|
|
integer :: i,j,degree,l
|
2015-11-24 17:01:09 +01:00
|
|
|
double precision :: diag_H_mat_elem_fock,accu_e_corr,hij,h0j,h,delta_E
|
2015-11-24 11:40:49 +01:00
|
|
|
double precision :: repeat_all_e_corr,accu_e_corr_tmp,e_2_pert_fonda
|
|
|
|
|
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
|
|
|
|
|
|
|
call i_H_psi_SC2(det_pert,psi_selectors,psi_selectors_coef,Nint,N_det_selectors,psi_selectors_size,N_st,i_H_psi_array,idx_repeat)
|
|
|
|
accu_e_corr = 0.d0
|
|
|
|
!$IVDEP
|
|
|
|
do i = 1, idx_repeat(0)
|
|
|
|
accu_e_corr = accu_e_corr + E_corr_per_selectors(idx_repeat(i))
|
|
|
|
enddo
|
2015-11-24 17:01:09 +01:00
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
|
|
|
h = h + accu_e_corr
|
2016-04-01 23:33:58 +02:00
|
|
|
delta_E = 1.d0/(electronic_energy(1) - h)
|
2015-11-24 11:40:49 +01:00
|
|
|
|
|
|
|
|
2016-04-01 23:33:58 +02:00
|
|
|
c_pert(1) = i_H_psi_array(1) /(electronic_energy(1) - h)
|
2015-11-24 11:40:49 +01:00
|
|
|
e_2_pert(1) = i_H_psi_array(1) * c_pert(1)
|
|
|
|
|
|
|
|
do i =2,N_st
|
|
|
|
H_pert_diag(i) = h
|
2016-04-01 23:33:58 +02:00
|
|
|
if (dabs(electronic_energy(i) - h) > 1.d-6) then
|
|
|
|
c_pert(i) = i_H_psi_array(i) / (-dabs(electronic_energy(i) - h))
|
2015-11-24 11:40:49 +01:00
|
|
|
e_2_pert(i) = (c_pert(i) * i_H_psi_array(i))
|
|
|
|
else
|
|
|
|
c_pert(i) = i_H_psi_array(i)
|
|
|
|
e_2_pert(i) = -dabs(i_H_psi_array(i))
|
|
|
|
endif
|
|
|
|
enddo
|
|
|
|
|
|
|
|
degree = popcnt(xor( ref_bitmask(1,1), det_pert(1,1))) + &
|
|
|
|
popcnt(xor( ref_bitmask(1,2), det_pert(1,2)))
|
|
|
|
!DEC$ NOUNROLL
|
|
|
|
do l=2,Nint
|
|
|
|
degree = degree+ popcnt(xor( ref_bitmask(l,1), det_pert(l,1))) + &
|
|
|
|
popcnt(xor( ref_bitmask(l,2), det_pert(l,2)))
|
|
|
|
enddo
|
|
|
|
if(degree==4)then
|
|
|
|
! <psi|delta_H|psi>
|
|
|
|
e_2_pert_fonda = e_2_pert(1)
|
|
|
|
H_pert_diag(1) = e_2_pert(1) * c_pert(1) * c_pert(1)
|
|
|
|
do i = 1, N_st
|
|
|
|
do j = 1, idx_repeat(0)
|
|
|
|
e_2_pert(i) += e_2_pert_fonda * psi_selectors_coef(idx_repeat(j),i) * psi_selectors_coef(idx_repeat(j),i)
|
|
|
|
enddo
|
|
|
|
enddo
|
|
|
|
endif
|
|
|
|
|
|
|
|
end
|
|
|
|
|
|
|
|
|
|
|
|
subroutine pt2_epstein_nesbet_SC2_no_projected ($arguments)
|
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
$declarations
|
|
|
|
BEGIN_DOC
|
|
|
|
! compute the Epstein-Nesbet perturbative first order coefficient and second order energetic contribution
|
|
|
|
!
|
|
|
|
! for the various N_st states,
|
|
|
|
!
|
|
|
|
! but with the correction in the denominator
|
|
|
|
!
|
|
|
|
! comming from the interaction of that determinant with all the others determinants
|
|
|
|
!
|
|
|
|
! that can be repeated by repeating all the double excitations
|
|
|
|
!
|
2016-04-01 23:33:58 +02:00
|
|
|
! : you repeat all the correlation energy already taken into account in electronic_energy(1)
|
2015-11-24 11:40:49 +01:00
|
|
|
!
|
|
|
|
! that could be repeated to this determinant.
|
|
|
|
!
|
|
|
|
! In addition, for the perturbative energetic contribution you have the standard second order
|
|
|
|
!
|
|
|
|
! e_2_pert = <psi_i|H|det_pert>^2/(Delta_E)
|
|
|
|
!
|
|
|
|
! and also the purely projected contribution
|
|
|
|
!
|
|
|
|
! H_pert_diag = <HF|H|det_pert> c_pert
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
double precision :: i_H_psi_array(N_st)
|
|
|
|
integer :: idx_repeat(0:ndet)
|
|
|
|
integer :: i,j,degree,l
|
2015-11-24 17:01:09 +01:00
|
|
|
double precision :: diag_H_mat_elem_fock,accu_e_corr,hij,h0j,h,delta_E
|
2015-11-24 11:40:49 +01:00
|
|
|
double precision :: repeat_all_e_corr,accu_e_corr_tmp,e_2_pert_fonda
|
|
|
|
|
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
|
|
|
|
|
|
|
call i_H_psi_SC2(det_pert,psi_selectors,psi_selectors_coef,Nint,N_det_selectors,psi_selectors_size,N_st,i_H_psi_array,idx_repeat)
|
|
|
|
accu_e_corr = 0.d0
|
|
|
|
!$IVDEP
|
|
|
|
do i = 1, idx_repeat(0)
|
|
|
|
accu_e_corr = accu_e_corr + E_corr_per_selectors(idx_repeat(i))
|
|
|
|
enddo
|
2015-11-24 17:01:09 +01:00
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
|
|
|
h = h + accu_e_corr
|
2016-04-01 23:33:58 +02:00
|
|
|
delta_E = 1.d0/(electronic_energy(1) - h)
|
2015-11-24 11:40:49 +01:00
|
|
|
|
|
|
|
|
2016-04-01 23:33:58 +02:00
|
|
|
c_pert(1) = i_H_psi_array(1) /(electronic_energy(1) - h)
|
2015-11-24 11:40:49 +01:00
|
|
|
e_2_pert(1) = i_H_psi_array(1) * c_pert(1)
|
|
|
|
|
|
|
|
do i =2,N_st
|
|
|
|
H_pert_diag(i) = h
|
2016-04-01 23:33:58 +02:00
|
|
|
if (dabs(electronic_energy(i) - h) > 1.d-6) then
|
|
|
|
c_pert(i) = i_H_psi_array(i) / (-dabs(electronic_energy(i) - h))
|
2015-11-24 11:40:49 +01:00
|
|
|
e_2_pert(i) = (c_pert(i) * i_H_psi_array(i))
|
|
|
|
else
|
|
|
|
c_pert(i) = i_H_psi_array(i)
|
|
|
|
e_2_pert(i) = -dabs(i_H_psi_array(i))
|
|
|
|
endif
|
|
|
|
enddo
|
|
|
|
end
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
subroutine pt2_epstein_nesbet_sc2 ($arguments)
|
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
$declarations
|
|
|
|
BEGIN_DOC
|
|
|
|
! compute the standard Epstein-Nesbet perturbative first order coefficient and second order energetic contribution
|
|
|
|
!
|
|
|
|
! for the various N_st states, but with the CISD_SC2 energies and coefficients
|
|
|
|
!
|
|
|
|
! c_pert(i) = <psi(i)|H|det_pert>/( E(i) - <det_pert|H|det_pert> )
|
|
|
|
!
|
|
|
|
! e_2_pert(i) = <psi(i)|H|det_pert>^2/( E(i) - <det_pert|H|det_pert> )
|
|
|
|
!
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
integer :: i,j
|
|
|
|
double precision :: i_H_psi_array(N_st)
|
2015-11-24 17:01:09 +01:00
|
|
|
double precision :: diag_H_mat_elem_fock, h
|
2015-11-24 11:40:49 +01:00
|
|
|
PROVIDE selection_criterion
|
|
|
|
|
|
|
|
ASSERT (Nint == N_int)
|
|
|
|
ASSERT (Nint > 0)
|
|
|
|
!call i_H_psi(det_pert,psi_selectors,psi_selectors_coef,Nint,N_det_selectors,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
call i_H_psi_minilist(det_pert,minilist,idx_minilist,N_minilist,psi_selectors_coef,Nint,N_minilist,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
|
|
|
|
|
2015-11-24 17:01:09 +01:00
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
2015-11-24 11:40:49 +01:00
|
|
|
do i =1,N_st
|
2016-04-01 23:33:58 +02:00
|
|
|
if(electronic_energy(i)>h.and.electronic_energy(i).ne.0.d0)then
|
2015-11-24 11:40:49 +01:00
|
|
|
c_pert(i) = -1.d0
|
|
|
|
e_2_pert(i) = selection_criterion*selection_criterion_factor*2.d0
|
2016-04-01 23:33:58 +02:00
|
|
|
else if (dabs(electronic_energy(i) - h) > 1.d-6) then
|
|
|
|
c_pert(i) = i_H_psi_array(i) / (electronic_energy(i) - h)
|
2015-11-24 11:40:49 +01:00
|
|
|
H_pert_diag(i) = h*c_pert(i)*c_pert(i)
|
|
|
|
e_2_pert(i) = c_pert(i) * i_H_psi_array(i)
|
|
|
|
else
|
|
|
|
c_pert(i) = -1.d0
|
|
|
|
e_2_pert(i) = -dabs(i_H_psi_array(i))
|
|
|
|
H_pert_diag(i) = h
|
|
|
|
endif
|
|
|
|
enddo
|
|
|
|
|
|
|
|
end
|
|
|
|
|
2016-09-28 21:14:35 +02:00
|
|
|
subroutine pt2_dummy ($arguments)
|
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
$declarations
|
|
|
|
|
|
|
|
BEGIN_DOC
|
|
|
|
! Dummy perturbation to add all connected determinants.
|
|
|
|
END_DOC
|
|
|
|
|
|
|
|
integer :: i,j
|
|
|
|
double precision :: diag_H_mat_elem_fock, h
|
|
|
|
double precision :: i_H_psi_array(N_st)
|
|
|
|
PROVIDE selection_criterion
|
|
|
|
|
|
|
|
call i_H_psi_minilist(det_pert,minilist,idx_minilist,N_minilist,psi_selectors_coef,Nint,N_minilist,psi_selectors_size,N_st,i_H_psi_array)
|
|
|
|
|
|
|
|
h = diag_H_mat_elem_fock(det_ref,det_pert,fock_diag_tmp,Nint)
|
|
|
|
do i =1,N_st
|
|
|
|
if (i_H_psi_array(i) /= 0.d0) then
|
|
|
|
c_pert(i) = i_H_psi_array(i) / (electronic_energy(i) - h)
|
|
|
|
H_pert_diag(i) = h*c_pert(i)*c_pert(i)
|
|
|
|
e_2_pert(i) = 1.d0
|
|
|
|
else
|
|
|
|
c_pert(i) = 0.d0
|
|
|
|
e_2_pert(i) = 0.d0
|
|
|
|
H_pert_diag(i) = 0.d0
|
|
|
|
endif
|
|
|
|
enddo
|
|
|
|
|
|
|
|
end
|
|
|
|
|
2015-11-24 11:40:49 +01:00
|
|
|
|
|
|
|
|
2015-11-24 11:16:14 +01:00
|
|
|
SUBST [ arguments, declarations ]
|
|
|
|
|
2016-04-01 23:33:58 +02:00
|
|
|
electronic_energy,det_ref,det_pert,fock_diag_tmp,c_pert,e_2_pert,H_pert_diag,Nint,ndet,N_st,minilist,idx_minilist,N_minilist ;
|
2015-11-24 11:16:14 +01:00
|
|
|
|
|
|
|
integer, intent(in) :: Nint
|
|
|
|
integer, intent(in) :: ndet
|
|
|
|
integer, intent(in) :: N_st
|
|
|
|
integer, intent(in) :: N_minilist
|
2015-11-24 17:01:09 +01:00
|
|
|
integer(bit_kind), intent(in) :: det_ref (Nint,2)
|
2015-11-24 11:16:14 +01:00
|
|
|
integer(bit_kind), intent(in) :: det_pert(Nint,2)
|
2015-11-24 17:01:09 +01:00
|
|
|
double precision , intent(in) :: fock_diag_tmp(2,mo_tot_num+1)
|
2016-04-01 23:33:58 +02:00
|
|
|
double precision , intent(in) :: electronic_energy(N_st)
|
2015-11-24 11:16:14 +01:00
|
|
|
double precision , intent(out) :: c_pert(N_st)
|
|
|
|
double precision , intent(out) :: e_2_pert(N_st)
|
|
|
|
double precision, intent(out) :: H_pert_diag(N_st)
|
|
|
|
integer, intent(in) :: idx_minilist(0:N_det_selectors)
|
|
|
|
integer(bit_kind), intent(in) :: minilist(Nint,2,N_det_selectors)
|
|
|
|
;;
|
|
|
|
|
|
|
|
|
|
|
|
END_TEMPLATE
|
|
|
|
|
2015-11-24 11:40:49 +01:00
|
|
|
! Note : If the arguments are changed here, they should also be changed accordingly in
|
|
|
|
! the perturbation.template.f file.
|
|
|
|
|