10
0
mirror of https://github.com/LCPQ/quantum_package synced 2024-06-01 10:55:25 +02:00
quantum_package/plugins/Full_CI_ZMQ/pt2_stoch_routines.irp.f

551 lines
16 KiB
Fortran
Raw Normal View History

2017-01-30 09:38:04 +01:00
BEGIN_PROVIDER [ integer, fragment_first ]
implicit none
2017-01-25 17:42:25 +01:00
fragment_first = first_det_of_teeth(1)
2017-01-18 08:42:17 +01:00
END_PROVIDER
2017-11-21 10:43:38 +01:00
subroutine ZMQ_pt2(E, pt2,relative_error, absolute_error, error)
2017-01-16 18:19:00 +01:00
use f77_zmq
use selection_types
implicit none
2017-06-26 19:12:44 +02:00
character(len=64000) :: task
2017-11-27 23:18:18 +01:00
integer(ZMQ_PTR) :: zmq_to_qp_run_socket, zmq_socket_pull
2017-01-16 18:19:00 +01:00
type(selection_buffer) :: b
integer, external :: omp_get_thread_num
2017-11-20 15:19:00 +01:00
double precision, intent(in) :: relative_error, absolute_error, E(N_states)
2017-11-21 10:43:38 +01:00
double precision, intent(out) :: pt2(N_states),error(N_states)
2017-01-16 18:19:00 +01:00
2017-06-26 19:12:44 +02:00
double precision, allocatable :: pt2_detail(:,:), comb(:)
logical, allocatable :: computed(:)
integer, allocatable :: tbc(:)
2017-11-26 11:09:03 +01:00
integer :: i, j, k, Ncomb, i_generator_end
2017-06-26 19:12:44 +02:00
integer, external :: pt2_find
2017-01-16 18:19:00 +01:00
2017-06-26 19:12:44 +02:00
double precision :: sumabove(comb_teeth), sum2above(comb_teeth), Nabove(comb_teeth)
double precision, external :: omp_get_wtime
double precision :: time
2017-11-20 15:19:00 +01:00
double precision :: w(N_states)
2017-11-27 23:18:18 +01:00
integer(ZMQ_PTR), external :: new_zmq_to_qp_run_socket
2017-11-29 13:52:52 +01:00
integer, external :: zmq_put_dvector
2017-05-09 23:11:45 +02:00
2017-11-21 17:20:18 +01:00
if (N_det < max(10,N_states)) then
pt2=0.d0
2017-06-26 19:12:44 +02:00
call ZMQ_selection(0, pt2)
2017-11-21 17:20:18 +01:00
error(:) = 0.d0
2017-06-26 19:12:44 +02:00
else
2017-11-21 10:43:38 +01:00
do pt2_stoch_istate=1,N_states
2017-11-22 16:21:16 +01:00
SOFT_TOUCH pt2_stoch_istate
2017-11-21 10:43:38 +01:00
w(:) = 0.d0
w(pt2_stoch_istate) = 1.d0
call update_psi_average_norm_contrib(w)
allocate(pt2_detail(N_states,N_det_generators+1), comb(N_det_generators), computed(N_det_generators), tbc(0:size_tbc))
sumabove = 0d0
sum2above = 0d0
Nabove = 0d0
provide nproc fragment_first fragment_count mo_bielec_integrals_in_map mo_mono_elec_integral pt2_weight psi_selectors
computed = .false.
tbc(0) = first_det_of_comb - 1
do i=1, tbc(0)
tbc(i) = i
computed(i) = .true.
end do
2017-11-27 23:18:18 +01:00
Ncomb=size(comb)
call get_carlo_workbatch(computed, comb, Ncomb, tbc)
2017-11-21 10:43:38 +01:00
pt2_detail = 0d0
print *, '========== ================= ================= ================='
print *, ' Samples Energy Stat. Error Seconds '
print *, '========== ================= ================= ================='
2017-11-27 23:18:18 +01:00
call new_parallel_job(zmq_to_qp_run_socket, zmq_socket_pull, 'pt2')
2017-11-27 00:09:25 +01:00
call zmq_put_psi(zmq_to_qp_run_socket,1)
2017-11-27 11:18:11 +01:00
call zmq_put_N_det_generators(zmq_to_qp_run_socket, 1)
call zmq_put_N_det_selectors(zmq_to_qp_run_socket, 1)
2017-11-29 13:52:52 +01:00
if (zmq_put_dvector(zmq_to_qp_run_socket,1,'energy',pt2_e0_denominator,size(pt2_e0_denominator)) == -1) then
stop 'Unable to put energy on ZMQ server'
endif
2017-11-21 10:43:38 +01:00
call create_selection_buffer(1, 1*2, b)
integer :: ipos
ipos=1
do i=1,tbc(0)
if(tbc(i) > fragment_first) then
write(task(ipos:ipos+20),'(I9,1X,I9,''|'')') 0, tbc(i)
2017-06-26 19:12:44 +02:00
ipos += 20
if (ipos > 63980) then
call add_task_to_taskserver(zmq_to_qp_run_socket,trim(task(1:ipos)))
ipos=1
endif
2017-11-21 10:43:38 +01:00
else
do j=1,fragment_count
write(task(ipos:ipos+20),'(I9,1X,I9,''|'')') j, tbc(i)
ipos += 20
if (ipos > 63980) then
call add_task_to_taskserver(zmq_to_qp_run_socket,trim(task(1:ipos)))
ipos=1
endif
end do
end if
end do
if (ipos > 1) then
call add_task_to_taskserver(zmq_to_qp_run_socket,trim(task(1:ipos)))
endif
call zmq_set_running(zmq_to_qp_run_socket)
!$OMP PARALLEL DEFAULT(shared) NUM_THREADS(nproc+1) &
!$OMP PRIVATE(i)
i = omp_get_thread_num()
if (i==0) then
2017-11-27 23:18:18 +01:00
call pt2_collector(zmq_socket_pull,E(pt2_stoch_istate), b, tbc, comb, Ncomb, computed, pt2_detail, sumabove, sum2above, Nabove, relative_error, absolute_error, w, error)
2017-11-21 10:43:38 +01:00
pt2(pt2_stoch_istate) = w(pt2_stoch_istate)
else
call pt2_slave_inproc(i)
endif
!$OMP END PARALLEL
call delete_selection_buffer(b)
2017-11-27 23:18:18 +01:00
call end_parallel_job(zmq_to_qp_run_socket, zmq_socket_pull, 'pt2')
2017-11-21 10:43:38 +01:00
print *, '========== ================= ================= ================='
deallocate(pt2_detail, comb, computed, tbc)
enddo
pt2_stoch_istate = 1
2017-11-21 15:52:16 +01:00
w(:) = 1.d0/N_states
call update_psi_average_norm_contrib(w)
SOFT_TOUCH psi_average_norm_contrib
2017-06-26 19:12:44 +02:00
endif
2017-11-23 10:35:13 +01:00
do k=N_det+1,N_states
pt2(k) = 0.d0
2017-11-21 17:20:18 +01:00
enddo
2017-03-03 23:14:04 +01:00
2017-01-16 18:19:00 +01:00
end subroutine
2017-11-21 10:43:38 +01:00
subroutine do_carlo(tbc, Ncomb, comb, pt2_detail, computed, sumabove, sum2above, Nabove)
integer, intent(in) :: tbc(0:size_tbc), Ncomb
2017-01-16 18:19:00 +01:00
logical, intent(in) :: computed(N_det_generators)
2017-11-20 15:19:00 +01:00
double precision, intent(in) :: comb(Ncomb), pt2_detail(N_states,N_det_generators)
2017-01-16 18:19:00 +01:00
double precision, intent(inout) :: sumabove(comb_teeth), sum2above(comb_teeth), Nabove(comb_teeth)
integer :: i, dets(comb_teeth)
double precision :: myVal, myVal2
mainLoop : do i=1,Ncomb
2017-02-01 11:39:59 +01:00
call get_comb(comb(i), dets, comb_teeth)
2017-01-16 18:19:00 +01:00
do j=1,comb_teeth
2017-01-31 21:52:31 +01:00
if(.not.(computed(dets(j)))) then
2017-01-16 18:19:00 +01:00
exit mainLoop
end if
end do
myVal = 0d0
myVal2 = 0d0
do j=comb_teeth,1,-1
2017-11-21 10:43:38 +01:00
myVal += pt2_detail(pt2_stoch_istate,dets(j)) * pt2_weight_inv(dets(j)) * comb_step
2017-01-16 18:19:00 +01:00
sumabove(j) += myVal
2017-02-01 14:15:18 +01:00
sum2above(j) += myVal*myVal
2017-01-16 18:19:00 +01:00
Nabove(j) += 1
end do
end do mainLoop
end subroutine
subroutine pt2_slave_inproc(i)
implicit none
integer, intent(in) :: i
call run_pt2_slave(1,i,pt2_e0_denominator)
end
2017-11-27 23:18:18 +01:00
subroutine pt2_collector(zmq_socket_pull, E, b, tbc, comb, Ncomb, computed, pt2_detail, sumabove, sum2above, Nabove, relative_error, absolute_error, pt2,error)
2017-01-16 18:19:00 +01:00
use f77_zmq
use selection_types
use bitmasks
implicit none
integer, intent(in) :: Ncomb
2017-11-27 23:18:18 +01:00
integer(ZMQ_PTR), intent(in) :: zmq_socket_pull
2017-01-16 18:19:00 +01:00
double precision, intent(inout) :: pt2_detail(N_states, N_det_generators)
2017-10-27 12:20:00 +02:00
double precision, intent(in) :: comb(Ncomb), relative_error, absolute_error, E
2017-01-16 18:19:00 +01:00
logical, intent(inout) :: computed(N_det_generators)
2017-01-31 21:52:31 +01:00
integer, intent(in) :: tbc(0:size_tbc)
2017-02-01 21:39:34 +01:00
double precision, intent(inout) :: sumabove(comb_teeth), sum2above(comb_teeth), Nabove(comb_teeth)
2017-11-21 10:43:38 +01:00
double precision, intent(out) :: pt2(N_states),error(N_states)
2017-01-16 18:19:00 +01:00
type(selection_buffer), intent(inout) :: b
2017-03-03 23:14:04 +01:00
double precision, allocatable :: pt2_mwen(:,:)
2017-01-16 18:19:00 +01:00
integer(ZMQ_PTR),external :: new_zmq_to_qp_run_socket
integer(ZMQ_PTR) :: zmq_to_qp_run_socket
integer :: msg_size, rc, more
2017-11-27 19:44:29 +01:00
integer :: acc, i, j, robin, N, n_tasks
2017-01-16 18:19:00 +01:00
double precision, allocatable :: val(:)
integer(bit_kind), allocatable :: det(:,:,:)
integer, allocatable :: task_id(:)
integer, allocatable :: index(:)
2017-11-26 11:09:03 +01:00
double precision :: time0
2017-04-24 18:20:45 +02:00
double precision :: time, timeLast, Nabove_old
2017-01-16 18:19:00 +01:00
double precision, external :: omp_get_wtime
2017-11-27 19:44:29 +01:00
integer :: tooth, firstTBDcomb, orgTBDcomb, n_tasks_max
2017-01-16 18:19:00 +01:00
integer, allocatable :: parts_to_get(:)
logical, allocatable :: actually_computed(:)
2017-11-21 10:43:38 +01:00
double precision :: eqt
2017-05-09 23:11:45 +02:00
character*(512) :: task
2017-04-24 18:20:45 +02:00
Nabove_old = -1.d0
2017-11-27 19:44:29 +01:00
n_tasks_max = N_det_generators/100+1
2017-01-16 18:19:00 +01:00
2017-03-03 23:14:04 +01:00
allocate(actually_computed(N_det_generators), parts_to_get(N_det_generators), &
2017-11-27 19:44:29 +01:00
pt2_mwen(N_states, n_tasks_max) )
pt2_mwen(1:N_states, 1:n_tasks_max) = 0.d0
2017-04-12 18:26:57 +02:00
do i=1,N_det_generators
actually_computed(i) = computed(i)
enddo
2017-01-16 18:19:00 +01:00
parts_to_get(:) = 1
2017-02-10 00:50:37 +01:00
if(fragment_first > 0) then
2017-04-12 18:26:57 +02:00
do i=1,fragment_first
parts_to_get(i) = fragment_count
enddo
2017-02-10 00:50:37 +01:00
endif
2017-01-16 18:19:00 +01:00
do i=1,tbc(0)
actually_computed(tbc(i)) = .false.
end do
2017-04-20 19:00:28 +02:00
orgTBDcomb = int(Nabove(1))
2017-01-16 18:19:00 +01:00
firstTBDcomb = 1
zmq_to_qp_run_socket = new_zmq_to_qp_run_socket()
2017-11-27 19:44:29 +01:00
allocate(val(b%N), det(N_int, 2, b%N), task_id(n_tasks_max), index(n_tasks_max))
2017-01-16 18:19:00 +01:00
more = 1
2017-11-26 11:09:03 +01:00
call wall_time(time0)
2017-01-16 18:19:00 +01:00
timeLast = time0
2017-05-02 16:18:02 +02:00
call get_first_tooth(actually_computed, tooth)
Nabove_old = Nabove(tooth)
2017-01-16 18:19:00 +01:00
2017-11-27 19:44:29 +01:00
logical :: loop
loop = .True.
pullLoop : do while (loop)
2017-05-05 15:08:51 +02:00
2017-11-27 19:44:29 +01:00
call pull_pt2_results(zmq_socket_pull, index, pt2_mwen, task_id, n_tasks)
do i=1,n_tasks
2017-04-12 18:26:57 +02:00
pt2_detail(1:N_states, index(i)) += pt2_mwen(1:N_states,i)
2017-01-16 18:19:00 +01:00
parts_to_get(index(i)) -= 1
if(parts_to_get(index(i)) < 0) then
2017-11-27 19:44:29 +01:00
print *, i, index(i), parts_to_get(index(i))
2017-01-30 20:15:28 +01:00
print *, "PARTS ??"
2017-01-31 21:52:31 +01:00
print *, parts_to_get
2017-01-16 18:19:00 +01:00
stop "PARTS ??"
end if
if(parts_to_get(index(i)) == 0) actually_computed(index(i)) = .true.
2017-11-27 19:44:29 +01:00
enddo
2017-01-16 18:19:00 +01:00
2017-11-27 23:18:18 +01:00
call zmq_delete_tasks(zmq_to_qp_run_socket,zmq_socket_pull,task_id,n_tasks,more)
if (more == 0) then
loop = .False.
endif
2017-01-16 18:19:00 +01:00
time = omp_get_wtime()
2017-11-27 23:18:18 +01:00
if(time - timeLast > 10d0 .or. (.not.loop)) then
2017-01-16 18:19:00 +01:00
timeLast = time
do i=1, first_det_of_teeth(1)-1
2017-01-31 21:52:31 +01:00
if(.not.(actually_computed(i))) then
2017-01-16 18:19:00 +01:00
cycle pullLoop
end if
end do
2017-10-27 12:20:00 +02:00
double precision :: E0, avg, prop
2017-10-30 15:35:55 +01:00
if (firstTBDcomb > Ncomb) then
call zmq_abort(zmq_to_qp_run_socket)
2017-10-30 16:21:26 +01:00
exit pullLoop
2017-10-30 15:35:55 +01:00
endif
2017-11-21 10:43:38 +01:00
call do_carlo(tbc, Ncomb+1-firstTBDcomb, comb(firstTBDcomb), pt2_detail, actually_computed, sumabove, sum2above, Nabove)
2017-10-30 16:21:26 +01:00
firstTBDcomb = int(Nabove(1)) - orgTBDcomb + 1
2017-04-24 18:20:45 +02:00
if(Nabove(1) < 5d0) cycle
2017-01-16 18:19:00 +01:00
call get_first_tooth(actually_computed, tooth)
2017-01-18 08:42:17 +01:00
2017-11-21 10:43:38 +01:00
E0 = sum(pt2_detail(pt2_stoch_istate,:first_det_of_teeth(tooth)-1))
2017-05-10 20:42:14 +02:00
if (tooth <= comb_teeth) then
prop = ((1d0 - dfloat(comb_teeth - tooth + 1) * comb_step) - pt2_cweight(first_det_of_teeth(tooth)-1))
prop = prop * pt2_weight_inv(first_det_of_teeth(tooth))
2017-11-21 10:43:38 +01:00
E0 += pt2_detail(pt2_stoch_istate,first_det_of_teeth(tooth)) * prop
2017-05-10 20:42:14 +02:00
avg = E0 + (sumabove(tooth) / Nabove(tooth))
eqt = sqrt(1d0 / (Nabove(tooth)-1) * abs(sum2above(tooth) / Nabove(tooth) - (sumabove(tooth)/Nabove(tooth))**2))
else
eqt = 0.d0
endif
2017-05-09 15:45:13 +02:00
call wall_time(time)
2017-10-30 15:35:55 +01:00
if ( (dabs(eqt/avg) < relative_error) .or. (dabs(eqt) < absolute_error) ) then
2017-05-09 23:11:45 +02:00
! Termination
2017-11-21 10:43:38 +01:00
pt2(pt2_stoch_istate) = avg
error(pt2_stoch_istate) = eqt
2017-05-09 23:11:45 +02:00
print '(G10.3, 2X, F16.10, 2X, G16.3, 2X, F16.4, A20)', Nabove(tooth), avg+E, eqt, time-time0, ''
2017-05-10 00:04:34 +02:00
call zmq_abort(zmq_to_qp_run_socket)
2017-04-12 18:26:57 +02:00
else
2017-04-24 18:20:45 +02:00
if (Nabove(tooth) > Nabove_old) then
2017-05-09 15:45:13 +02:00
print '(G10.3, 2X, F16.10, 2X, G16.3, 2X, F16.4, A20)', Nabove(tooth), avg+E, eqt, time-time0, ''
2017-04-24 18:20:45 +02:00
Nabove_old = Nabove(tooth)
endif
2017-01-16 18:19:00 +01:00
endif
end if
end do pullLoop
2017-11-21 10:43:38 +01:00
E0 = sum(pt2_detail(pt2_stoch_istate,:first_det_of_teeth(tooth)-1))
2017-05-10 01:34:29 +02:00
prop = ((1d0 - dfloat(comb_teeth - tooth + 1) * comb_step) - pt2_cweight(first_det_of_teeth(tooth)-1))
prop = prop * pt2_weight_inv(first_det_of_teeth(tooth))
2017-11-21 10:43:38 +01:00
E0 += pt2_detail(pt2_stoch_istate,first_det_of_teeth(tooth)) * prop
pt2(pt2_stoch_istate) = E0 + (sumabove(tooth) / Nabove(tooth))
2017-05-10 01:34:29 +02:00
2017-01-16 18:19:00 +01:00
call end_zmq_to_qp_run_socket(zmq_to_qp_run_socket)
call sort_selection_buffer(b)
end subroutine
2017-02-01 14:06:57 +01:00
integer function pt2_find(v, w, sze, imin, imax)
2017-01-16 18:19:00 +01:00
implicit none
2017-02-01 14:06:57 +01:00
integer, intent(in) :: sze, imin, imax
2017-01-31 21:52:31 +01:00
double precision, intent(in) :: v, w(sze)
2017-01-16 18:19:00 +01:00
integer :: i,l,h
2017-02-01 16:35:47 +01:00
integer, parameter :: block=64
2017-01-16 18:19:00 +01:00
2017-02-01 14:06:57 +01:00
l = imin
2017-02-01 16:35:47 +01:00
h = imax-1
2017-01-16 18:19:00 +01:00
2017-02-01 16:35:47 +01:00
do while(h-l >= block)
2017-01-30 20:15:28 +01:00
i = ishft(h+l,-1)
2017-01-16 18:19:00 +01:00
if(w(i+1) > v) then
h = i-1
else
l = i+1
end if
end do
2017-02-01 16:35:47 +01:00
!DIR$ LOOP COUNT (64)
2017-02-01 17:00:39 +01:00
do pt2_find=l,h
if(w(pt2_find) >= v) then
2017-02-01 16:35:47 +01:00
exit
end if
end do
2017-01-16 18:19:00 +01:00
end function
BEGIN_PROVIDER [ integer, comb_teeth ]
implicit none
2017-05-09 15:45:13 +02:00
comb_teeth = 100
2017-01-16 18:19:00 +01:00
END_PROVIDER
subroutine get_first_tooth(computed, first_teeth)
implicit none
logical, intent(in) :: computed(N_det_generators)
integer, intent(out) :: first_teeth
2017-01-18 15:53:51 +01:00
integer :: i, first_det
2017-01-16 18:19:00 +01:00
2017-01-18 15:53:51 +01:00
first_det = 1
2017-01-16 18:19:00 +01:00
first_teeth = 1
do i=first_det_of_comb, N_det_generators
2017-01-31 21:52:31 +01:00
if(.not.(computed(i))) then
2017-01-18 15:53:51 +01:00
first_det = i
2017-01-16 18:19:00 +01:00
exit
end if
end do
do i=comb_teeth, 1, -1
2017-01-18 15:53:51 +01:00
if(first_det_of_teeth(i) < first_det) then
2017-01-16 18:19:00 +01:00
first_teeth = i
exit
end if
end do
2017-01-18 15:53:51 +01:00
2017-01-16 18:19:00 +01:00
end subroutine
2017-10-02 09:49:22 +02:00
BEGIN_PROVIDER [ integer*8, size_tbc ]
2017-02-10 00:50:37 +01:00
implicit none
BEGIN_DOC
! Size of the tbc array
END_DOC
2017-10-02 09:49:22 +02:00
size_tbc = int((comb_teeth+1),8)*int(N_det_generators,8) + fragment_count*fragment_first
2017-01-31 21:52:31 +01:00
END_PROVIDER
2017-02-01 11:29:17 +01:00
subroutine get_carlo_workbatch(computed, comb, Ncomb, tbc)
2017-01-16 18:19:00 +01:00
implicit none
2017-05-09 19:17:07 +02:00
integer, intent(inout) :: Ncomb
double precision, intent(out) :: comb(Ncomb)
integer, intent(inout) :: tbc(0:size_tbc)
logical, intent(inout) :: computed(N_det_generators)
2017-05-09 23:11:45 +02:00
integer :: i, j, last_full, dets(comb_teeth)
2017-05-09 19:17:07 +02:00
integer :: icount, n
integer :: k, l
2017-05-10 20:42:14 +02:00
l=first_det_of_comb
2017-01-31 21:52:31 +01:00
call RANDOM_NUMBER(comb)
2017-05-09 19:17:07 +02:00
do i=1,size(comb)
comb(i) = comb(i) * comb_step
!DIR$ FORCEINLINE
call add_comb(comb(i), computed, tbc, size_tbc, comb_teeth)
2017-05-09 23:11:45 +02:00
Ncomb = i
2017-05-10 20:42:14 +02:00
if (tbc(0) == N_det_generators) return
2017-05-09 23:11:45 +02:00
do while (computed(l))
l=l+1
enddo
k=tbc(0)+1
tbc(k) = l
computed(l) = .True.
tbc(0) = k
2017-02-01 11:29:17 +01:00
enddo
2017-05-09 19:17:07 +02:00
2017-02-01 11:29:17 +01:00
end subroutine
2017-01-16 18:19:00 +01:00
2017-02-01 11:29:17 +01:00
subroutine get_comb(stato, dets, ct)
2017-01-16 18:19:00 +01:00
implicit none
2017-02-01 11:29:17 +01:00
integer, intent(in) :: ct
2017-01-16 18:19:00 +01:00
double precision, intent(in) :: stato
2017-02-01 11:29:17 +01:00
integer, intent(out) :: dets(ct)
2017-01-16 18:19:00 +01:00
double precision :: curs
integer :: j
integer, external :: pt2_find
curs = 1d0 - stato
do j = comb_teeth, 1, -1
2017-01-31 21:52:31 +01:00
!DIR$ FORCEINLINE
2017-02-01 14:06:57 +01:00
dets(j) = pt2_find(curs, pt2_cweight,size(pt2_cweight), first_det_of_teeth(j), first_det_of_teeth(j+1))
2017-01-16 18:19:00 +01:00
curs -= comb_step
end do
end subroutine
2017-02-01 11:29:17 +01:00
subroutine add_comb(comb, computed, tbc, stbc, ct)
2017-01-16 18:19:00 +01:00
implicit none
2017-10-05 10:37:10 +02:00
integer*8, intent(in) :: stbc
integer, intent(in) :: ct
2017-01-16 18:19:00 +01:00
double precision, intent(in) :: comb
logical, intent(inout) :: computed(N_det_generators)
2017-02-01 11:29:17 +01:00
integer, intent(inout) :: tbc(0:stbc)
integer :: i, k, l, dets(ct)
2017-01-16 18:19:00 +01:00
2017-01-31 21:52:31 +01:00
!DIR$ FORCEINLINE
2017-02-01 11:29:17 +01:00
call get_comb(comb, dets, ct)
2017-01-16 18:19:00 +01:00
2017-02-01 11:29:17 +01:00
k=tbc(0)+1
do i = 1, ct
l = dets(i)
if(.not.(computed(l))) then
tbc(k) = l
k = k+1
computed(l) = .true.
2017-01-16 18:19:00 +01:00
end if
end do
2017-02-01 11:29:17 +01:00
tbc(0) = k-1
2017-01-16 18:19:00 +01:00
end subroutine
2017-11-21 10:43:38 +01:00
BEGIN_PROVIDER [ integer, pt2_stoch_istate ]
implicit none
BEGIN_DOC
! State for stochatsic PT2
END_DOC
pt2_stoch_istate = 1
END_PROVIDER
2017-01-16 18:19:00 +01:00
2017-01-30 09:38:04 +01:00
BEGIN_PROVIDER [ double precision, pt2_weight, (N_det_generators) ]
&BEGIN_PROVIDER [ double precision, pt2_cweight, (N_det_generators) ]
2017-02-01 14:06:57 +01:00
&BEGIN_PROVIDER [ double precision, pt2_cweight_cache, (N_det_generators) ]
2017-01-16 18:19:00 +01:00
&BEGIN_PROVIDER [ double precision, comb_step ]
&BEGIN_PROVIDER [ integer, first_det_of_teeth, (comb_teeth+1) ]
&BEGIN_PROVIDER [ integer, first_det_of_comb ]
implicit none
integer :: i
double precision :: norm_left, stato
integer, external :: pt2_find
2017-11-21 10:43:38 +01:00
pt2_weight(1) = psi_coef_generators(1,pt2_stoch_istate)**2
pt2_cweight(1) = psi_coef_generators(1,pt2_stoch_istate)**2
2017-01-16 18:19:00 +01:00
2017-05-10 20:42:14 +02:00
do i=1,N_det_generators
2017-11-21 10:43:38 +01:00
pt2_weight(i) = psi_coef_generators(i,pt2_stoch_istate)**2
2017-05-10 20:42:14 +02:00
enddo
! Important to loop backwards for numerical precision
pt2_cweight(N_det_generators) = pt2_weight(N_det_generators)
do i=N_det_generators-1,1,-1
pt2_cweight(i) = pt2_weight(i) + pt2_cweight(i+1)
2017-01-16 18:19:00 +01:00
end do
2017-04-12 14:46:12 +02:00
do i=1,N_det_generators
2017-05-10 20:42:14 +02:00
pt2_weight(i) = pt2_weight(i) / pt2_cweight(1)
pt2_cweight(i) = pt2_cweight(i) / pt2_cweight(1)
2017-04-12 14:46:12 +02:00
enddo
2017-05-10 20:42:14 +02:00
do i=1,N_det_generators-1
pt2_cweight(i) = 1.d0 - pt2_cweight(i+1)
end do
pt2_cweight(N_det_generators) = 1.d0
2017-01-16 18:19:00 +01:00
norm_left = 1d0
comb_step = 1d0/dfloat(comb_teeth)
2017-04-12 15:32:02 +02:00
first_det_of_comb = 1
2017-01-16 18:19:00 +01:00
do i=1,N_det_generators
2017-05-09 19:17:07 +02:00
if(pt2_weight(i)/norm_left < .5d0*comb_step) then
2017-01-16 18:19:00 +01:00
first_det_of_comb = i
exit
end if
2017-01-30 09:38:04 +01:00
norm_left -= pt2_weight(i)
2017-01-16 18:19:00 +01:00
end do
2017-06-26 19:12:44 +02:00
first_det_of_comb = max(2,first_det_of_comb)
2017-05-05 15:24:04 +02:00
call write_int(6, first_det_of_comb-1, 'Size of deterministic set')
2017-01-16 18:19:00 +01:00
2017-01-31 21:52:31 +01:00
comb_step = (1d0 - pt2_cweight(first_det_of_comb-1)) * comb_step
2017-01-16 18:19:00 +01:00
2017-02-01 14:06:57 +01:00
stato = 1d0 - comb_step
iloc = N_det_generators
2017-01-16 18:19:00 +01:00
do i=comb_teeth, 1, -1
2017-02-01 14:06:57 +01:00
integer :: iloc
2017-02-10 00:50:37 +01:00
iloc = pt2_find(stato, pt2_cweight, N_det_generators, 1, iloc)
2017-02-01 14:06:57 +01:00
first_det_of_teeth(i) = iloc
2017-01-16 18:19:00 +01:00
stato -= comb_step
end do
first_det_of_teeth(comb_teeth+1) = N_det_generators + 1
first_det_of_teeth(1) = first_det_of_comb
2017-01-30 20:15:28 +01:00
if(first_det_of_teeth(1) /= first_det_of_comb) then
print *, 'Error in ', irp_here
stop "comb provider"
endif
2017-01-16 18:19:00 +01:00
END_PROVIDER
2017-01-31 21:52:31 +01:00
BEGIN_PROVIDER [ double precision, pt2_weight_inv, (N_det_generators) ]
implicit none
BEGIN_DOC
! Inverse of pt2_weight array
END_DOC
integer :: i
do i=1,N_det_generators
pt2_weight_inv(i) = 1.d0/pt2_weight(i)
enddo
END_PROVIDER
2017-01-16 18:19:00 +01:00