2015-04-09 23:59:06 +02:00
|
|
|
use omp_lib
|
2015-10-21 15:50:15 +02:00
|
|
|
use bitmasks
|
2015-04-09 23:59:06 +02:00
|
|
|
|
2015-07-13 18:00:38 +02:00
|
|
|
BEGIN_PROVIDER [ integer(omp_lock_kind), psi_ref_lock, (psi_det_size) ]
|
2015-04-09 23:59:06 +02:00
|
|
|
implicit none
|
|
|
|
BEGIN_DOC
|
2015-07-13 18:00:38 +02:00
|
|
|
! Locks on ref determinants to fill delta_ij
|
2015-04-09 23:59:06 +02:00
|
|
|
END_DOC
|
|
|
|
integer :: i
|
|
|
|
do i=1,psi_det_size
|
2015-07-13 18:00:38 +02:00
|
|
|
call omp_init_lock( psi_ref_lock(i) )
|
2015-04-09 23:59:06 +02:00
|
|
|
enddo
|
|
|
|
|
|
|
|
END_PROVIDER
|
|
|
|
|
2015-10-16 13:06:19 +02:00
|
|
|
|
|
|
|
subroutine mrcc_dress(delta_ij_, delta_ii_, Ndet_ref, Ndet_non_ref,i_generator,n_selected,det_buffer,Nint,iproc,key_mask)
|
2015-04-09 21:46:37 +02:00
|
|
|
use bitmasks
|
|
|
|
implicit none
|
|
|
|
|
|
|
|
integer, intent(in) :: i_generator,n_selected, Nint, iproc
|
2015-10-16 13:06:19 +02:00
|
|
|
integer, intent(in) :: Ndet_ref, Ndet_non_ref
|
2015-07-13 18:00:38 +02:00
|
|
|
double precision, intent(inout) :: delta_ij_(Ndet_ref,Ndet_non_ref,*)
|
|
|
|
double precision, intent(inout) :: delta_ii_(Ndet_ref,*)
|
2015-04-09 21:46:37 +02:00
|
|
|
|
|
|
|
integer(bit_kind), intent(in) :: det_buffer(Nint,2,n_selected)
|
2015-04-09 23:59:06 +02:00
|
|
|
integer :: i,j,k,l
|
2015-04-09 21:46:37 +02:00
|
|
|
integer :: degree_alpha(psi_det_size)
|
|
|
|
integer :: idx_alpha(0:psi_det_size)
|
2015-11-19 20:57:44 +01:00
|
|
|
logical :: good, fullMatch
|
2015-04-09 21:46:37 +02:00
|
|
|
|
|
|
|
integer(bit_kind) :: tq(Nint,2,n_selected)
|
|
|
|
integer :: N_tq, c_ref ,degree
|
|
|
|
|
2015-04-09 23:59:06 +02:00
|
|
|
double precision :: hIk, hla, hIl, dIk(N_states), dka(N_states), dIa(N_states)
|
|
|
|
double precision, allocatable :: dIa_hla(:,:)
|
|
|
|
double precision :: haj, phase, phase2
|
|
|
|
double precision :: f(N_states), ci_inv(N_states)
|
|
|
|
integer :: exc(0:2,2,2)
|
|
|
|
integer :: h1,h2,p1,p2,s1,s2
|
|
|
|
integer(bit_kind) :: tmp_det(Nint,2)
|
|
|
|
integer :: iint, ipos
|
|
|
|
integer :: i_state, k_sd, l_sd, i_I, i_alpha
|
2015-10-16 13:06:19 +02:00
|
|
|
|
2015-11-19 20:57:44 +01:00
|
|
|
integer(bit_kind),allocatable :: miniList(:,:,:)
|
2015-10-29 11:39:26 +01:00
|
|
|
integer(bit_kind),intent(in) :: key_mask(Nint, 2)
|
|
|
|
integer,allocatable :: idx_miniList(:)
|
2015-11-19 20:57:44 +01:00
|
|
|
integer :: N_miniList, ni, leng
|
2015-10-16 13:06:19 +02:00
|
|
|
|
|
|
|
|
2015-11-05 15:05:19 +01:00
|
|
|
leng = max(N_det_generators, N_det_non_ref)
|
2015-11-19 20:57:44 +01:00
|
|
|
allocate(miniList(Nint, 2, leng), idx_miniList(leng))
|
2015-10-29 11:39:26 +01:00
|
|
|
|
2015-11-19 20:57:44 +01:00
|
|
|
!create_minilist_find_previous(key_mask, fullList, miniList, N_fullList, N_miniList, fullMatch, Nint)
|
|
|
|
call create_minilist_find_previous(key_mask, psi_det_generators, miniList, i_generator-1, N_miniList, fullMatch, Nint)
|
2015-11-05 15:05:19 +01:00
|
|
|
|
2015-11-19 20:57:44 +01:00
|
|
|
if(fullMatch) then
|
|
|
|
return
|
2015-10-29 11:39:26 +01:00
|
|
|
end if
|
|
|
|
|
2015-10-23 15:58:43 +02:00
|
|
|
|
|
|
|
call find_triples_and_quadruples(i_generator,n_selected,det_buffer,Nint,tq,N_tq,miniList,N_minilist)
|
2015-04-09 21:46:37 +02:00
|
|
|
|
2015-07-13 18:00:38 +02:00
|
|
|
allocate (dIa_hla(N_states,Ndet_non_ref))
|
2015-04-09 21:46:37 +02:00
|
|
|
|
|
|
|
! |I>
|
|
|
|
|
|
|
|
! |alpha>
|
2015-10-16 13:06:19 +02:00
|
|
|
|
|
|
|
if(N_tq > 0) then
|
|
|
|
call create_minilist(key_mask, psi_non_ref, miniList, idx_miniList, N_det_non_ref, N_minilist, Nint)
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
2015-04-09 22:32:25 +02:00
|
|
|
do i_alpha=1,N_tq
|
2015-10-16 13:06:19 +02:00
|
|
|
! call get_excitation_degree_vector(psi_non_ref,tq(1,1,i_alpha),degree_alpha,Nint,N_det_non_ref,idx_alpha)
|
|
|
|
call get_excitation_degree_vector(miniList,tq(1,1,i_alpha),degree_alpha,Nint,N_minilist,idx_alpha)
|
|
|
|
|
|
|
|
do j=1,idx_alpha(0)
|
|
|
|
idx_alpha(j) = idx_miniList(idx_alpha(j))
|
|
|
|
end do
|
|
|
|
|
2015-04-09 21:46:37 +02:00
|
|
|
! |I>
|
2015-07-13 18:00:38 +02:00
|
|
|
do i_I=1,N_det_ref
|
2015-04-09 21:46:37 +02:00
|
|
|
! Find triples and quadruple grand parents
|
2015-07-13 18:00:38 +02:00
|
|
|
call get_excitation_degree(tq(1,1,i_alpha),psi_ref(1,1,i_I),degree,Nint)
|
2015-04-09 21:46:37 +02:00
|
|
|
if (degree > 4) then
|
|
|
|
cycle
|
|
|
|
endif
|
2015-04-09 22:32:25 +02:00
|
|
|
|
|
|
|
do i_state=1,N_states
|
|
|
|
dIa(i_state) = 0.d0
|
|
|
|
enddo
|
|
|
|
|
2015-04-09 21:46:37 +02:00
|
|
|
! <I| <> |alpha>
|
2015-04-09 22:32:25 +02:00
|
|
|
do k_sd=1,idx_alpha(0)
|
2015-07-13 18:00:38 +02:00
|
|
|
call get_excitation_degree(psi_ref(1,1,i_I),psi_non_ref(1,1,idx_alpha(k_sd)),degree,Nint)
|
2015-04-09 21:46:37 +02:00
|
|
|
if (degree > 2) then
|
|
|
|
cycle
|
|
|
|
endif
|
2015-04-09 22:32:25 +02:00
|
|
|
! <I| /k\ |alpha>
|
2015-04-09 21:46:37 +02:00
|
|
|
! <I|H|k>
|
2015-07-13 18:00:38 +02:00
|
|
|
call i_h_j(psi_ref(1,1,i_I),psi_non_ref(1,1,idx_alpha(k_sd)),Nint,hIk)
|
2015-04-09 22:32:25 +02:00
|
|
|
do i_state=1,N_states
|
2015-04-09 23:59:06 +02:00
|
|
|
dIk(i_state) = hIk * lambda_mrcc(i_state,idx_alpha(k_sd))
|
2015-04-09 22:32:25 +02:00
|
|
|
enddo
|
|
|
|
! |l> = Exc(k -> alpha) |I>
|
2015-07-13 18:00:38 +02:00
|
|
|
call get_excitation(psi_non_ref(1,1,idx_alpha(k_sd)),tq(1,1,i_alpha),exc,degree,phase,Nint)
|
2015-04-09 21:46:37 +02:00
|
|
|
call decode_exc(exc,degree,h1,p1,h2,p2,s1,s2)
|
2015-04-09 23:59:06 +02:00
|
|
|
do k=1,N_int
|
2015-07-13 18:00:38 +02:00
|
|
|
tmp_det(k,1) = psi_ref(k,1,i_I)
|
|
|
|
tmp_det(k,2) = psi_ref(k,2,i_I)
|
2015-04-09 23:59:06 +02:00
|
|
|
enddo
|
2015-04-09 21:46:37 +02:00
|
|
|
! Hole (see list_to_bitstring)
|
|
|
|
iint = ishft(h1-1,-bit_kind_shift) + 1
|
|
|
|
ipos = h1-ishft((iint-1),bit_kind_shift)-1
|
|
|
|
tmp_det(iint,s1) = ibclr(tmp_det(iint,s1),ipos)
|
|
|
|
|
|
|
|
! Particle
|
|
|
|
iint = ishft(p1-1,-bit_kind_shift) + 1
|
|
|
|
ipos = p1-ishft((iint-1),bit_kind_shift)-1
|
|
|
|
tmp_det(iint,s1) = ibset(tmp_det(iint,s1),ipos)
|
2015-04-09 23:59:06 +02:00
|
|
|
if (degree_alpha(k_sd) == 2) then
|
2015-04-09 21:46:37 +02:00
|
|
|
! Hole (see list_to_bitstring)
|
|
|
|
iint = ishft(h2-1,-bit_kind_shift) + 1
|
|
|
|
ipos = h2-ishft((iint-1),bit_kind_shift)-1
|
|
|
|
tmp_det(iint,s2) = ibclr(tmp_det(iint,s2),ipos)
|
|
|
|
|
|
|
|
! Particle
|
|
|
|
iint = ishft(p2-1,-bit_kind_shift) + 1
|
|
|
|
ipos = p2-ishft((iint-1),bit_kind_shift)-1
|
|
|
|
tmp_det(iint,s2) = ibset(tmp_det(iint,s2),ipos)
|
|
|
|
endif
|
|
|
|
|
2015-04-09 22:32:25 +02:00
|
|
|
! <I| \l/ |alpha>
|
|
|
|
do i_state=1,N_states
|
|
|
|
dka(i_state) = 0.d0
|
|
|
|
enddo
|
|
|
|
do l_sd=k_sd+1,idx_alpha(0)
|
2015-07-13 18:00:38 +02:00
|
|
|
call get_excitation_degree(tmp_det,psi_non_ref(1,1,idx_alpha(l_sd)),degree,Nint)
|
2015-04-09 21:46:37 +02:00
|
|
|
if (degree == 0) then
|
2015-07-13 18:00:38 +02:00
|
|
|
call get_excitation(psi_ref(1,1,i_I),psi_non_ref(1,1,idx_alpha(l_sd)),exc,degree,phase2,Nint)
|
|
|
|
call i_h_j(psi_ref(1,1,i_I),psi_non_ref(1,1,idx_alpha(l_sd)),Nint,hIl)
|
2015-04-09 22:32:25 +02:00
|
|
|
do i_state=1,N_states
|
2015-04-09 23:59:06 +02:00
|
|
|
dka(i_state) = hIl * lambda_mrcc(i_state,idx_alpha(l_sd)) * phase * phase2
|
2015-04-09 22:32:25 +02:00
|
|
|
enddo
|
2015-04-09 21:46:37 +02:00
|
|
|
exit
|
|
|
|
endif
|
|
|
|
enddo
|
2015-04-09 22:32:25 +02:00
|
|
|
do i_state=1,N_states
|
2015-04-09 23:59:06 +02:00
|
|
|
dIa(i_state) = dIa(i_state) + dIk(i_state) * dka(i_state)
|
2015-04-09 21:46:37 +02:00
|
|
|
enddo
|
|
|
|
enddo
|
2015-04-09 22:32:25 +02:00
|
|
|
|
|
|
|
do i_state=1,N_states
|
2015-07-13 18:00:38 +02:00
|
|
|
ci_inv(i_state) = 1.d0/psi_ref_coef(i_I,i_state)
|
2015-04-09 22:32:25 +02:00
|
|
|
enddo
|
|
|
|
do l_sd=1,idx_alpha(0)
|
|
|
|
k_sd = idx_alpha(l_sd)
|
2015-07-13 18:00:38 +02:00
|
|
|
call i_h_j(tq(1,1,i_alpha),psi_non_ref(1,1,idx_alpha(l_sd)),Nint,hla)
|
2015-04-09 23:59:06 +02:00
|
|
|
do i_state=1,N_states
|
|
|
|
dIa_hla(i_state,k_sd) = dIa(i_state) * hla
|
|
|
|
enddo
|
|
|
|
enddo
|
2015-07-13 18:00:38 +02:00
|
|
|
call omp_set_lock( psi_ref_lock(i_I) )
|
2015-04-09 23:59:06 +02:00
|
|
|
do l_sd=1,idx_alpha(0)
|
|
|
|
k_sd = idx_alpha(l_sd)
|
|
|
|
do i_state=1,N_states
|
2015-07-03 18:50:07 +02:00
|
|
|
delta_ij_(i_I,k_sd,i_state) += dIa_hla(i_state,k_sd)
|
2015-07-13 18:00:38 +02:00
|
|
|
if(dabs(psi_ref_coef(i_I,i_state)).ge.5.d-5)then
|
|
|
|
delta_ii_(i_I,i_state) -= dIa_hla(i_state,k_sd) * ci_inv(i_state) * psi_non_ref_coef(k_sd,i_state)
|
2015-07-02 00:45:36 +02:00
|
|
|
else
|
2015-07-03 18:50:07 +02:00
|
|
|
delta_ii_(i_I,i_state) = 0.d0
|
2015-07-02 00:45:36 +02:00
|
|
|
endif
|
2015-04-09 21:46:37 +02:00
|
|
|
enddo
|
|
|
|
enddo
|
2015-07-13 18:00:38 +02:00
|
|
|
call omp_unset_lock( psi_ref_lock(i_I) )
|
2015-04-09 21:46:37 +02:00
|
|
|
enddo
|
|
|
|
enddo
|
2015-04-09 23:59:06 +02:00
|
|
|
deallocate (dIa_hla)
|
2015-10-29 11:39:26 +01:00
|
|
|
deallocate(miniList, idx_miniList)
|
2015-04-09 21:46:37 +02:00
|
|
|
end
|
|
|
|
|
|
|
|
|
|
|
|
|
2015-10-23 15:58:43 +02:00
|
|
|
BEGIN_PROVIDER [ integer(bit_kind), gen_det_sorted, (N_int,2,N_det_generators,2) ]
|
|
|
|
&BEGIN_PROVIDER [ integer, gen_det_shortcut, (0:N_det_generators,2) ]
|
|
|
|
&BEGIN_PROVIDER [ integer, gen_det_version, (N_int, N_det_generators,2) ]
|
|
|
|
&BEGIN_PROVIDER [ integer, gen_det_idx, (N_det_generators,2) ]
|
|
|
|
gen_det_sorted(:,:,:,1) = psi_det_generators(:,:,:N_det_generators)
|
|
|
|
gen_det_sorted(:,:,:,2) = psi_det_generators(:,:,:N_det_generators)
|
|
|
|
call sort_dets_ab_v(gen_det_sorted(:,:,:,1), gen_det_idx(:,1), gen_det_shortcut(0:,1), gen_det_version(:,:,1), N_det_generators, N_int)
|
|
|
|
call sort_dets_ba_v(gen_det_sorted(:,:,:,2), gen_det_idx(:,2), gen_det_shortcut(0:,2), gen_det_version(:,:,2), N_det_generators, N_int)
|
|
|
|
END_PROVIDER
|
2015-04-01 13:23:02 +02:00
|
|
|
|
2015-04-02 10:13:33 +02:00
|
|
|
|
2015-10-23 15:58:43 +02:00
|
|
|
subroutine find_triples_and_quadruples(i_generator,n_selected,det_buffer,Nint,tq,N_tq,miniList,N_miniList)
|
2015-10-26 08:31:27 +01:00
|
|
|
|
2015-04-03 14:26:14 +02:00
|
|
|
use bitmasks
|
2015-04-02 10:13:33 +02:00
|
|
|
implicit none
|
2015-04-03 14:26:14 +02:00
|
|
|
|
2015-04-09 21:46:37 +02:00
|
|
|
integer, intent(in) :: i_generator,n_selected, Nint
|
2015-04-03 14:26:14 +02:00
|
|
|
|
|
|
|
integer(bit_kind), intent(in) :: det_buffer(Nint,2,n_selected)
|
|
|
|
integer :: i,j,k,m
|
|
|
|
logical :: is_in_wavefunction
|
|
|
|
integer :: degree(psi_det_size)
|
|
|
|
integer :: idx(0:psi_det_size)
|
|
|
|
logical :: good
|
|
|
|
|
2015-04-09 21:46:37 +02:00
|
|
|
integer(bit_kind), intent(out) :: tq(Nint,2,n_selected)
|
|
|
|
integer, intent(out) :: N_tq
|
2015-10-21 15:50:15 +02:00
|
|
|
|
2015-10-23 15:58:43 +02:00
|
|
|
|
2015-10-29 11:39:26 +01:00
|
|
|
integer :: nt,ni
|
2015-11-19 21:20:43 +01:00
|
|
|
logical, external :: is_connected_to
|
2015-10-23 15:58:43 +02:00
|
|
|
|
|
|
|
|
2015-10-29 11:39:26 +01:00
|
|
|
integer(bit_kind),intent(in) :: miniList(Nint,2,N_det_generators)
|
2015-10-23 15:58:43 +02:00
|
|
|
integer,intent(in) :: N_miniList
|
2015-11-05 15:05:19 +01:00
|
|
|
|
2015-10-23 15:58:43 +02:00
|
|
|
|
|
|
|
|
2015-04-03 14:26:14 +02:00
|
|
|
N_tq = 0
|
2015-11-05 15:05:19 +01:00
|
|
|
|
|
|
|
|
2015-10-29 11:39:26 +01:00
|
|
|
i_loop : do i=1,N_selected
|
2015-12-02 11:59:01 +01:00
|
|
|
if(is_connected_to(det_buffer(1,1,i), miniList, Nint, N_miniList)) then
|
2015-11-19 21:20:43 +01:00
|
|
|
cycle
|
|
|
|
end if
|
2015-10-23 15:58:43 +02:00
|
|
|
|
2015-04-03 14:26:14 +02:00
|
|
|
! Select determinants that are triple or quadruple excitations
|
2015-07-13 18:00:38 +02:00
|
|
|
! from the ref
|
2015-04-03 14:26:14 +02:00
|
|
|
good = .True.
|
2015-10-16 13:06:19 +02:00
|
|
|
call get_excitation_degree_vector(psi_ref,det_buffer(1,1,i),degree,Nint,N_det_ref,idx)
|
|
|
|
!good=(idx(0) == 0) tant que degree > 2 pas retourné par get_excitation_degree_vector
|
2015-04-03 14:26:14 +02:00
|
|
|
do k=1,idx(0)
|
|
|
|
if (degree(k) < 3) then
|
|
|
|
good = .False.
|
2015-04-02 10:13:33 +02:00
|
|
|
exit
|
|
|
|
endif
|
|
|
|
enddo
|
2015-04-03 14:26:14 +02:00
|
|
|
if (good) then
|
|
|
|
if (.not. is_in_wavefunction(det_buffer(1,1,i),Nint,N_det)) then
|
|
|
|
N_tq += 1
|
|
|
|
do k=1,N_int
|
|
|
|
tq(k,1,N_tq) = det_buffer(k,1,i)
|
|
|
|
tq(k,2,N_tq) = det_buffer(k,2,i)
|
|
|
|
enddo
|
|
|
|
endif
|
|
|
|
endif
|
2015-10-29 11:39:26 +01:00
|
|
|
enddo i_loop
|
2015-04-03 14:26:14 +02:00
|
|
|
end
|
2015-04-02 10:13:33 +02:00
|
|
|
|
2015-04-09 21:46:37 +02:00
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|