Octopus
xc_photons.F90
Go to the documentation of this file.
1!! Copyright (C) 2022 I.-T Lu
2!!
3!! This program is free software; you can redistribute it and/or modify
4!! it under the terms of the GNU General Public License as published by
5!! the Free Software Foundation; either version 2, or (at your option)
6!! any later version.
7!!
8!! This program is distributed in the hope that it will be useful,
9!! but WITHOUT ANY WARRANTY; without even the implied warranty of
10!! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
11!! GNU General Public License for more details.
12!!
13!! You should have received a copy of the GNU General Public License
14!! along with this program; if not, write to the Free Software
15!! Foundation, Inc., 51 Franklin Street, Fifth Floor, Boston, MA
16!! 02110-1301, USA.
17!!
18
19#include "global.h"
20
27
29 use debug_oct_m
31 use epot_oct_m
32 use global_oct_m
33 use grid_oct_m
36 use mesh_oct_m
43 use space_oct_m
45 use parser_oct_m
48
49 implicit none
50
51 private
52 public :: xc_photons_t
53
62 !
63 type xc_photons_t
64 private
65 integer :: method = 0
66 real(real64), allocatable, public :: vpx(:)
67 real(real64), public :: ex
68 type(photon_mode_t) :: pt
69 real(real64) :: pxlda_kappa
70 real(real64) :: eta_c
72 integer :: energy_method = 0
73 logical :: lcorrelations = .false.
74 logical :: llamb_re_mass = .false.
75 logical :: llamb_freespace =.false.
76 real(real64) :: lamb_omega
77
78 logical, public :: lpfmf = .false.
79 real(real64), allocatable, public :: mf_vector_potential(:)
80 real(real64), allocatable :: jp_proj_eo(:,:)
83
84 contains
85 procedure :: init => xc_photons_init
86 procedure :: end => xc_photons_end
87 procedure :: wants_to_renormalize_mass => xc_photons_wants_to_renormalize_mass
88 procedure :: get_renormalized_mass => xc_photons_get_renormalized_emass
89 procedure :: mf_dump => xc_photons_mf_dump
90 procedure :: mf_load => xc_photons_mf_load
91 procedure :: v_ks => xc_photons_v_ks
92 procedure :: add_mean_field => xc_photons_add_mean_field
93 end type xc_photons_t
94
95 ! the PhotonXCXCMethod
96 integer, private, parameter :: &
97 XC_PHOTONS_NONE = 0, &
98 xc_photons_lda = 1, &
100
101contains
102
103 ! ---------------------------------------------------------
105 !
106 subroutine xc_photons_init(xc_photons, namespace, xc_photon, space, gr, st)
107 class(xc_photons_t), intent(out) :: xc_photons
108 type(namespace_t), intent(in) :: namespace
109 integer, intent(in) :: xc_photon
110 class(space_t), intent(in) :: space
111 type(grid_t), intent(in) :: gr
112 type(states_elec_t), intent(in) :: st
113
114 push_sub(xc_photons_init)
115
116 xc_photons%lpfmf = .false.
117
118 call messages_experimental("XCPhotonFunctional /= none")
119
120 call photon_mode_init(xc_photons%pt, namespace, space%dim, .true.)
121 call photon_mode_set_n_electrons(xc_photons%pt, st%qtot)
122
123 select case(xc_photon)
124 case(option__xcphotonfunctional__photon_x_lda)
125 xc_photons%method = xc_photons_lda
126 xc_photons%lcorrelations = .false.
127 case(option__xcphotonfunctional__photon_xc_lda)
128 xc_photons%method = xc_photons_lda
129 xc_photons%lcorrelations = .true.
130 case(option__xcphotonfunctional__photon_x_wfn)
131 xc_photons%method = xc_photons_wfs
132 xc_photons%lcorrelations = .false.
133 case(option__xcphotonfunctional__photon_xc_wfn)
134 xc_photons%method = xc_photons_wfs
135 xc_photons%lcorrelations = .true.
136 case default
137 xc_photons%method = xc_photons_none
138 return
139 end select
140
141
142 if (xc_photons%method == xc_photons_lda) then
143
144 !%Variable PhotonXCLDAKappa
145 !%Type float
146 !%Default 1.0
147 !%Section Hamiltonian::XC
148 !%Description
149 !% the scaling factor for px-LDA potential
150 !%End
151 call parse_variable(namespace, 'PhotonXCLDAKappa', m_one, xc_photons%pxlda_kappa)
152
153 end if
154
155 !%Variable PhotonXCEnergyMethod
156 !%Type integer
157 !%Default 1
158 !%Section Hamiltonian::XC
159 !%Description
160 !% There are different ways to calculate the energy,
161 !%Option virial 1
162 !% (modified) virial approach</br>
163 !% <math>
164 !% (E_{\rm{px}}^{\rm{virial}} = \frac{1}{2}\int d\mathbf{r}\ \mathbf{r}\cdot[
165 !% -\rho(\mathbf{r})\nabla v_{\rm{px}}(\mathbf{r})])
166 !% </math></br>
167 !%Option expectation_value 2
168 !% expectation value w.tr.t. the wave functions (valid only for 1 electron)</br>
169 !% <math>
170 !% E_{\rm{px}}[\rho] = -\sum_{\alpha=1}^{M_{p}}\frac{\tilde{\lambda}_{\alpha}^{2}}{2\tilde{\omega}_{\alpha}^{2}}
171 !% \langle (\tilde{\mathbf{{\varepsilon}}}_{\alpha}\cdot\hat{\mathbf{J}}_{\rm{p}})\Phi[\rho]
172 !% | (\tilde{\mathbf{{\varepsilon}}}_{\alpha}\cdot\hat{\mathbf{J}}_{\rm{p}})\Phi[\rho] \rangle
173 !% </math></br>
174 !% This option only works for the wave function based electron-photon functionals
175 !%Option LDA 3
176 !% energy from electron density</br>
177 !% <math>
178 !% E_{\rm pxLDA}[\rho] = \frac{-2\pi^{2}}{(d+2)({2V_{d}})^{\frac{2}{d}}}
179 !% \sum_{\alpha=1}^{M_{p}}\frac{\tilde{\lambda}_{\alpha}^{2}}{\tilde{\omega}_{\alpha}^{2}}
180 !% \int d\mathbf{r}\ \rho^{\frac{2+d}{d}}(\mathbf{r})
181 !% </math></br>
182 !% This option only works with LDA electron-photon functionals.
183 !%End
185 call parse_variable(namespace, 'PhotonXCEnergyMethod', 1, xc_photons%energy_method)
186
187 if( xc_photons%method == xc_photons_wfs .and. xc_photons%energy_method == option__photonxcenergymethod__lda ) then
188 message(1) = "Calculating the electron-photon energy from the LDA expression"
189 message(2) = "is not implemented for wave function based electron-photon functionals"
190 call messages_fatal(2, namespace=namespace)
191 end if
192
193
194 if (xc_photons%lcorrelations) then
195
196 !%Variable PhotonXCEtaC
197 !%Type float
198 !%Default 1.0
199 !%Section Hamiltonian::XC
200 !%Description
201 !% The scaling factor for the px potential to reduce the weak coupling perturbation regime
202 !%End
203
204 if (parse_is_defined(namespace, 'PhotonXCEtaC')) then
205 call parse_variable(namespace, 'PhotonXCEtaC', m_one, xc_photons%eta_c)
206 else
207 message(1) = "Defining PhotonXCEtaC is required for photon functionals containing correlation."
208 call messages_fatal(1, namespace=namespace)
209 end if
210
211 else
212
213 xc_photons%eta_c = m_one
214
215 end if
216
217 ! This variable will keep vpx across iterations
218 safe_allocate(xc_photons%vpx(1:gr%np_part))
219
220 xc_photons%vpx = m_zero
221
222 !%Variable PhotonXCLambShift
223 !%Type logical
224 !%Default .false.
225 !%Section Hamiltonian::XC
226 !%Description
227 !% to deal with the photon free exchange potential for continuum mode in free space
228 !%End
229
230 call parse_variable(namespace, 'PhotonXCLambShift', .false., xc_photons%llamb_freespace)
231 call messages_experimental("PhotonXCLambShift", namespace=namespace)
232
233 if (xc_photons%llamb_freespace) then
234
235 !%Variable PhotonXCLambShiftOmegaCutoff
236 !%Type float
237 !%Default 0.0
238 !%Section Hamiltonian::XC
239 !%Description
240 !% the cutoff frequency (Ha) for Lamb shift
241 !%End
242
243 call parse_variable(namespace, 'PhotonXCLambShiftOmegaCutoff', m_zero, xc_photons%lamb_omega)
244
245 !%Variable PhotonXCLambShiftRenormalizeMass
246 !%Type logical
247 !%Default .false.
248 !%Section Hamiltonian::XC
249 !%Description
250 !% to deal with the photon free exchange potential for continuum mode in free space
251 !%End
252
253 call parse_variable(namespace, 'PhotonXCLambShiftRenormalizeMass', .false., xc_photons%llamb_re_mass)
254
255 end if
256
257 ! compute the dressed photon modes
258 call photon_mode_dressed(xc_photons%pt)
259
260
261 pop_sub(xc_photons_init)
262
263 end subroutine xc_photons_init
264
265 ! ---------------------------------------------------------
266 subroutine xc_photons_end(this)
267 class(xc_photons_t), intent(inout) :: this
268
269 push_sub(xc_photons_end)
270
271 call photon_mode_end(this%pt)
272 safe_deallocate_a(this%vpx)
273
274 if (allocated(this%mf_vector_potential)) then
275 safe_deallocate_a(this%mf_vector_potential)
276 end if
277 if (allocated(this%jp_proj_eo)) then
278 safe_deallocate_a(this%jp_proj_eo)
279 end if
280
281 pop_sub(xc_photons_end)
282 end subroutine xc_photons_end
283
289 !
290 subroutine xc_photons_v_ks(xc_photons, namespace, total_density, density, gr, space, psolver, ep, st)
291 class(xc_photons_t), intent(inout) :: xc_photons
292 type(namespace_t), intent(in) :: namespace
293 real(real64), pointer, contiguous, intent(in) :: total_density(:)
294 real(real64), allocatable, intent(in) :: density(:, :)
295 class(grid_t), intent(in) :: gr
296 type(space_t), intent(in) :: space
297 type(poisson_t), intent(in) :: psolver
298 type(epot_t), intent(in) :: ep
299 type(states_elec_t), intent(inout) :: st
300
301 integer :: ia
302
303 push_sub(xc_photons_v_ks)
304
305 xc_photons%lpfmf = xc_photons%method > 0
306
307 xc_photons%vpx = m_zero
308 xc_photons%ex = m_zero
309
310 if ( .not. allocated(xc_photons%mf_vector_potential) ) then
311 safe_allocate(xc_photons%mf_vector_potential(1:space%dim))
312 xc_photons%mf_vector_potential = m_zero
313 end if
314 if ( .not. allocated(xc_photons%jp_proj_eo)) then
315 safe_allocate(xc_photons%jp_proj_eo(1:xc_photons%pt%nmodes,1:2))
316 xc_photons%jp_proj_eo = m_zero
317 end if
318
319
320 select case(xc_photons%method)
321 case(xc_photons_lda) ! LDA approximation for px potential
322 call photon_free_vpx_lda(namespace, xc_photons, total_density, gr, space, psolver)
323 case(xc_photons_wfs) ! wave function approxmation for px potential
324 call photon_free_vpx_wfc(namespace, xc_photons, total_density, gr, space, st)
325 case(xc_photons_none) ! no photon-exchange potential
326 call messages_write('Photon-free px potential is not computed', new_line = .true.)
327 call messages_info()
328 case default
329 assert(.false.)
330 end select
331
332
333 if (.not. xc_photons%llamb_freespace) then
334 ! add the constant energy shift
335 do ia = 1, xc_photons%pt%nmodes
336 xc_photons%ex = xc_photons%ex + 0.5_real64 * (xc_photons%pt%dressed_omega(ia)-xc_photons%pt%omega(ia))
337 end do
338 end if
339
340 pop_sub(xc_photons_v_ks)
341 end subroutine xc_photons_v_ks
342 ! ---------------------------------------------------------
343
344 ! ---------------------------------------------------------
345 ! ---------------------------------------------------------
346 !
378 ! The Lamb shift code is experimental and untested
379 subroutine photon_free_vpx_lda(namespace, xc_photons, total_density, gr, space, psolver)
380 type(namespace_t), intent(in) :: namespace
381 type(xc_photons_t), intent(inout) :: xc_photons
382 real(real64), pointer, contiguous, intent(in) :: total_density(:)
383 class(grid_t), intent(in) :: gr
384 type(space_t), intent(in) :: space
385 type(poisson_t), intent(in) :: psolver
386
387 integer :: ia, ip, iter
388 real(real64) :: unit_volume, r, res, presum, prefact
389 real(real64) :: xx(space%dim), prefactor_lamb
390 real(real64), allocatable :: prefactor(:)
391 real(real64), allocatable :: rho_aux(:)
392 real(real64), allocatable :: grad_rho_aux(:,:)
393 real(real64), allocatable :: px_source(:)
394 real(real64), allocatable :: tmp1(:)
395 real(real64), allocatable :: tmp2(:,:)
396 real(real64), allocatable :: tmp3(:)
397 real(real64), allocatable :: grad_vpx(:,:)
398 real(real64), allocatable :: epsgrad_epsgrad_rho_aux(:)
399 real(real64), allocatable :: epx_force_module(:)
400
401 real(real64), parameter :: threshold = 1e-7_real64
402
403 push_sub(photon_free_vpx_lda)
404
405 if (xc_photons%energy_method == 2 .and. xc_photons%pt%n_electrons >1) then
406 call messages_not_implemented("expectation value for energy for pxLDA more than 1 electron", namespace=namespace)
407 end if
408
409 xc_photons%vpx = m_zero
410 xc_photons%ex = m_zero
411
412 safe_allocate(prefactor(1:xc_photons%pt%nmodes))
413 prefactor = m_zero
414 ! here we will use only one spin channel
415 safe_allocate(rho_aux(1:gr%np_part))
416 safe_allocate(grad_rho_aux(1:gr%np, 1:xc_photons%pt%dim))
417 safe_allocate(px_source(1:gr%np_part))
418 safe_allocate(tmp1(1:gr%np_part))
419 safe_allocate(tmp2(1:gr%np, 1:xc_photons%pt%dim))
420 safe_allocate(tmp3(1:gr%np_part))
421 safe_allocate(grad_vpx(1:gr%np, 1:xc_photons%pt%dim))
422 grad_vpx = m_zero
423 safe_allocate(epx_force_module(1:gr%np_part))
424 epx_force_module = m_zero
425
426 select case(xc_photons%pt%dim)
427 case(1)
428 unit_volume = m_two
429 case(2)
430 unit_volume = m_pi
431 case(3)
432 unit_volume = m_four*m_pi/m_three
433 case default
434 call messages_not_implemented("LDA px more than 3 dimension", namespace=namespace)
435 end select
436
437 !$omp parallel do
438 do ip=1, gr%np
439 rho_aux(ip) = ( abs(total_density(ip))/(m_two*unit_volume) )**(m_two/(xc_photons%pt%dim*m_one))
440 end do
441 !$omp end parallel do
442
443
444 ! compute the electron-photon exchange potential
445
446 if (xc_photons%llamb_freespace) then
447
448 ! Note: The Lamb shift part is currently experimental and untested!
449 ! compute the electron-photon exchange potential
450
451 prefactor_lamb = -(8.0_real64*m_pi*m_third) * xc_photons%lamb_omega / (p_c**3)
452
453 !$OMP parallel do
454 do ip=1,gr%np
455 xc_photons%vpx(ip) = prefactor_lamb*rho_aux(ip)
456 end do
457 !$OMP end parallel do
458
459 else
460
461 do ia = 1, xc_photons%pt%nmodes
462 prefactor(ia) = -m_two*(m_pi * xc_photons%pt%dressed_lambda(ia) / xc_photons%pt%dressed_omega(ia))**2
463 end do
464
465 select case(xc_photons%pt%dim)
466 case(1)
467 ! solve the pxLDA potential using the analytical form in 1D
468 px_source = m_zero
469 do ia = 1, xc_photons%pt%nmodes
470 !$OMP parallel do
471 do ip=1,gr%np_part
472 px_source(ip) = px_source(ip) + prefactor(ia)
473 end do
474 !$OMP end parallel do
475 end do
476
477 !$OMP parallel do
478 do ip=1,gr%np
479 xc_photons%vpx(ip) = px_source(ip)*rho_aux(ip)
480 end do
481 !$OMP end parallel do
482 case(2)
483 call get_px_source(px_source)
484 ! for 2D we solve the Poisson equation using the conjugate gradient method
485 mesh_aux => gr%der%mesh
486 iter = 1000
487 call dconjugate_gradients(gr%np, xc_photons%vpx(:), px_source, laplacian_op, dmf_dotp_aux, iter, res, threshold)
488 write(message(1),'(a,i6,a)') "Info: CG converged with ", iter, " iterations."
489 write(message(2),'(a,e14.6)') "Info: The residue is ", res
490 call messages_info(2, namespace=namespace)
491
492 case(3)
493 ! for 3D we use thepoisson solver including the prefactor (-4*pi)
494 ! therefore, we need to remove the factor in advance
495 call get_px_source(px_source)
496
497 call lalg_scal(gr%np, m_one/(-m_four*m_pi), px_source)
498
499 ! solve the Poisson equation
500 call dpoisson_solve(psolver, namespace, xc_photons%vpx(:), px_source)
501 case default
502 assert(.false.)
503 end select
504
505 end if
506
507 ! scaling the potential
508 call lalg_scal(gr%np, (xc_photons%eta_c * xc_photons%pxlda_kappa), xc_photons%vpx)
509
510 ! compute electron-photon energy
511
512 select case (xc_photons%energy_method)
513 case(1) ! compute the epx energy from the virial relation
514
515 do ia = 1, xc_photons%pt%nmodes
516
517 ! compute the electron-photon force
518 !$omp parallel do
519 do ip = 1, gr%np
520 epx_force_module(ip) = -prefactor(ia)*m_two*abs(total_density(ip))*rho_aux(ip)/(xc_photons%pt%dim*m_one+m_two)
521 end do
522 !$omp end parallel do
523
524 call dderivatives_grad(gr%der, epx_force_module(:), tmp2)
525 call lalg_gemv(gr%np, xc_photons%pt%dim, m_one, tmp2, xc_photons%pt%dressed_pol(1:xc_photons%pt%dim, ia), m_zero, tmp1)
526
527 !$omp parallel do private(r, xx)
528 do ip = 1, gr%np
529 call mesh_r(gr, ip, r, coords=xx)
530 tmp3(ip) = tmp1(ip)*dot_product(xx(1:xc_photons%pt%dim), xc_photons%pt%dressed_pol(1:xc_photons%pt%dim, ia))
531 end do
532 !$omp end parallel do
533
534 xc_photons%ex = xc_photons%ex + m_half*dmf_integrate(gr, tmp3)
535 end do
536
537 xc_photons%ex = xc_photons%eta_c * xc_photons%pxlda_kappa * xc_photons%ex
538
539 case(2) ! compute the energy as expetation value wrt to the wave functions
540
541 rho_aux(1:gr%np) = sqrt(abs( total_density(1:gr%np)))
542
543 safe_allocate(epsgrad_epsgrad_rho_aux(1:gr%np))
544
545 call dderivatives_grad(gr%der, rho_aux(1:gr%np_part), grad_rho_aux)
546
547 do ia = 1, xc_photons%pt%nmodes
548 prefact = (xc_photons%pt%dressed_lambda(ia)**2) / (m_two*xc_photons%pt%dressed_omega(ia)**2)
549
550 call lalg_gemv(gr%np, xc_photons%pt%dim, m_one, grad_rho_aux, xc_photons%pt%dressed_pol(:, ia), m_zero, tmp1)
551 call dderivatives_grad(gr%der, tmp1, tmp2)
552 call lalg_gemv(gr%np, xc_photons%pt%dim, m_one, tmp2, xc_photons%pt%dressed_pol(1:xc_photons%pt%dim, ia), m_zero, tmp1)
553
554 !$OMP parallel do
555 do ip=1, gr%np
556 epsgrad_epsgrad_rho_aux(ip) = epsgrad_epsgrad_rho_aux(ip) + prefact*tmp1(ip)
557 end do
558 !$OMP end parallel do
559
560 end do
561
562 xc_photons%ex = xc_photons%eta_c * dmf_dotp(gr, rho_aux(1:gr%np), epsgrad_epsgrad_rho_aux(1:gr%np))
563
564 safe_deallocate_a(epsgrad_epsgrad_rho_aux)
565
566 case(3) ! integrate the aux electron density over the volume
567
568 !$OMP parallel do
569 do ip=1,gr%np
570 tmp1(ip) = abs( total_density(ip))**((m_one*xc_photons%pt%dim+m_two)/(xc_photons%pt%dim*m_one))
571 end do
572 !$OMP end parallel do
573
574 ! sum over the prefactors
575 presum = m_zero
576 do ia = 1, xc_photons%pt%nmodes
577 presum = presum + prefactor(ia)
578 end do
579 presum = presum * (m_one/(m_two*unit_volume))**(m_two/(xc_photons%pt%dim*m_one)) / (xc_photons%pt%dim*m_one+m_two)
580 presum = presum * xc_photons%eta_c * xc_photons%pxlda_kappa
581
582 xc_photons%ex = xc_photons%eta_c * xc_photons%pxlda_kappa * presum * dmf_integrate(gr, tmp1)
583
584 end select
585
586 safe_deallocate_a(prefactor)
587 safe_deallocate_a(rho_aux)
588 safe_deallocate_a(grad_rho_aux)
589 safe_deallocate_a(px_source)
590 safe_deallocate_a(tmp1)
591 safe_deallocate_a(tmp2)
592 safe_deallocate_a(tmp3)
593 safe_deallocate_a(grad_vpx)
594 safe_deallocate_a(epx_force_module)
595
596 pop_sub(photon_free_vpx_lda)
597
598 contains
599 ! ---------------------------------------------------------
601 subroutine laplacian_op(x, hx)
602 real(real64), contiguous, intent(in) :: x(:)
603 real(real64), contiguous, intent(out) :: Hx(:)
604
605 real(real64), allocatable :: tmpx(:)
606
607 safe_allocate(tmpx(1:gr%np_part))
608 call lalg_copy(gr%np, x, tmpx)
609 call dderivatives_lapl(gr%der, tmpx, hx)
610 safe_deallocate_a(tmpx)
611
612 end subroutine laplacian_op
613
614 subroutine get_px_source(px_source)
615 real(real64), contiguous, intent(out) :: px_source(:)
616
617 call dderivatives_grad(gr%der, rho_aux(1:gr%np_part), grad_rho_aux)
618
619 px_source = m_zero
620 do ia = 1, xc_photons%pt%nmodes
621 call lalg_gemv(gr%np, xc_photons%pt%dim, m_one, grad_rho_aux, xc_photons%pt%dressed_pol(:, ia), m_zero, tmp1)
622 call dderivatives_grad(gr%der, tmp1, tmp2)
623 call lalg_gemv(gr%np, xc_photons%pt%dim, m_one, tmp2, xc_photons%pt%dressed_pol(1:xc_photons%pt%dim, ia), m_zero, tmp1)
624 call lalg_axpy(gr%np, prefactor(ia), tmp1, px_source)
625 end do
626
627 end subroutine get_px_source
628
629 end subroutine photon_free_vpx_lda
630 ! ---------------------------------------------------------
631
632 ! ---------------------------------------------------------
633 !
659 !
660 ! The Lamb shift code is experimental and untested
661
662 subroutine photon_free_vpx_wfc(namespace, xc_photons, total_density, gr, space, st)
663 type(namespace_t), intent(in) :: namespace
664 type(xc_photons_t), intent(inout) :: xc_photons
665 real(real64), pointer, contiguous, intent(in) :: total_density(:)
666 class(grid_t), intent(in) :: gr
667 type(space_t), intent(in) :: space
668 type(states_elec_t), intent(in) :: st
669
670 integer :: ia, ip
671 real(real64) :: prefactor_lamb
672 real(real64) :: xx(space%dim), r
673 real(real64), allocatable :: prefactor(:)
674 real(real64), allocatable :: rho_aux(:)
675 real(real64), allocatable :: grad_rho_aux(:,:)
676 real(real64), allocatable :: grad_vpx(:,:)
677 real(real64), allocatable :: epsgrad_epsgrad_rho_aux(:)
678 real(real64), allocatable :: tmp1(:)
679 real(real64), allocatable :: tmp2(:,:)
680 real(real64) :: shift
681
682 push_sub(photon_free_vpx_wfc)
683
684 if (st%d%nspin >1) then
685 call messages_not_implemented("PhotonXCXCMethod = wavefunction for polarized and spinor cases", namespace=namespace)
686 end if
687
688 if (xc_photons%pt%n_electrons >1) then
689 call messages_not_implemented("PhotonXCXCMethod = wavefunction for more than 1 electron", namespace=namespace)
690 end if
691
692 xc_photons%vpx = m_zero
693 xc_photons%ex = m_zero
695 safe_allocate(prefactor(1:xc_photons%pt%nmodes))
696 prefactor = m_zero
697 safe_allocate(rho_aux(1:gr%np_part))
698 rho_aux = m_zero
699 safe_allocate(grad_rho_aux(1:gr%np, 1:xc_photons%pt%dim))
700 grad_rho_aux = m_zero
701 safe_allocate(epsgrad_epsgrad_rho_aux(1:gr%np))
702 safe_allocate(grad_vpx(1:gr%np, 1:xc_photons%pt%dim))
703 safe_allocate(tmp1(1:gr%np_part))
704 safe_allocate(tmp2(1:gr%np_part, 1:xc_photons%pt%dim))
705
706
707 rho_aux(1:gr%np) = sqrt(abs( total_density(1:gr%np)))
708 !$OMP parallel do
709 do ip = 1, gr%np
710 rho_aux(ip) = safe_tol(rho_aux(ip),1e-18_real64)
711 end do
712 !$OMP end parallel do
713
714 if (xc_photons%llamb_freespace) then
715
716 ! experimental Lamb shift mode
717
718 prefactor_lamb = ( m_two/(m_three*m_pi) ) * xc_photons%lamb_omega / p_c**3
719 call dderivatives_lapl(gr%der, rho_aux(1:gr%np_part), epsgrad_epsgrad_rho_aux)
720 call lalg_scal(gr%np, prefactor_lamb, epsgrad_epsgrad_rho_aux)
721
722 else
723
724 do ia = 1, xc_photons%pt%nmodes
725 prefactor(ia) = (xc_photons%pt%dressed_lambda(ia)**2) / (m_two*xc_photons%pt%dressed_omega(ia)**2)
726 end do
727
728 call dderivatives_grad(gr%der, rho_aux, grad_rho_aux)
729
730 epsgrad_epsgrad_rho_aux = m_zero
731 do ia = 1, xc_photons%pt%nmodes
732 tmp1 = m_zero
733 call lalg_gemv(gr%np, xc_photons%pt%dim, m_one, grad_rho_aux, xc_photons%pt%dressed_pol(:, ia), m_zero, tmp1)
734 call dderivatives_grad(gr%der, tmp1, tmp2)
735 call lalg_gemv(gr%np, xc_photons%pt%dim, prefactor(ia), tmp2, xc_photons%pt%dressed_pol(:, ia), &
736 m_one, epsgrad_epsgrad_rho_aux)
737 end do
738
739 end if
740
741 !$OMP parallel do
742 do ip = 1, gr%np
743 xc_photons%vpx(ip) = epsgrad_epsgrad_rho_aux(ip)/rho_aux(ip)
744 end do
745 !$OMP end parallel do
746
747 if(st%eigenval(1,1) < m_huge .and. .not. space%is_periodic()) then
748 shift = m_two * st%eigenval(1,1) * prefactor(1)
749 !$OMP parallel do
750 do ip=1, gr%np
751 xc_photons%vpx(ip) = xc_photons%vpx(ip) + shift
752 end do
753 !$OMP end parallel do
754 end if
756 call lalg_scal(gr%np, xc_photons%eta_c, xc_photons%vpx(:))
757
758 select case (xc_photons%energy_method)
759 case(1) ! virial
760
761 call dderivatives_grad(gr%der, xc_photons%vpx(:), grad_vpx)
762 !$OMP parallel do private(r, xx)
763 do ip = 1, gr%np
764 call mesh_r(gr, ip, r, coords=xx)
765 tmp1(ip) = - total_density(ip)*dot_product(xx(1:xc_photons%pt%dim), grad_vpx(ip,1:xc_photons%pt%dim))
766 end do
767 !$OMP end parallel do
768
769 xc_photons%ex = m_half*dmf_integrate(gr, tmp1)
770
771 case(2) ! expectation_value
772 xc_photons%ex = xc_photons%eta_c * dmf_dotp(gr, rho_aux(1:gr%np), epsgrad_epsgrad_rho_aux)
773
774 case default
775 assert(.false.)
776 end select
777
778 safe_deallocate_a(prefactor)
779 safe_deallocate_a(rho_aux)
780 safe_deallocate_a(grad_rho_aux)
781 safe_deallocate_a(grad_vpx)
782 safe_deallocate_a(epsgrad_epsgrad_rho_aux)
783 safe_deallocate_a(tmp1)
784 safe_deallocate_a(tmp2)
785
786 pop_sub(photon_free_vpx_wfc)
787
788 end subroutine photon_free_vpx_wfc
789 ! ---------------------------------------------------------
790
791
792 ! ---------------------------------------------------------
802 !
803 subroutine xc_photons_add_mean_field(xc_photons, gr, space, kpoints, st, time, dt)
804 class(xc_photons_t), intent(inout) :: xc_photons
805 class(grid_t), intent(in) :: gr
806 class(space_t), intent(in) :: space
807 type(kpoints_t), intent(in) :: kpoints
808 type(states_elec_t), intent(inout) :: st
809 real(real64), intent(in) :: time
810 real(real64), intent(in) :: dt
811
812
813 integer :: ia, idir, ispin
814 real(real64) :: pol_dot_jp
815 real(real64), allocatable :: current(:,:,:)
816 real(real64), allocatable :: jp(:)
817
819
820 ! compute the dressed photon-free vector potential
821 xc_photons%mf_vector_potential = m_zero
822
823 safe_allocate(current(1:gr%np_part, 1:space%dim, 1:st%d%nspin))
824 current = m_zero
825 ! here we use the paramagnetic current; note that the physical current here
826 ! only contains the paramagnetic current.
827 call states_elec_calc_quantities(gr, st, kpoints, .false., paramagnetic_current = current)
828
829 ! compute the paramagnetic current
830 safe_allocate(jp(1:space%dim))
831 do idir = 1, space%dim
832 jp(idir) = m_zero
833 do ispin = 1, st%d%spin_channels
834 jp(idir) = jp(idir) + dmf_integrate(gr%der%mesh, current(:,idir,ispin))
835 end do
836 end do
837
838 ! update the 'projected' current
839 do ia = 1, xc_photons%pt%nmodes
840 pol_dot_jp = dot_product(xc_photons%pt%dressed_pol(1:space%dim, ia),jp(1:space%dim))
841 xc_photons%jp_proj_eo(ia,1) = xc_photons%jp_proj_eo(ia,1) + &
842 cos(xc_photons%pt%dressed_omega(ia)*( time-dt))*pol_dot_jp*dt
843 xc_photons%jp_proj_eo(ia,2) = xc_photons%jp_proj_eo(ia,2) + &
844 sin(xc_photons%pt%dressed_omega(ia)*( time-dt))*pol_dot_jp*dt
845 end do
846
847 do ia = 1, xc_photons%pt%nmodes
848 xc_photons%mf_vector_potential(1:xc_photons%pt%dim) = xc_photons%mf_vector_potential(1:xc_photons%pt%dim) &
849 + (-p_c*(xc_photons%pt%dressed_lambda(ia)**2) / xc_photons%pt%dressed_omega(ia)) &
850 * (xc_photons%jp_proj_eo(ia,1)*sin(xc_photons%pt%dressed_omega(ia)* time) &
851 - xc_photons%jp_proj_eo(ia,2)*cos(xc_photons%pt%dressed_omega(ia)* time)) &
852 * xc_photons%pt%dressed_pol(1:xc_photons%pt%dim, ia)
853 end do
854
855 safe_deallocate_a(current)
856 safe_deallocate_a(jp)
857
859
860 end subroutine xc_photons_add_mean_field
861 ! ---------------------------------------------------------
862
863
867 !
868 logical pure function xc_photons_wants_to_renormalize_mass(xc_photons) result (renorm)
869 class(xc_photons_t), intent(in) :: xc_photons
870
871 renorm = (xc_photons%method>0) .and. xc_photons%llamb_freespace .and. xc_photons%llamb_re_mass
872
874
876 real(real64) pure function xc_photons_get_renormalized_emass(xc_photons) result(mass)
877 class(xc_photons_t), intent(in) :: xc_photons
878
879 mass = m_one - (m_four*xc_photons%lamb_omega) / (3.0*m_pi * p_c**3)
880
882
884 !
885 subroutine xc_photons_mf_dump(xc_photons, restart, ierr)
886 class(xc_photons_t), intent(in) :: xc_photons
887 type(restart_t), intent(in) :: restart
888 integer, intent(out) :: ierr
889
890 character(len=80), allocatable :: lines(:)
891 integer :: iunit, err, jj, nmodes
892 integer :: pt_dim
893
894 push_sub(photon_free_mf_dump)
895 nmodes = xc_photons%pt%nmodes
896 pt_dim = xc_photons%pt%dim
897
898 safe_allocate(lines(1:nmodes+pt_dim))
899
900 ierr = 0
901
902 iunit = restart_open(restart, 'photon_free_mf')
903
904 do jj = 1, pt_dim
905 write(lines(jj), '(2x, es19.12)') xc_photons%mf_vector_potential(jj)
906 end do
907
908 do jj = 1, nmodes
909 write(lines(jj+pt_dim), '(a10,1x,I8,a1,2x,2(es19.12,2x))') 'Mode ', jj, ":", xc_photons%jp_proj_eo(jj,1:2)
910 end do
911
912 call restart_write(restart, iunit, lines, nmodes+pt_dim, err)
913 if (err /= 0) ierr = ierr + 1
914 call restart_close(restart, iunit)
915
916 safe_deallocate_a(lines)
917
918 pop_sub(photon_free_mf_dump)
919 end subroutine xc_photons_mf_dump
920
921! ---------------------------------------------------------
922
924 !
925 subroutine xc_photons_mf_load(xc_photons, restart, space, ierr)
926 class(xc_photons_t), intent(inout) :: xc_photons
927 type(restart_t), intent(in) :: restart
928 class(space_t), intent(in) :: space
929 integer, intent(out) :: ierr
930
931 character(len=80), allocatable :: lines(:)
932 character(len=7) :: sdummy
933 integer :: idummy
934 integer :: iunit, err, jj, nmodes
935 integer :: pt_dim
936
937 push_sub(photon_free_mf_load)
938
939 ierr = 0
940 nmodes = xc_photons%pt%nmodes
941 pt_dim = xc_photons%pt%dim
942
943 if (restart_skip(restart)) then
944 ierr = -1
945 pop_sub(photon_free_mf_load)
946 return
947 end if
948
949 if (debug%info) then
950 message(1) = "Debug: Reading Photon-Free Photons restart."
951 call messages_info(1, namespace=restart%namespace)
952 end if
953
954 if ( .not. allocated(xc_photons%jp_proj_eo)) then
955 safe_allocate(xc_photons%jp_proj_eo(1:xc_photons%pt%nmodes, 1:2))
956 xc_photons%jp_proj_eo = m_zero
957 end if
958 if ( .not. allocated(xc_photons%mf_vector_potential)) then
959 safe_allocate(xc_photons%mf_vector_potential(1:space%dim))
960 xc_photons%mf_vector_potential = m_zero
961 end if
962
963 safe_allocate(lines(1:nmodes+pt_dim))
964 iunit = restart_open(restart, 'photon_free_mf')
965 call restart_read(restart, iunit, lines, nmodes+pt_dim, err)
966 if (err /= 0) then
967 ierr = ierr + 1
968 else
969 do jj = 1, pt_dim
970 read(lines(jj),'(2x, es19.12)') xc_photons%mf_vector_potential(jj)
971 end do
972
973 do jj = 1, nmodes
974 read(lines(jj+pt_dim), '(a10,1x,I8,a1,2x,2(es19.12,2x))') sdummy, idummy, sdummy, xc_photons%jp_proj_eo(jj,1:2)
975 end do
976 end if
977 call restart_close(restart, iunit)
979 if (debug%info) then
980 message(1) = "Debug: Reading Photons restart done."
981 call messages_info(1, namespace=restart%namespace)
982 end if
983
984 safe_deallocate_a(lines)
985
986 pop_sub(photon_free_mf_load)
987 end subroutine xc_photons_mf_load
988
989end module xc_photons_oct_m
990
991!! Local Variables:
992!! mode: f90
993!! coding: utf-8
994!! End:
constant times a vector plus a vector
Definition: lalg_basic.F90:170
Copies a vector x, to a vector y.
Definition: lalg_basic.F90:185
scales a vector by a constant
Definition: lalg_basic.F90:156
double sin(double __x) __attribute__((__nothrow__
double sqrt(double __x) __attribute__((__nothrow__
double cos(double __x) __attribute__((__nothrow__
This module calculates the derivatives (gradients, Laplacians, etc.) of a function.
subroutine, public dderivatives_grad(der, ff, op_ff, ghost_update, set_bc, to_cartesian)
apply the gradient to a mesh function
subroutine, public dderivatives_lapl(der, ff, op_ff, ghost_update, set_bc, factor)
apply the Laplacian to a mesh function
real(real64), parameter, public m_two
Definition: global.F90:189
real(real64), parameter, public m_huge
Definition: global.F90:205
real(real64), parameter, public m_zero
Definition: global.F90:187
real(real64), parameter, public m_four
Definition: global.F90:191
real(real64), parameter, public m_third
Definition: global.F90:194
real(real64), parameter, public m_pi
some mathematical constants
Definition: global.F90:185
real(real64), parameter, public m_half
Definition: global.F90:193
real(real64), parameter, public p_c
Electron gyromagnetic ratio, see Phys. Rev. Lett. 130, 071801 (2023)
Definition: global.F90:223
real(real64), parameter, public m_one
Definition: global.F90:188
real(real64), parameter, public m_three
Definition: global.F90:190
This module implements the underlying real-space grid.
Definition: grid.F90:117
This module defines various routines, operating on mesh functions.
class(mesh_t), pointer, public mesh_aux
Globally-scoped pointer to the mesh instance.
real(real64) function, public dmf_dotp_aux(f1, f2)
dot product between two vectors (mesh functions)
real(real64) function, public dmf_integrate(mesh, ff, mask, reduce)
Integrate a function on the mesh.
This module defines the meshes, which are used in Octopus.
Definition: mesh.F90:118
pure subroutine, public mesh_r(mesh, ip, rr, origin, coords)
return the distance to the origin for a given grid point
Definition: mesh.F90:336
subroutine, public messages_not_implemented(feature, namespace)
Definition: messages.F90:1125
subroutine, public messages_info(no_lines, iunit, verbose_limit, stress, all_nodes, namespace)
Definition: messages.F90:624
character(len=256), dimension(max_lines), public message
to be output by fatal, warning
Definition: messages.F90:160
subroutine, public messages_fatal(no_lines, only_root_writes, namespace)
Definition: messages.F90:420
subroutine, public messages_experimental(name, namespace)
Definition: messages.F90:1097
logical function, public parse_is_defined(namespace, name)
Definition: parser.F90:502
subroutine, public photon_mode_end(this)
subroutine, public photon_mode_dressed(this)
subroutine, public photon_mode_set_n_electrons(this, qtot)
subroutine, public photon_mode_init(this, namespace, dim, photon_free)
subroutine, public dpoisson_solve(this, namespace, pot, rho, all_nodes, kernel)
Calculates the Poisson equation. Given the density returns the corresponding potential.
Definition: poisson.F90:892
This module is intended to contain "only mathematical" functions and procedures.
Definition: solvers.F90:115
subroutine, public states_elec_calc_quantities(gr, st, kpoints, nlcc, kinetic_energy_density, paramagnetic_current, density_gradient, density_laplacian, gi_kinetic_energy_density, st_end)
calculated selected quantities
This module implements the "photon-free" electron-photon exchange-correlation functional.
Definition: xc_photons.F90:121
subroutine photon_free_vpx_wfc(namespace, xc_photons, total_density, gr, space, st)
compute the electron-photon exchange potential based on wave functions
Definition: xc_photons.F90:756
subroutine xc_photons_v_ks(xc_photons, namespace, total_density, density, gr, space, psolver, ep, st)
evaluate the KS potential and energy for the given functional
Definition: xc_photons.F90:384
logical pure function xc_photons_wants_to_renormalize_mass(xc_photons)
indicate whether the photon-exchange requires a renormalized electron mass
Definition: xc_photons.F90:962
subroutine xc_photons_init(xc_photons, namespace, xc_photon, space, gr, st)
initialize the photon-exchange functional
Definition: xc_photons.F90:200
subroutine xc_photons_add_mean_field(xc_photons, gr, space, kpoints, st, time, dt)
accumulate the results of time integral the paramagnetic current.
Definition: xc_photons.F90:897
subroutine xc_photons_mf_dump(xc_photons, restart, ierr)
write restart information
Definition: xc_photons.F90:979
real(real64) pure function xc_photons_get_renormalized_emass(xc_photons)
return the renormalized electron mass for the electron-photon exhange
Definition: xc_photons.F90:970
integer, parameter, private xc_photons_lda
Definition: xc_photons.F90:189
subroutine photon_free_vpx_lda(namespace, xc_photons, total_density, gr, space, psolver)
compute the electron-photon exchange potential within the LDA
Definition: xc_photons.F90:473
subroutine xc_photons_end(this)
Definition: xc_photons.F90:360
integer, parameter, private xc_photons_wfs
Definition: xc_photons.F90:189
subroutine xc_photons_mf_load(xc_photons, restart, space, ierr)
load restart information
Description of the grid, containing information on derivatives, stencil, and symmetries.
Definition: grid.F90:168
The states_elec_t class contains all electronic wave functions.
This class described the 'photon-exchange' electron-photon xc functionals, based on QEDFT.
Definition: xc_photons.F90:156
int true(void)
subroutine laplacian_op(x, hx)
Computes .
Definition: test.F90:534
subroutine get_px_source(px_source)
Definition: xc_photons.F90:708