Home
last modified time | relevance | path

Searched refs:evc1 (Results 1 – 25 of 25) sorted by relevance

/dports/science/quantum-espresso/q-e-qe-6.7.0/TDDFPT/src/
H A Dlr_lanczos.f90126 CALL lr_apply_liouvillian(evc1(1,1,1,1),evc1_new(1,1,1,1),.true.)
134 CALL lr_apply_liouvillian(evc1(1,1,1,2),evc1_new(1,1,1,2),.true.)
142 CALL lr_apply_liouvillian(evc1(1,1,1,1),evc1_new(1,1,1,1),.true.)
145 CALL zcopy(size_evc,evc1(1,1,1,1),1,evc1(1,1,1,2),1)
159 CALL lr_apply_s(evc1(:,:,:,2), sevc1(:,:,:))
167 CALL lanczos_pseudohermitian(LR_iteration,size(evc1,1), size(evc1,2), size(evc1,3),&
172 CALL lanczos_pseudohermitian(LR_iteration,size(evc1,1), size(evc1,2), size(evc1,3),&
179 CALL lanczos_nonhermitian(LR_iteration,size(evc1,1), size(evc1,2), size(evc1,3),&
184 CALL lanczos_nonhermitian(LR_iteration,size(evc1,1), size(evc1,2), size(evc1,3),&
310 WRITE(301,*) ibnd, ig, dble(evc1(ig,ibnd,1,1)), aimag(evc1(ig,ibnd,1,1))
[all …]
H A Dlr_normalise.f9033 COMPLEX(kind=dp), INTENT(inout) :: evc1(npwx*npol,nbnd,nksq) local
101 CALL calbec(ngk(1),vkb,evc1(:,:,1),becp)
102 CALL s_psi(npwx,ngk(1),nbnd,evc1(1,1,1),spsi)
110 CALL s_psi(npwx,ngk(1),nbnd,evc1(1,1,1),spsi)
115 prod = dble( lr_dot( evc1(1,1,1),spsi(1,1,1) ) )
119 evc1(:,:,1)=cmplx(prod,0.0d0,dp)*evc1(:,:,1)
142 CALL calbec(ngk(ik),vkb,evc1(:,:,ik),becp)
151 prod = dble( lr_dot( evc1(1,1,1),spsi(1,1,1) ) )
155 evc1(:,:,:) = cmplx(prod,0.0d0,dp) * evc1(:,:,:)
206 prod = dble( lr_dot( evc1(1,1,1), spsi(1,1,1) ) )
[all …]
H A Dlr_apply_liouvillian.f9069 COMPLEX(DP), INTENT(IN) :: evc1(npwx*npol,nbnd,nks) local
120 CALL lr_calc_dens( evc1, .false. )
526 IF (lr_exx .AND. .NOT.interaction) CALL lr_exx_kernel_noint(evc1,evc1_new)
537 CALL h_psi(npwx,ngk(1),nbnd,evc1(1,1,1),sevc1_new(1,1,1))
545 CALL invfft_orbital_gamma(evc1(:,:,1),ibnd,nbnd)
550 CALL s_psi(npwx,ngk(1),nbnd,evc1(1,1,1),spsi1)
685 IF (lr_exx .AND. .NOT.interaction) CALL lr_exx_kernel_noint(evc1,evc1_new)
701 CALL h_psi(npwx,ngk(ik),nbnd,evc1(1,1,ik),sevc1_new(1,1,ik))
705 CALL s_psi(npwx,ngk(ik),nbnd,evc1(1,1,ik),spsi1)
H A Dlr_main.f9028 & evc1, evc1_old,norm0, charge_response, n_ipol, &
185 evc1(:,:,:,1) = d0psi(:,:,:,pol_index)
193 evc1(:,:,:,2) = evc1(:,:,:,1)
H A Dlr_apply_liouvillian_eels.f9042 COMPLEX(DP), INTENT(IN) :: evc1(npwx*npol,nbnd,nksq) local
112 call lr_calc_dens_eels_nc (dvrsc(1,1), evc1(1,1,1))
114 call lr_calc_dens_eels (dvrsc(1,current_spin), evc1(1,1,1))
261 CALL ch_psi_all (npwq, evc1(:,:,ik), sevc1_new(:,:,ik), et(:,ikk), ik, nbnd_occ(ikk))
H A Dlr_write_restart.f9022 evc1,evc1_new,evc1_old,iunrestart, nwordrestart, &
173 CALL davcio(evc1(:,:,:,1),nwordrestart,iunrestart,1,1)
174 CALL davcio(evc1(:,:,:,2),nwordrestart,iunrestart,2,1)
H A Dlr_calc_dens.f9068 COMPLEX(kind=dp), INTENT(in) :: evc1(npwx*npol,nbnd,nks) local
388 CALL invfft_orbital_gamma(evc1(:,:,1),ibnd,nbnd)
469 IF (lr_exx) CALL lr_exx_kernel_int ( evc1(:,:,1), ibnd, nbnd, 1 )
497 CALL calbec(ngk(1), vkb, evc1(:,:,1), becp)
605 psic(dffts%nl(igk_k(ig,ik)))=evc1(ig,ibnd,ik)
622 IF (lr_exx) CALL lr_exx_kernel_int (evc1(:,:,ik), ibnd, nbnd, ik )
643 CALL calbec(ngk(ik),vkb,evc1(:,:,ik),becp)
H A Dlr_restart.f9022 USE lr_variables, ONLY : itermax, evc1, evc1_old, &
192 CALL davcio(evc1(:,:,:,1),nwordrestart,iunrestart,1,-1)
193 CALL davcio(evc1(:,:,:,2),nwordrestart,iunrestart,2,-1)
H A Dlr_eels_main.f9023 & evc1, evc1_old, norm0, n_ipol, &
239 evc1(:,:,:,1) = d0psi(:,:,:,pol_index)
245 evc1(:,:,:,2) = evc1(:,:,:,1)
H A Dlr_dealloc.f9043 IF (allocated(evc1)) DEALLOCATE(evc1)
H A Dlr_alloc_init.f90101 ALLOCATE(evc1(npwx*npol,nbnd,nksq,2))
116 evc1(:,:,:,:) = (0.0d0,0.0d0)
H A Dlr_variables.f9081 evc1(:,:,:,:), & ! " " variable
H A Dlr_dav_main.f9021 evc1,n_ipol, d0psi, &
H A Dlr_charg_resp.f90630 SUBROUTINE lr_calc_F(evc1) argument
651 COMPLEX(kind=dp), INTENT(in) :: evc1(npwx,nbnd,nks) local
676 CALL invfft_orbital_gamma(evc1(:,:,1),ibnd,nbnd)
680 CALL calbec(ngk(1), vkb, evc1(:,:,1), becp)
757 SSUM=(2.D0*wg(ibnd_occ,1)*ddot(2*ngk(1),evc0_virt(:,ibnd_virt,1),1,evc1(:,ibnd_occ,1),1))
758 …IF (gstart==2) SSUM = SSUM - (wg(ibnd_occ,1)*dble(evc1(1,ibnd_occ,1))*dble(evc0_virt(1,ibnd_virt,1…
H A Dlr_solve_e.f9029 & n_ipol, evc0, d0psi, d0psi2, evc1, lr_verbosity, &
/dports/net/ntp/ntp-4.2.8p15/sntp/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/www/firefox-esr/firefox-91.8.0/ipc/chromium/src/third_party/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/lang/spidermonkey78/firefox-78.9.0/ipc/chromium/src/third_party/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/www/firefox/firefox-99.0/ipc/chromium/src/third_party/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/mail/thunderbird/thunderbird-91.8.0/ipc/chromium/src/third_party/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/lang/spidermonkey60/firefox-60.9.0/ipc/chromium/src/third_party/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/sysutils/fluent-bit/fluent-bit-1.8.11/lib/monkey/mk_core/deps/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/net-mgmt/lldpd/lldpd-1.0.8/libevent/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/devel/libevent/libevent-2.1.12-stable/test/
H A Dregress_finalize.c260 struct event_and_count evc1, evc2; in test_fin_within_cb() local
261 evc1.count = evc2.count = 0; in test_fin_within_cb()
262 evc2.ev2 = evc1.ev = evtimer_new(base, timer_callback_2, &evc1); in test_fin_within_cb()
263 evc1.ev2 = evc2.ev = evtimer_new(base, timer_callback_2, &evc2); in test_fin_within_cb()
268 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
272 tt_int_op(evc1.count, ==, 101); in test_fin_within_cb()
277 evc1.count = evc2.count = 0; in test_fin_within_cb()
278 evc2.ev2 = evc1.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc1); in test_fin_within_cb()
279 evc1.ev2 = evc2.ev = event_new(base, -1, EV_PERSIST, timer_callback_2, &evc2); in test_fin_within_cb()
281 event_active(evc1.ev, EV_TIMEOUT, 1); in test_fin_within_cb()
[all …]
/dports/science/quantum-espresso/q-e-qe-6.7.0/GWW/pw4gww/
H A Drotate_wannier.f9042 COMPLEX(kind=DP), ALLOCATABLE :: evc1(:,:)!reads wavefunctions here local
52 allocate( evc1(npwx,nbnd))
59 evc1=(0.d0,0.d0)
66 evc1(ig,i)=evc1(ig,i)+rot_u(j,i)*evc0(ig,j)
87 evc(1:npw0,1:nbnd)=evc1(1:npw0,1:nbnd)
90 CALL davcio(evc1,2*nwordwfc,iun_wannier,1,1)
93 DEALLOCATE(evc1)