Octopus
rdmft.F90
Go to the documentation of this file.
1!! Copyright (C) 2012-2019 I. Theophilou, N. Helbig
2!! Copyright (C) 2019 F. Buchholz, M. Oliveira
3!!
4!! This program is free software; you can redistribute it and/or modify
5!! it under the terms of the GNU General Public License as published by
6!! the Free Software Foundation; either version 2, or (at your option)
7!! any later version.
8!!
9!! This program is distributed in the hope that it will be useful,
10!! but WITHOUT ANY WARRANTY; without even the implied warranty of
11!! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
12!! GNU General Public License for more details.
13!!
14!! You should have received a copy of the GNU General Public License
15!! along with this program; if not, write to the Free Software
16!! Foundation, Inc., 51 Franklin Street, Fifth Floor, Boston, MA
17!! 02110-1301, USA.
18!!
19
20#include "global.h"
21
22module rdmft_oct_m
23 use debug_oct_m
30 use energy_oct_m
32 use global_oct_m
33 use grid_oct_m
37 use io_oct_m
39 use ions_oct_m
40 use, intrinsic :: iso_fortran_env
42 use loct_oct_m
43 use math_oct_m
44 use mesh_oct_m
48 use mpi_oct_m
52 use output_oct_m
55 use parser_oct_m
60 use space_oct_m
65 use unit_oct_m
67 use v_ks_oct_m
68 use xc_oep_oct_m
70
71 implicit none
72
73 private
74 public :: &
75 rdm_t, &
76 rdmft_init, &
77 rdmft_end, &
79
80 type rdm_t
81 private
82 type(eigensolver_t) :: eigens
83 integer :: max_iter
84 integer :: iter
85 integer :: nst
86 integer :: n_twoint !number of unique two electron integrals
87 logical :: do_basis
88 logical :: hf
89 real(real64) :: mu
90 real(real64) :: occsum
91 real(real64) :: qtot
92 real(real64) :: scale_f
93 real(real64) :: toler
94 real(real64) :: conv_ener
95 real(real64) :: maxFO
96 real(real64) :: tolerFO
97
98 real(real64), allocatable :: eone(:)
99 real(real64), allocatable :: eone_int(:, :)
100 real(real64), allocatable :: twoint(:)
101 real(real64), allocatable :: hartree(:, :)
102 real(real64), allocatable :: exchange(:, :)
103 real(real64), allocatable :: evalues(:)
104 real(real64), allocatable :: vecnat(:, :)
105 real(real64), allocatable :: Coul(:,:,:)
106 real(real64), allocatable :: Exch(:,:,:)
107
108 integer, allocatable :: i_index(:, :)
109 integer, allocatable :: j_index(:, :)
110 integer, allocatable :: k_index(:, :)
111 integer, allocatable :: l_index(:, :)
112 end type rdm_t
113
114 type(rdm_t), pointer :: rdm_ptr
115
116contains
118 ! ---------------------------------------------------------
119 subroutine rdmft_init(rdm, namespace, gr, st, hm, mc, space, fromScratch)
120 type(rdm_t), intent(out) :: rdm
121 type(namespace_t), intent(in) :: namespace
122 type(grid_t), intent(inout) :: gr
123 type(states_elec_t), intent(in) :: st
124 type(hamiltonian_elec_t), intent(in) :: hm
125 type(multicomm_t), intent(in) :: mc
126 class(space_t), intent(in) :: space
127 logical, intent(in) :: fromScratch
128
129 push_sub(rdmft_init)
130
131 if(st%nst < st%qtot + 1) then
132 message(1) = "Too few states to run RDMFT calculation"
133 message(2) = "Number of states should be at least the number of electrons plus one"
134 call messages_fatal(2, namespace=namespace)
135 end if
136
137 if (states_are_complex(st)) then
138 call messages_not_implemented("Complex states for RDMFT", namespace=namespace)
139 end if
140
141 ! The documentation for the variable is found in scf_init.
142 call parse_variable(namespace, 'MaximumIter', 200, rdm%max_iter)
143
144 !%Variable RDMTolerance
145 !%Type float
146 !%Default 1e-7 Ha
147 !%Section SCF::RDMFT
148 !%Description
149 !% Convergence criterion for stopping the occupation numbers minimization. Minimization is
150 !% stopped when all derivatives of the energy wrt. each occupation number
151 !% are smaller than this criterion. The bisection for finding the correct mu that is needed
152 !% for the occupation number minimization also stops according to this criterion.
153 !%End
154 call parse_variable(namespace, 'RDMTolerance', 1.0e-7_real64, rdm%toler)
155
156 !%Variable RDMToleranceFO
157 !%Type float
158 !%Default 1e-4 Ha
159 !%Section SCF::RDMFT
160 !%Description
161 !% Convergence criterion for stopping the diagonalization of the Fock matrix in the Piris method.
162 !% Orbital minimization is stopped when all off-diagonal ellements of the Fock matrix
163 !% are smaller than this criterion.
164 !%End
165 call parse_variable(namespace, 'RDMToleranceFO', 1.0e-4_real64, rdm%tolerFO)
166
167 !%Variable RDMConvEner
168 !%Type float
169 !%Default 1e-6 Ha
170 !%Section SCF::RDMFT
171 !%Description
172 !% Convergence criterion for stopping the overall minimization of the energy with
173 !% respect to occupation numbers and the orbitals. The minimization of the
174 !% energy stops when the total energy difference between two subsequent
175 !% minimizations of the energy with respect to the occupation numbers and the
176 !% orbitals is smaller than this criterion. It is also used to exit the orbital minimization.
177 !%End
178 call parse_variable(namespace, 'RDMConvEner', 1.0e-7_real64, rdm%conv_ener)
180 !%Variable RDMBasis
181 !%Type logical
182 !%Default yes
183 !%Section SCF::RDMFT
184 !%Description
185 !% If true, all the energy terms and corresponding derivatives involved in RDMFT will
186 !% not be calculated on the grid but on the basis of the initial orbitals
187 !%End
188 call parse_variable(namespace, 'RDMBasis',.true., rdm%do_basis)
190 if (rdm%do_basis .and. fromscratch) then
191 call messages_write("RDMFT calculations with RDMBasis = yes cannot be started FromScratch", new_line=.true.)
192 call messages_write("Run a calculation for independent particles first")
193 call messages_fatal(namespace=namespace)
194 end if
196 !%Variable RDMHartreeFock
197 !%Type logical
198 !%Default no
199 !%Section SCF::RDMFT
200 !%Description
201 !% If true, the code simulates a HF calculation, by omitting the occ.num. optimization
202 !% can be used for test reasons
203 !%End
204 call parse_variable(namespace, 'RDMHartreeFock',.false., rdm%hf)
206 rdm%nst = st%nst
207 if (rdm%do_basis) then
208 rdm%n_twoint = rdm%nst*(rdm%nst + 1)*(rdm%nst**2 + rdm%nst + 2)/8
209 safe_allocate(rdm%eone_int(1:rdm%nst, 1:rdm%nst))
210 safe_allocate(rdm%twoint(1:rdm%n_twoint))
211 safe_allocate(rdm%i_index(1:2,1:rdm%n_twoint))
212 safe_allocate(rdm%j_index(1:2,1:rdm%n_twoint))
213 safe_allocate(rdm%k_index(1:2,1:rdm%n_twoint))
214 safe_allocate(rdm%l_index(1:2,1:rdm%n_twoint))
215 safe_allocate(rdm%vecnat(1:rdm%nst, 1:rdm%nst))
216 safe_allocate(rdm%Coul(1:rdm%nst, 1:rdm%nst, 1:rdm%nst))
217 safe_allocate(rdm%Exch(1:rdm%nst, 1:rdm%nst, 1:rdm%nst))
218 rdm%eone_int = m_zero
219 rdm%twoint = m_zero
220 rdm%vecnat(:, :) = diagonal_matrix(rdm%nst, m_one)
221 rdm%i_index = m_zero
222 rdm%j_index = m_zero
223 rdm%k_index = m_zero
224 rdm%l_index = m_zero
225 rdm%Coul = m_zero
226 rdm%Exch = m_zero
227 else
228 ! initialize eigensolver.
229 call eigensolver_init(rdm%eigens, namespace, gr, st, hm, mc, space)
230 end if
231
232 safe_allocate(rdm%eone(1:rdm%nst))
233 safe_allocate(rdm%hartree(1:rdm%nst, 1:rdm%nst))
234 safe_allocate(rdm%exchange(1:rdm%nst, 1:rdm%nst))
235 safe_allocate(rdm%evalues(1:rdm%nst))
236
237 rdm%eone = m_zero
238 rdm%hartree = m_zero
239 rdm%exchange = m_zero
240 rdm%evalues = m_zero
241 rdm%mu = m_two*st%eigenval(int(st%qtot*m_half), 1)
242 rdm%qtot = st%qtot
243 rdm%occsum = m_zero
244 rdm%scale_f = 1e-2_real64
245 rdm%maxFO = m_zero
246 rdm%iter = 0
247
248 pop_sub(rdmft_init)
249 end subroutine rdmft_init
250
251 ! ----------------------------------------
252
253 subroutine rdmft_end(rdm)
254 type(rdm_t), intent(inout) :: rdm
255
256 push_sub(rdmft_end)
257
258 safe_deallocate_a(rdm%evalues)
259 safe_deallocate_a(rdm%eone)
260 safe_deallocate_a(rdm%hartree)
261 safe_deallocate_a(rdm%exchange)
262
263 if (rdm%do_basis) then
264 safe_deallocate_a(rdm%eone_int)
265 safe_deallocate_a(rdm%twoint)
266 safe_deallocate_a(rdm%i_index)
267 safe_deallocate_a(rdm%j_index)
268 safe_deallocate_a(rdm%k_index)
269 safe_deallocate_a(rdm%l_index)
270 safe_deallocate_a(rdm%vecnat)
271 safe_deallocate_a(rdm%Coul)
272 safe_deallocate_a(rdm%Exch)
273 else
274 call eigensolver_end(rdm%eigens)
275 end if
276
277 pop_sub(rdmft_end)
278 end subroutine rdmft_end
279
280 ! ----------------------------------------
281
282 ! scf for the occupation numbers and the natural orbitals
283 subroutine scf_rdmft(rdm, namespace, space, mc, gr, ions, ext_partners, st, ks, hm, outp, restart_dump)
284 type(rdm_t), intent(inout) :: rdm
285 type(namespace_t), intent(in) :: namespace
286 type(electron_space_t), intent(in) :: space
287 type(multicomm_t), intent(in) :: mc
288 type(grid_t), intent(in) :: gr
289 type(ions_t), intent(in) :: ions
290 type(partner_list_t), intent(in) :: ext_partners
291 type(states_elec_t), intent(inout) :: st
292 type(v_ks_t), intent(inout) :: ks
293 type(hamiltonian_elec_t), intent(inout) :: hm
294 type(output_t), intent(in) :: outp
295 type(restart_t), intent(in) :: restart_dump
296
297 type(states_elec_t) :: states_save
298 integer :: iter, icount, ip, ist, ierr, maxcount, iorb
299 integer(int64) :: what_i
300 real(real64) :: energy, energy_dif, energy_old, energy_occ, xpos, xneg, rel_ener
301 real(real64), allocatable :: dpsi(:, :), dpsi2(:, :)
302 logical :: conv
303 character(len=MAX_PATH_LEN) :: dirname
304
305 push_sub(scf_rdmft)
306
307 if (hm%d%ispin /= 1) then
308 call messages_not_implemented("RDMFT exchange function not yet implemented for spin_polarized or spinors", &
309 namespace=namespace)
310 end if
311
312 ! problem is about k-points for exchange
313 if (space%is_periodic()) then
314 call messages_not_implemented("Periodic system calculations for RDMFT", namespace=namespace)
315 end if
316
317 ! exchange routine needs all states on each processor currently
318 if(st%parallel_in_states) then
319 call messages_not_implemented("RDMFT parallel in states", namespace=namespace)
320 end if
321
322 call messages_print_with_emphasis(msg='RDMFT Calculation', namespace=namespace)
323 call messages_print_var_value('RDMBasis', rdm%do_basis, namespace=namespace)
324
325 !set initial values
326 energy_old = 1.0e20_real64
327 xpos = m_zero
328 xneg = m_zero
329 energy = m_zero
330 if (.not. rdm%do_basis) then
331 maxcount = 1 !still needs to be checked
332 else
333 maxcount = 50
334 !precalculate matrix elements in basis
335 write(message(1),'(a)') 'Calculating Coulomb and exchange matrix elements in basis'
336 write(message(2),'(a)') '--this may take a while--'
337 call messages_info(2, namespace=namespace)
338
339 call two_body_me(gr, st, space, namespace, hm%kpoints, hm%exxop%psolver, 1, st%nst, rdm%i_index, rdm%j_index, rdm%k_index, &
340 rdm%l_index, rdm%twoint)
341 call rdm_integrals(rdm, namespace, hm, st, gr)
342 call sum_integrals(rdm)
343 endif
344
345 ! Start the actual minimization, first step is minimization of occupation numbers
346 ! Orbital minimization is according to Piris and Ugalde, Vol. 30, No. 13, J. Comput. Chem. (scf_orb) or
347 ! using conjugated gradient (scf_orb_cg)
348 do iter = 1, rdm%max_iter
349 rdm%iter = rdm%iter + 1
350 write(message(1), '(a)') '**********************************************************************'
351 write(message(2),'(a, i4)') 'Iteration:', iter
352 call messages_info(2, namespace=namespace)
353 ! occupation number optimization unless we are doing Hartree-Fock
354 if (rdm%hf) then
355 call scf_occ_no(rdm, namespace, gr, hm, space, st, energy_occ)
356 else
357 call scf_occ(rdm, namespace, gr, hm, space, st, energy_occ)
358 end if
359 ! orbital optimization
360 write(message(1), '(a)') 'Optimization of natural orbitals'
361 call messages_info(1, namespace=namespace)
362 do icount = 1, maxcount
363 if (rdm%do_basis) then
364 call scf_orb(rdm, namespace, gr, st, hm, space, energy)
365 else
366 call scf_orb_cg(rdm, namespace, space, gr, ions, ext_partners, st, ks, hm, energy)
367 end if
368 energy_dif = energy - energy_old
369 energy_old = energy
370 if (rdm%do_basis) then
371 if (abs(energy_dif)/abs(energy) < rdm%conv_ener .and. rdm%maxFO < rdm%tolerFO) exit
372 if (energy_dif < m_zero) then
373 xneg = xneg + 1
374 else
375 xpos = xpos + 1
376 end if
377 if (xneg > 1.5e0_real64*xpos) then
378 rdm%scale_f = 1.01_real64*rdm%scale_f
379 elseif (xneg < 1.1e0_real64*xpos) then
380 rdm%scale_f = 0.95_real64* rdm%scale_f
381 end if
382 endif !rdm%do_basis
383 end do !icount
384 xneg = m_zero
385 xpos = m_zero
386
387 rel_ener = abs(energy_occ-energy)/abs(energy)
388
389 write(message(1),'(a,11x,es20.10)') 'Total energy:', units_from_atomic(units_out%energy,energy + hm%ep%eii)
390 write(message(2),'(a,1x,es20.10)') 'Rel. energy difference:', rel_ener
391 call messages_info(2, namespace=namespace)
392
393 if (.not. rdm%hf .and. rdm%do_basis) then
394 write(message(1),'(a,18x,es20.10)') 'Max F0:', rdm%maxFO
395 call messages_info(1, namespace=namespace)
396 end if
397
398
399 if (rdm%do_basis) then
400 conv = (rel_ener < rdm%conv_ener) .and. rdm%maxFO < rdm%tolerFO
401 else
402 conv = rel_ener < rdm%conv_ener
403 endif
404
405 !Is this still okay or does it restrict the possible convergence? FB: Does this makes sense at all?
406 if (rdm%toler > 1e-4_real64) rdm%toler = rdm%toler*1e-1_real64
407
408 ! save restart information
409 if ((conv .or. restart_walltime_period_alarm(mc%master_comm) .or. iter == rdm%max_iter)) then
410 if (rdm%do_basis) then
411 call states_elec_copy(states_save, st)
412 safe_allocate(dpsi(1:gr%np, 1:st%d%dim))
413 safe_allocate(dpsi2(1:gr%np, 1:st%d%dim))
414 do iorb = 1, st%nst
415 dpsi = m_zero
416 do ist = 1, st%nst
417 call states_elec_get_state(st, gr, ist, 1, dpsi2)
418 do ip = 1, gr%np
419 dpsi(ip,1) = dpsi(ip,1) + rdm%vecnat(ist, iorb)*dpsi2(ip,1)
420 end do
421 end do
422 call states_elec_set_state(states_save, gr, iorb, 1, dpsi)
423 end do
424 call density_calc(states_save, gr, states_save%rho)
425 ! if other quantities besides the densities and the states are needed they also have to be recalculated here!
426 call states_elec_dump(restart_dump, space, states_save, gr, hm%kpoints, ierr, iter=iter)
427
428 if (conv .or. iter == rdm%max_iter) then
429 call states_elec_end(st)
430 call states_elec_copy(st, states_save)
431 end if
432
433 call states_elec_end(states_save)
434
435 safe_deallocate_a(dpsi)
436 safe_deallocate_a(dpsi2)
437 else
438 call states_elec_dump(restart_dump, space, st, gr, hm%kpoints, ierr, iter=iter)
439
440 ! calculate maxFO for cg-solver
441 if (.not. rdm%hf) then
442 call calc_maxfo (namespace, hm, st, gr, rdm)
443 write(message(1),'(a,18x,es20.10)') 'Max F0:', rdm%maxFO
444 call messages_info(1, namespace=namespace)
445 end if
446 endif
447
448 if (ierr /= 0) then
449 message(1) = 'Unable to write states wavefunctions.'
450 call messages_warning(1, namespace=namespace)
451 end if
452
453 endif
454
455 ! write output for iterations if requested
456 if (any(outp%what) .and. outp%duringscf) then
457 do what_i = lbound(outp%what, 1), ubound(outp%what, 1)
458 if (outp%what_now(what_i, iter)) then
459 write(dirname,'(a,a,i4.4)') trim(outp%iter_dir), "scf.", iter
460 call output_all(outp, namespace, space, dirname, gr, ions, iter, st, hm, ks)
461 call output_modelmb(outp, namespace, space, dirname, gr, ions, iter, st)
462 call scf_write_static(dirname, "info")
463 exit
464 end if
465 end do
466 end if
467
468 if (conv) exit
469 end do
470
471 if(conv) then
472 write(message(1),'(a,i3,a)') 'The calculation converged after ',rdm%iter,' iterations'
473 write(message(2),'(a,9x,es20.10)') 'The total energy is ', units_from_atomic(units_out%energy,energy + hm%ep%eii)
474 call messages_info(2, namespace=namespace)
475 else
476 write(message(1),'(a,i3,a)') 'The calculation did not converge after ', iter-1, ' iterations '
477 write(message(2),'(a,es15.5)') 'Relative energy difference between the last two iterations ', rel_ener
478 write(message(3),'(a,es15.5)') 'The maximal non-diagonal element of the Hermitian matrix F is ', rdm%maxFO
479 call messages_info(3, namespace=namespace)
480 end if
481
482 call scf_write_static(static_dir, "info")
483 call output_all(outp, namespace, space, static_dir, gr, ions, -1, st, hm, ks)
484 call output_modelmb(outp, namespace, space, static_dir, gr, ions, -1, st)
485
486 pop_sub(scf_rdmft)
487
488 contains
489 ! ---------------------------------------------------------
490 subroutine scf_write_static(dir, fname)
491 character(len=*), intent(in) :: dir, fname
492
493 integer :: iunit, ist
494 real(real64), allocatable :: photon_number_state (:), ekin_state (:), epot_state (:)
495
497
498 safe_allocate(photon_number_state(1:st%nst))
499 safe_allocate(ekin_state(1:st%nst))
500 safe_allocate(epot_state(1:st%nst))
501
502 if(mpi_world%is_root()) then
503 call io_mkdir(dir, namespace)
504 iunit = io_open(trim(dir) // "/" // trim(fname), namespace, action='write')
505
506 call grid_write_info(gr, iunit=iunit)
507
508 call v_ks_write_info(ks, iunit=iunit)
509
510 if (rdm%do_basis) then
511 write(iunit, '(a)')'Orbital optimization with [basis set]'
512 else
513 write(iunit, '(a)')'Orbital optimization with [conjugated gradients]'
514 end if
515 write(iunit, '(1x)')
516
517 if (rdm%hf) then
518 write(iunit, '(a)')'Hartree Fock calculation'
519 write(iunit, '(1x)')
520 end if
521
522 if (hm%psolver%is_dressed) then
523 write(iunit, '(a)')'Dressed state calculation'
524 call photon_mode_write_info(hm%psolver%photons, iunit=iunit)
525 write(iunit, '(1x)')
526 end if
527
528 ! scf information
529 if(conv) then
530 write(iunit, '(a, i4, a)')'SCF converged in ', iter, ' iterations'
531 else
532 write(iunit, '(a)') 'SCF *not* converged!'
533 end if
534 write(iunit, '(1x)')
535
536 write(iunit, '(3a,es20.10)') 'Total Energy [', trim(units_abbrev(units_out%energy)), ']:', &
537 units_from_atomic(units_out%energy, energy + hm%ep%eii)
538 write(iunit,'(a,1x,f16.12)') 'Sum of occupation numbers:', rdm%occsum
539 else
540 iunit = 0
541 end if
542
543 if (hm%psolver%is_dressed) then
544 call calc_photon_number(space, gr, st, hm%psolver%photons, photon_number_state, ekin_state, epot_state)
545 if(mpi_world%is_root()) then
546 write(iunit,'(a,1x,f14.12)') 'Total mode occupation:', hm%psolver%photons%number(1)
547 end if
548 end if
549
550 if(mpi_world%is_root()) then
551 if (rdm%max_iter > 0) then
552 write(iunit, '(a)') 'Convergence:'
553 write(iunit, '(6x, a, es15.8,a,es15.8,a)') 'maxFO = ', rdm%maxFO
554 write(iunit, '(6x, a, es15.8,a,es15.8,a)') 'rel_ener = ', rel_ener
555 write(iunit,'(1x)')
556 end if
557 ! otherwise, these values are uninitialized, and unknown.
558 end if
559
560 if (mpi_world%is_root()) then
561 ! Write header
562 write(iunit,'(a)') 'Natural occupation numbers:'
563 write(iunit,'(a4,5x,a12)', advance='no') '#st', 'Occupation'
564 if (.not. rdm%do_basis) write(iunit,'(5x,a12)', advance='no') 'conv'
565 if (hm%psolver%is_dressed) write(iunit,'(3(5x,a12))', advance='no') 'Mode Occ.', '-1/2d^2/dq^2', '1/2w^2q^2'
566 write(iunit,*)
567
568 ! Write values
569 do ist = 1, st%nst
570 write(iunit,'(i4,3x,f14.12)', advance='no') ist, st%occ(ist, 1)
571 if (.not. rdm%do_basis) write(iunit,'(3x,f14.12)', advance='no') rdm%eigens%diff(ist, 1)
572 if (hm%psolver%is_dressed) then
573 write(iunit,'(3(3x,f14.12))', advance='no') photon_number_state(ist), ekin_state(ist), epot_state(ist)
574 end if
575 write(iunit,*)
576 end do
577 end if
578
579 if (mpi_world%is_root()) then
580 call io_close(iunit)
581 end if
582
583 safe_deallocate_a(photon_number_state)
584 safe_deallocate_a(ekin_state)
585 safe_deallocate_a(epot_state)
586
588 end subroutine scf_write_static
589 end subroutine scf_rdmft
590
591 ! ---------------------------------------------------------
592 subroutine calc_maxfo (namespace, hm, st, gr, rdm)
593 type(namespace_t), intent(in) :: namespace
594 type(rdm_t), intent(inout) :: rdm
595 type(grid_t), intent(in) :: gr
596 type(hamiltonian_elec_t), intent(inout) :: hm
597 type(states_elec_t), intent(inout) :: st
598
599 real(real64), allocatable :: lambda(:, :), FO(:, :)
600 integer :: ist, jst
601
602 push_sub(calc_maxfo)
603
604 safe_allocate(lambda(1:st%nst,1:st%nst))
605 safe_allocate(fo(1:st%nst, 1:st%nst))
606
607 ! calculate FO operator to check Hermiticity of lagrange multiplier matrix (lambda)
608 lambda = m_zero
609 fo = m_zero
610 call construct_lambda(namespace, hm, st, gr, lambda, rdm)
611
612 !Set up FO matrix to check maxFO
613 do ist = 1, st%nst
614 do jst = 1, ist - 1
615 fo(jst, ist) = - (lambda(jst, ist) - lambda(ist ,jst))
616 end do
617 end do
618 rdm%maxFO = maxval(abs(fo))
619
620 safe_deallocate_a(lambda)
621 safe_deallocate_a(fo)
622
623 pop_sub(calc_maxfo)
624 end subroutine calc_maxfo
625
626 ! ---------------------------------------------------------
627 subroutine calc_photon_number(space, gr, st, photons, photon_number_state, ekin_state, epot_state)
628 class(space_t), intent(in) :: space
629 type(grid_t), intent(in) :: gr
630 type(states_elec_t), intent(in) :: st
631 type(photon_mode_t), intent(inout) :: photons
632 real(real64), intent(out) :: photon_number_state(:)
633 real(real64), intent(out) :: ekin_state(:)
634 real(real64), intent(out) :: epot_state(:)
635
636 integer :: ist, dim_photon
637 real(real64) :: q2_exp, laplace_exp
638 real(real64), allocatable :: psi(:, :), psi_q2(:), dpsidq(:), d2psidq2(:)
639
640 push_sub(calc_photon_number)
641
642 ! The photon dimension is always the last
643 dim_photon = space%dim
644
645 safe_allocate(psi(1:gr%np_part, 1))
646 safe_allocate(psi_q2(1:gr%np))
647 safe_allocate(dpsidq(1:gr%np_part))
648 safe_allocate(d2psidq2(1:gr%np))
649
650 photons%number(1) = m_zero
651
652 do ist = 1, st%nst
653 call states_elec_get_state(st, gr, ist, 1, psi)
654
655 ! <phi(ist)|d^2/dq^2|phi(ist)> ~= <phi(ist)| d/dq (d/dq|phi(ist)>)
656 call dderivatives_partial(gr%der, psi(:, 1), dpsidq(:), dim_photon, ghost_update = .true., set_bc = .true.)
657 call dderivatives_partial(gr%der, dpsidq(1:gr%np_part), d2psidq2(:), dim_photon, ghost_update = .true., set_bc = .true.)
658 laplace_exp = dmf_dotp(gr, psi(:, 1), d2psidq2(:))
659 ekin_state(ist) = -m_half*laplace_exp
660
661 ! <phi(ist)|q^2|psi(ist)>= |q|psi(ist)>|^2
662 psi_q2(1:gr%np) = psi(1:gr%np, 1) * gr%x(1:gr%np, dim_photon)**2
663 q2_exp = dmf_dotp(gr, psi(:, 1), psi_q2(:))
664 epot_state(ist) = m_half * photons%omega(1)**2 * q2_exp
665
666 !! N_phot(ist)=( <phi_i|H_ph|phi_i>/omega - 0.5 ) / N_elec
667 !! with <phi_i|H_ph|phi_i>=-0.5* <phi(ist)|d^2/dq^2|phi(ist)> + 0.5*omega <phi(ist)|q^2|psi(ist)>
668 photon_number_state(ist) = -m_half*laplace_exp / photons%omega(1) + m_half * photons%omega(1) * q2_exp
669 photon_number_state(ist) = photon_number_state(ist) - m_half
670
671 !! N_phot_total= sum_ist occ_ist*N_phot(ist)
672 photons%number(1) = photons%number(1) + (photon_number_state(ist) + m_half)*st%occ(ist, 1)
673 ! 0.5 must be added again to do the normalization due to the total charge correctly
674 end do
675
676 photons%number(1) = photons%number(1) - st%qtot/m_two
677
678 safe_deallocate_a(psi)
679 safe_deallocate_a(psi_q2)
680 safe_deallocate_a(dpsidq)
681 safe_deallocate_a(d2psidq2)
682
683 pop_sub(calc_photon_number)
684 end subroutine calc_photon_number
685
686 ! ---------------------------------------------------------
688 ! reset occ.num. to 2/0
689 subroutine set_occ_pinning(st)
690 type(states_elec_t), intent(inout) :: st
691
692 real(real64), allocatable :: occin(:, :)
693
694 push_sub(set_occ_pinning)
695
696 safe_allocate(occin(1:st%nst, 1:st%nik))
697
698 occin(1:st%nst, 1:st%nik) = st%occ(1:st%nst, 1:st%nik)
699 where(occin(:, :) < m_one) occin(:, :) = m_zero
700 where(occin(:, :) > m_one) occin(:, :) = st%smear%el_per_state
701
702 st%occ(:, :) = occin(:, :)
703
704 safe_deallocate_a(occin)
705
706 pop_sub(set_occ_pinning)
707 end subroutine set_occ_pinning
708
709
710 ! ---------------------------------------------------------
711 ! dummy routine for occupation numbers which only calculates the necessary variables for further use
712 ! used in Hartree-Fock mode
713 subroutine scf_occ_no(rdm, namespace, gr, hm, space, st, energy)
714 type(rdm_t), intent(inout) :: rdm
715 type(namespace_t), intent(in) :: namespace
716 type(grid_t), intent(in) :: gr
717 type(hamiltonian_elec_t), intent(in) :: hm
718 class(space_t), intent(in) :: space
719 type(states_elec_t), intent(inout) :: st
720 real(real64), intent(out) :: energy
721
722 integer :: ist
723
724 push_sub(scf_occ_no)
725
726 write(message(1),'(a)') 'SKIP Optimization of occupation numbers'
727 call messages_info(1, namespace=namespace)
728
729 call set_occ_pinning(st)
730
731 energy = m_zero
732
733 call rdm_derivatives(rdm, namespace, hm, st, gr, space)
734
735 call total_energy_rdm(rdm, st%occ(:,1), energy)
736
737 rdm%occsum = sum(st%occ(1:st%nst, 1:st%nik))
738
739 write(message(1),'(a4,5x,a12)')'#st','Occupation'
740 call messages_info(1, namespace=namespace)
741
742 do ist = 1, st%nst
743 write(message(1),'(i4,3x,f11.9)') ist, st%occ(ist, 1)
744 call messages_info(1, namespace=namespace)
745 end do
746
747 write(message(1),'(a,1x,f13.9)') 'Sum of occupation numbers', rdm%occsum
748 write(message(2),'(a,es20.10)') 'Total energy occ', units_from_atomic(units_out%energy,energy + hm%ep%eii)
749 call messages_info(2, namespace=namespace)
750
751 pop_sub(scf_occ_no)
752 end subroutine scf_occ_no
753
754 ! scf for the occupation numbers
755 subroutine scf_occ(rdm, namespace, gr, hm, space, st, energy)
756 type(rdm_t), target, intent(inout) :: rdm
757 type(namespace_t), intent(in) :: namespace
758 type(grid_t), intent(in) :: gr
759 type(hamiltonian_elec_t), intent(in) :: hm
760 class(space_t), intent(in) :: space
761 type(states_elec_t), intent(inout) :: st
762 real(real64), intent(out) :: energy
763
764 integer :: ist, icycle, ierr
765 real(real64) :: sumgi1, sumgi2, sumgim, mu1, mu2, mum, dinterv, thresh_occ
766 real(real64), allocatable :: occin(:, :)
767 real(real64), parameter :: smallocc = 0.00001_real64
768 real(real64), allocatable :: theta(:)
769 real(real64) :: objective
770
771 push_sub(scf_occ)
772 call profiling_in("SCF_OCC")
773
774 write(message(1),'(a)') 'Optimization of occupation numbers'
775 call messages_info(1, namespace=namespace)
776
777 safe_allocate(occin(1:st%nst, 1:st%nik))
778 safe_allocate(theta(1:st%nst))
779
780 occin = m_zero
781 theta = m_zero
782 energy = m_zero
783
784 ! Defines a threshold on occ nums to avoid numerical instabilities.
785 ! Needs to be changed consistently with the same variable in objective_rdmft
786 thresh_occ = 1e-14_real64
787
788 !Initialize the occin. Smallocc is used for numerical stability
789 occin(1:st%nst, 1:st%nik) = st%occ(1:st%nst, 1:st%nik)
790 where(occin(:, :) < smallocc) occin(:, :) = smallocc
791 where(occin(:, :) > st%smear%el_per_state - smallocc) occin(:, :) = st%smear%el_per_state - smallocc
792
793 !Renormalize the occupation numbers
794 rdm%occsum = st%qtot
795
796 st%occ(:, :) = occin(:, :)
797
798 call rdm_derivatives(rdm, namespace, hm, st, gr, space)
799
800 !finding the chemical potential mu such that the occupation numbers sum up to the number of electrons
801 !bisection to find the root of rdm%occsum-st%qtot=M_ZERO
802 mu1 = rdm%mu !initial guess for mu
803 mu2 = -1.0e-6_real64
804 dinterv = m_half
805
806 ! Set pointer to rdm, so that it is available in the functions called by the minimizer
807 rdm_ptr => rdm
809 !use n_j=sin^2(2pi*theta_j) to treat pinned states, minimize for both intial mu
810 theta(:) = asin(sqrt(occin(:, 1)/st%smear%el_per_state))*(m_half/m_pi)
811 call minimize_multidim(minmethod_bfgs, st%nst, theta, 0.05_real64, 0.01_real64, &
812 1e-12_real64, 1e-12_real64, 200, objective_rdmft, write_iter_info_rdmft, objective, ierr)
813 sumgi1 = rdm%occsum - st%qtot
814 rdm%mu = mu2
815 theta(:) = asin(sqrt(occin(:, 1)/st%smear%el_per_state))*(m_half/m_pi)
816 call minimize_multidim(minmethod_bfgs, st%nst, theta, 0.05_real64, 0.01_real64, &
817 1e-12_real64, 1e-12_real64, 200, objective_rdmft, write_iter_info_rdmft, objective, ierr)
818 sumgi2 = rdm%occsum - st%qtot
819
820 ! Adjust the interval between the initial mu to include the root of rdm%occsum-st%qtot=M_ZERO
821 do while (sumgi1*sumgi2 > m_zero)
822 if (sumgi2 > m_zero) then
823 mu2 = mu1
824 sumgi2 = sumgi1
825 mu1 = mu1 - dinterv
826 rdm%mu = mu1
827 theta(:) = asin(sqrt(occin(:, 1)/st%smear%el_per_state))*(m_half/m_pi)
828 call minimize_multidim(minmethod_bfgs, st%nst, theta, 0.05_real64, 0.01_real64, &
829 1e-12_real64, 1e-12_real64, 200, objective_rdmft, write_iter_info_rdmft, objective, ierr)
830 sumgi1 = rdm%occsum - st%qtot
831 else
832 mu1 = mu2
833 sumgi1 = sumgi2
834 mu2 = mu2 + dinterv
835 rdm%mu = mu2
836 theta(:) = asin(sqrt(occin(:, 1)/st%smear%el_per_state))*(m_half/m_pi)
837 call minimize_multidim(minmethod_bfgs, st%nst, theta, 0.05_real64, 0.01_real64, &
838 1e-12_real64, 1e-12_real64, 200, objective_rdmft, write_iter_info_rdmft, objective, ierr)
839 sumgi2 = rdm%occsum - st%qtot
840 end if
841 end do
842
843 do icycle = 1, 50
844 mum = (mu1 + mu2)*m_half
845 rdm%mu = mum
846 theta(:) = asin(sqrt(occin(:, 1)/st%smear%el_per_state))*(m_half/m_pi)
847 call minimize_multidim(minmethod_bfgs, st%nst, theta, 0.05_real64, 0.0001_real64, &
848 1e-12_real64, 1e-12_real64, 200, objective_rdmft, write_iter_info_rdmft, objective, ierr)
849 sumgim = rdm%occsum - st%qtot
851 if (sumgi1*sumgim < m_zero) then
852 mu2 = mum
853 else
854 mu1 = mum
855 sumgi1 = sumgim
856 end if
857
858 ! check occ.num. threshold again after minimization
859 do ist = 1, st%nst
860 st%occ(ist,1) = m_two*sin(theta(ist)*m_pi*m_two)**2
861 if (st%occ(ist,1) <= thresh_occ ) st%occ(ist,1) = thresh_occ
862 end do
863
864 if (abs(sumgim) < rdm%toler .or. abs((mu1-mu2)*m_half) < rdm%toler) exit
865 end do
866
867 nullify(rdm_ptr)
868
869 if (icycle >= 50) then
870 write(message(1),'(a,1x,f11.4)') 'Bisection ended without finding mu, sum of occupation numbers:', rdm%occsum
871 call messages_fatal(1, namespace=namespace)
872 end if
873
874 do ist = 1, st%nst
875 st%occ(ist, 1) = st%smear%el_per_state*sin(theta(ist)*m_pi*m_two)**2
876 end do
877
878 objective = objective + rdm%mu*(rdm%occsum - rdm%qtot)
879 energy = objective
880
881 write(message(1),'(a4,5x,a12)')'#st','Occupation'
882 call messages_info(1, namespace=namespace)
883
884 do ist = 1, st%nst
885 write(message(1),'(i4,3x,f14.12)') ist, st%occ(ist, 1)
886 call messages_info(1, namespace=namespace)
887 end do
888
889 write(message(1),'(a,3x,f11.9)') 'Sum of occupation numbers: ', rdm%occsum
890 write(message(2),'(a,11x,es20.10)') 'Total energy: ', units_from_atomic(units_out%energy, energy + hm%ep%eii)
891 call messages_info(2, namespace=namespace)
892
893 safe_deallocate_a(occin)
894 safe_deallocate_a(theta)
895
896 call profiling_out("SCF_OCC")
897 pop_sub(scf_occ)
898 end subroutine scf_occ
899
900 ! ---------------------------------------------------------
901 subroutine objective_rdmft(size, theta, objective, getgrad, df)
902 integer, intent(in) :: size
903 real(real64), intent(in) :: theta(size)
904 real(real64), intent(inout) :: objective
905 integer, intent(in) :: getgrad
906 real(real64), intent(inout) :: df(size)
907
908 integer :: ist
909 real(real64) :: thresh_occ, thresh_theta
910 real(real64), allocatable :: dE_dn(:),occ(:)
911
912 push_sub(objective_rdmft)
913
914 assert(size == rdm_ptr%nst)
915
916 safe_allocate(de_dn(1:size))
917 safe_allocate(occ(1:size))
918
919 occ = m_zero
920
921 ! Defines a threshold on occ nums to avoid numerical instabilities.
922 ! Needs to be changed consistently with the same variable in scf_occ
923 thresh_occ = 1e-14_real64
924 thresh_theta = asin(sqrt(thresh_occ/m_two))*(m_half/m_pi)
925
926 do ist = 1, size
927 occ(ist) = m_two*sin(theta(ist)*m_pi*m_two)**2
928 if (occ(ist) <= thresh_occ ) occ(ist) = thresh_occ
929 end do
930
931 rdm_ptr%occsum = sum(occ(1:size))
932
933 !calculate the total energy without nuclei interaction and the energy
934 !derivatives with respect to the occupation numbers
935
936 call total_energy_rdm(rdm_ptr, occ, objective, de_dn)
937 do ist = 1, size
938 if (occ(ist) <= thresh_occ ) then
939 df(ist) = m_four*m_pi*sin(m_four*thresh_theta*m_pi)*(de_dn(ist) - rdm_ptr%mu)
940 else
941 df(ist) = m_four*m_pi*sin(m_four*theta(ist)*m_pi)*(de_dn(ist) - rdm_ptr%mu)
942 end if
943 end do
944 objective = objective - rdm_ptr%mu*(rdm_ptr%occsum - rdm_ptr%qtot)
945
946 safe_deallocate_a(de_dn)
947 safe_deallocate_a(occ)
948
949 pop_sub(objective_rdmft)
950 end subroutine objective_rdmft
951
952 ! ---------------------------------------------------------
953 subroutine write_iter_info_rdmft(iter, size, energy, maxdr, maxdf, theta)
954 integer, intent(in) :: iter
955 integer, intent(in) :: size
956 real(real64), intent(in) :: energy, maxdr, maxdf
957 real(real64), intent(in) :: theta(size)
958
959 push_sub(write_iter_info_rdmft)
960
961 ! Nothing to do.
962
963 pop_sub(write_iter_info_rdmft)
964 end subroutine write_iter_info_rdmft
965
966 ! scf for the natural orbitals
967 subroutine scf_orb(rdm, namespace, gr, st, hm, space, energy)
968 type(rdm_t), intent(inout) :: rdm
969 type(namespace_t), intent(in) :: namespace
970 type(grid_t), intent(in) :: gr
971 type(states_elec_t), intent(inout) :: st
972 type(hamiltonian_elec_t), intent(in) :: hm
973 class(space_t), intent(in) :: space
974 real(real64), intent(out) :: energy
975
976 integer :: ist, jst
977 real(real64), allocatable :: lambda(:, :), fo(:, :)
978
979 push_sub(scf_orb)
980 call profiling_in("SCF_ORB_BASIS")
981
982 !matrix of Lagrange Multipliers from Equation (8), Piris and Ugalde, Vol. 30, No. 13, J. Comput. Chem.
983 safe_allocate(lambda(1:st%nst,1:st%nst))
984 safe_allocate(fo(1:st%nst, 1:st%nst)) !Generalized Fockian Equation (11)
985
986 lambda = m_zero
987 fo = m_zero
988
989 call construct_lambda(namespace, hm, st, gr, lambda, rdm)
990
991 !Set up fo matrix
992 if (rdm%iter==1) then
993 do ist = 1, st%nst
994 do jst = 1, ist
995 fo(ist, jst) = m_half*(lambda(ist, jst) + lambda(jst, ist))
996 fo(jst, ist) = fo(ist, jst)
997 end do
998 end do
999 else
1000 do ist = 1, st%nst
1001 do jst = 1, ist - 1
1002 fo(jst, ist) = - ( lambda(jst, ist) - lambda(ist ,jst))
1003 end do
1004 end do
1005 rdm%maxfo = maxval(abs(fo))
1006 do ist = 1, st%nst
1007 fo(ist, ist) = rdm%evalues(ist)
1008 do jst = 1, ist-1
1009 if(abs(fo(jst, ist)) > rdm%scale_f) then
1010 fo(jst, ist) = rdm%scale_f*fo(jst,ist)/abs(fo(jst, ist))
1011 end if
1012 fo(ist, jst) = fo(jst, ist)
1013 end do
1014 end do
1015 end if
1016
1017 call lalg_eigensolve(st%nst, fo, rdm%evalues)
1018 call assign_eigfunctions(rdm, st, fo)
1019 call sum_integrals(rdm) ! to calculate rdm%Coul and rdm%Exch with the new rdm%vecnat
1020 call rdm_derivatives(rdm, namespace, hm, st, gr, space)
1021 call total_energy_rdm(rdm, st%occ(:,1), energy)
1022
1023 safe_deallocate_a(lambda)
1024 safe_deallocate_a(fo)
1025
1026 call profiling_out("SCF_ORB_BASIS")
1027 pop_sub(scf_orb)
1028 end subroutine scf_orb
1029
1030
1031 !-----------------------------------------------------------------
1032 ! Minimize the total energy wrt. an orbital by conjugate gradient
1033 !-----------------------------------------------------------------
1034 subroutine scf_orb_cg(rdm, namespace, space, gr, ions, ext_partners, st, ks, hm, energy)
1035 type(rdm_t), intent(inout) :: rdm
1036 type(namespace_t), intent(in) :: namespace
1037 type(electron_space_t), intent(in) :: space
1038 type(grid_t), intent(in) :: gr
1039 type(ions_t), intent(in) :: ions
1040 type(partner_list_t), intent(in) :: ext_partners
1041 type(states_elec_t), intent(inout) :: st
1042 type(v_ks_t), intent(inout) :: ks
1043 type(hamiltonian_elec_t), intent(inout) :: hm
1044 real(real64), intent(out) :: energy
1045
1046 integer :: ik, ist, maxiter
1047
1049 push_sub(scf_orb_cg)
1050 call profiling_in("CG")
1051
1052 call v_ks_calc(ks, namespace, space, hm, st, ions, ext_partners)
1053 call hm%update(gr, namespace, space, ext_partners)
1054
1055 rdm%eigens%converged = 0
1056 if(mpi_world%is_root() .and. .not. debug%info) then
1057 call loct_progress_bar(-1, st%lnst*st%d%kpt%nlocal)
1058 end if
1059 do ik = st%d%kpt%start, st%d%kpt%end
1060 rdm%eigens%matvec = 0
1061 maxiter = rdm%eigens%es_maxiter
1062 call deigensolver_cg(namespace, gr, st, hm, rdm%eigens%pre, rdm%eigens%tolerance, maxiter, &
1063 rdm%eigens%converged(ik), ik, rdm%eigens%diff(:, ik), rdm%eigens%energy_change_threshold, &
1064 rdm%eigens%orthogonalize_to_all, rdm%eigens%conjugate_direction)
1065
1066 if (.not. rdm%eigens%folded_spectrum) then
1067 ! recheck convergence after subspace diagonalization, since states may have reordered (copied from eigensolver_run)
1068 rdm%eigens%converged(ik) = 0
1069 do ist = 1, st%nst
1070 if(rdm%eigens%diff(ist, ik) < rdm%eigens%tolerance) then
1071 rdm%eigens%converged(ik) = ist
1072 else
1073 exit
1074 end if
1075 end do
1076 end if
1077 end do
1078
1079 if(mpi_world%is_root() .and. .not. debug%info) then
1080 write(stdout, '(1x)')
1081 end if
1082
1083 ! calculate total energy with new states
1084 call density_calc (st, gr, st%rho)
1085 call v_ks_calc(ks, namespace, space, hm, st, ions, ext_partners)
1086 call hm%update(gr, namespace, space, ext_partners)
1087 call rdm_derivatives(rdm, namespace, hm, st, gr, space)
1088
1089 call total_energy_rdm(rdm, st%occ(:,1), energy)
1090
1091 call profiling_out("CG")
1092 pop_sub(scf_orb_cg)
1093 end subroutine scf_orb_cg
1094
1095
1096 ! ----------------------------------------
1097 ! constructs the Lagrange multiplyers needed for the orbital minimization
1098 subroutine construct_lambda(namespace, hm, st, gr, lambda, rdm)
1099 type(namespace_t), intent(in) :: namespace
1100 type(hamiltonian_elec_t), intent(in) :: hm
1101 type(states_elec_t), intent(inout) :: st
1102 type(grid_t), intent(in) :: gr
1103 real(real64), intent(out) :: lambda(:, :)
1104 type(rdm_t), intent(inout) :: rdm
1105
1106 real(real64), allocatable :: hpsi(:, :), hpsi1(:, :), dpsi(:, :), dpsi1(:, :)
1107 real(real64), allocatable :: fock(:,:,:), fvec(:)
1108 integer :: ist, iorb, jorb, jst
1109
1110 push_sub(construct_lambda)
1111
1112 lambda = m_zero
1113
1114 !calculate the Lagrange multiplyer lambda matrix on the grid, Eq. (9), Piris and Ugalde, Vol. 30, No. 13, J. Comput. Chem.
1115 if (.not. rdm%do_basis) then
1116 safe_allocate(hpsi(1:gr%np,1:st%d%dim))
1117 safe_allocate(hpsi1(1:gr%np,1:st%d%dim))
1118 safe_allocate(dpsi(1:gr%np_part ,1:st%d%dim))
1119 safe_allocate(dpsi1(1:gr%np_part ,1:st%d%dim))
1120
1121 do iorb = 1, st%nst
1122 call states_elec_get_state(st, gr, iorb, 1, dpsi)
1123 call dhamiltonian_elec_apply_single(hm, namespace, gr, dpsi, hpsi, iorb, 1)
1124
1125 do jorb = iorb, st%nst
1126 ! calculate <phi_j|H|phi_i> =lam_ji
1127 call states_elec_get_state(st, gr, jorb, 1, dpsi1)
1128 lambda(jorb, iorb) = dmf_dotp(gr, dpsi1(:,1), hpsi(:,1))
1130 ! calculate <phi_i|H|phi_j>=lam_ij
1131 if (.not. iorb == jorb ) then
1132 call dhamiltonian_elec_apply_single(hm, namespace, gr, dpsi1, hpsi1, jorb, 1)
1133 lambda(iorb, jorb) = dmf_dotp(gr, dpsi(:,1), hpsi1(:,1))
1134 end if
1135 end do
1136 end do
1137
1138
1139 else ! calculate the same lambda matrix on the basis
1140 !call sum_integrals(rdm)
1141 safe_allocate(fvec(1:st%nst))
1142 safe_allocate(fock(1:st%nst, 1:st%nst, 1:st%nst))
1143 fock = m_zero
1144
1145 do iorb = 1, st%nst
1146 do ist = 1, st%nst
1147 do jst = 1, ist
1148 fock(ist, jst, iorb) = st%occ(iorb, 1)*rdm%eone_int(ist,jst)
1149 do jorb = 1, st%nst
1150 !The coefficient of the Exchange term below is only for the Mueller functional
1151 fock(ist ,jst, iorb) = fock(ist, jst, iorb) + st%occ(iorb, 1)*st%occ(jorb, 1)*rdm%Coul(ist, jst, jorb) &
1152 - sqrt(st%occ(iorb, 1))*sqrt(st%occ(jorb, 1))*rdm%Exch(ist, jst, jorb)
1153 end do
1154 fock(jst, ist, iorb) = fock(ist, jst, iorb)
1155 end do
1156 end do
1157 end do
1158
1159 do jorb = 1, st%nst
1160 do ist = 1, st%nst
1161 fvec(ist) = m_zero
1162 do jst = 1, st%nst
1163 fvec(ist) = fvec(ist) + fock(ist, jst, jorb)*rdm%vecnat(jst, jorb)
1164 end do
1165 end do
1166 do iorb= 1, st%nst
1167 lambda(iorb, jorb) = m_zero
1168 do ist = 1, st%nst
1169 lambda(iorb, jorb) = lambda(iorb, jorb) + rdm%vecnat(ist, iorb)*fvec(ist)
1170 end do
1171 end do
1172 end do
1173 end if
1174
1175
1176 if (.not. rdm%do_basis) then
1177 safe_deallocate_a(hpsi)
1178 safe_deallocate_a(hpsi1)
1179 safe_deallocate_a(dpsi)
1180 safe_deallocate_a(dpsi1)
1181 else
1182 safe_deallocate_a(fvec)
1183 safe_deallocate_a(fock)
1184 end if
1185
1186 pop_sub(construct_lambda)
1187 end subroutine construct_lambda
1188
1189 ! ----------------------------------------
1190
1191 ! finds the new states after the minimization of the orbitals (Piris method)
1192 subroutine assign_eigfunctions(rdm, st, lambda)
1193 type(rdm_t), intent(inout) :: rdm
1194 type(states_elec_t), intent(inout) :: st
1195 real(real64), intent(in) :: lambda(:, :)
1196
1197 integer :: iorb, jorb, ist
1198 real(real64), allocatable :: vecnat_new(:, :)
1199
1200 push_sub(assign_eigenfunctions)
1201
1202 safe_allocate(vecnat_new(1:st%nst, 1:st%nst))
1203 do iorb = 1, st%nst
1204 do ist = 1, st%nst
1205 vecnat_new(ist, iorb) = m_zero
1206 do jorb = 1, st%nst
1207 vecnat_new(ist , iorb) = vecnat_new(ist, iorb) + rdm%vecnat(ist, jorb)*lambda(jorb, iorb)
1208 end do
1209 end do
1210 end do
1211
1212 rdm%vecnat(:, :) = vecnat_new(:, :)
1213
1214 safe_deallocate_a(vecnat_new)
1215
1216 pop_sub(assign_eigenfunctions)
1217 end subroutine assign_eigfunctions
1218
1219 ! --------------------------------------------
1220
1221 ! calculates the total energy when only the occupation numbers are updated
1222 subroutine total_energy_rdm(rdm, occ, energy, dE_dn)
1223 type(rdm_t), intent(in) :: rdm
1224 real(real64), intent(in) :: occ(:)
1225 real(real64), intent(out) :: energy
1226 real(real64), optional, intent(out) :: dE_dn(:)
1227
1228 integer :: ist, jst
1229 real(real64), allocatable :: V_h(:), V_x(:)
1230
1231 push_sub(total_energy_rdm)
1232
1233 safe_allocate(v_h(1:rdm%nst))
1234 safe_allocate(v_x(1:rdm%nst))
1235
1236 energy = m_zero
1237 v_h = m_zero
1238 v_x = m_zero
1239
1240 !Calculate hartree and exchange contribution
1241 !This is only for the Mueller functional and has to be changed
1242 do ist = 1, rdm%nst
1243 do jst = 1, rdm%nst
1244 v_h(ist) = v_h(ist) + occ(jst)*rdm%hartree(ist, jst)
1245 v_x(ist) = v_x(ist) - sqrt(occ(jst))*rdm%exchange(ist, jst)
1246 end do
1247 v_x(ist) = v_x(ist)*m_half/max(sqrt(occ(ist)), 1.0e-16_real64)
1248 end do
1249
1250
1251 !Calculate the energy derivative with respect to the occupation numbers
1252 if (present(de_dn)) then
1253 de_dn(:) = rdm%eone(:) + v_h(:) + v_x(:)
1254 end if
1255
1256 !Total energy calculation without nuclei interaction
1257 do ist = 1, rdm%nst
1258 energy = energy + occ(ist)*rdm%eone(ist) &
1259 + m_half*occ(ist)*v_h(ist) &
1260 + occ(ist)*v_x(ist)
1261 end do
1262
1263 safe_deallocate_a(v_h)
1264 safe_deallocate_a(v_x)
1265
1266 pop_sub(total_energy_rdm)
1267 end subroutine total_energy_rdm
1268
1269 ! ----------------------------------------
1270 ! calculates the derivatives of the energy terms with respect to the occupation numbers
1271 subroutine rdm_derivatives(rdm, namespace, hm, st, gr, space)
1272 type(rdm_t), intent(inout) :: rdm
1273 type(namespace_t), intent(in) :: namespace
1274 type(hamiltonian_elec_t), intent(in) :: hm
1275 type(states_elec_t), intent(inout) :: st
1276 type(grid_t), intent(in) :: gr
1277 class(space_t), intent(in) :: space
1278
1279
1280 real(real64), allocatable :: hpsi(:, :), rho1(:), rho(:), dpsi(:, :), dpsi2(:, :)
1281 real(real64), allocatable :: v_ij(:,:,:,:,:)
1282 real(real64) :: dd
1283 type(states_elec_t) :: xst
1284
1285 integer :: ist, jst, nspin_, iorb, jorb
1286
1288
1289
1290 nspin_ = min(st%d%nspin, 2)
1291
1292 if (rdm%do_basis.eqv..false.) then
1293 safe_allocate(hpsi(1:gr%np, 1:st%d%dim))
1294 safe_allocate(rho1(1:gr%np))
1295 safe_allocate(rho(1:gr%np))
1296 safe_allocate(dpsi(1:gr%np_part, 1:st%d%dim))
1297 safe_allocate(dpsi2(1:gr%np, 1:st%d%dim))
1298 safe_allocate(v_ij(1:gr%np, 1:st%nst, 1:st%nst, 1:st%nik, 1:st%nik))
1299
1300 v_ij = m_zero
1301 rdm%eone = m_zero
1302 rdm%hartree = m_zero
1303 rdm%exchange = m_zero
1304
1305 !derivative of one-electron energy with respect to the natural orbitals occupation number
1306 do ist = 1, st%nst
1307 call states_elec_get_state(st, gr, ist, 1, dpsi)
1308
1309 ! calculate one-body energy
1310 call dhamiltonian_elec_apply_single(hm, namespace, gr, dpsi, hpsi, ist, 1, &
1312 rdm%eone(ist) = dmf_dotp(gr, dpsi(:, 1), hpsi(:, 1))
1313 end do
1314
1315 !integrals used for the hartree and exchange parts of the total energy and their derivatives
1316 ! maybe better to let that be done from the lower level routines like hamiltonian apply?
1318 ! only used to calculate total energy
1319 call xst%nullify()
1320 call dexchange_operator_compute_potentials(hm%exxop, namespace, space, gr, st, xst, hm%kpoints, f_out = v_ij)
1321 call states_elec_end(xst)
1322
1323 do ist = 1, st%nst
1324 call states_elec_get_state(st, gr, ist, 1, dpsi)
1325
1326 rho1(1:gr%np) = dpsi(1:gr%np, 1)**2
1327
1328 do jst = ist, st%nst
1329 rdm%hartree(ist, jst) = dmf_dotp(gr, rho1, v_ij(:,jst, jst, 1, 1))
1330 rdm%hartree(jst, ist) = rdm%hartree(ist, jst)
1331 call states_elec_get_state(st, gr, jst, 1, dpsi2)
1332 rho(1:gr%np) = dpsi2(1:gr%np, 1)*dpsi(1:gr%np, 1)
1333 rdm%exchange(ist, jst) = dmf_dotp(gr, rho, v_ij(:, ist, jst, 1, 1))
1334 rdm%exchange(jst, ist) = rdm%exchange(ist, jst)
1335 end do
1336 end do
1337
1338
1339 safe_deallocate_a(hpsi)
1340 safe_deallocate_a(rho)
1341 safe_deallocate_a(rho1)
1342 safe_deallocate_a(dpsi)
1343 safe_deallocate_a(dpsi2)
1344 safe_deallocate_a(v_ij)
1345
1346 else !if energy derivatives are expanded in a basis set
1347
1348 do iorb = 1, st%nst
1349 rdm%eone(iorb) = m_zero
1350 do ist = 1, st%nst
1351 do jst = 1, st%nst
1352 dd = rdm%vecnat(ist, iorb)*rdm%vecnat(jst, iorb)
1353 rdm%eone(iorb) = rdm%eone(iorb) + dd*rdm%eone_int(ist, jst)
1354 end do
1355 end do
1356 end do
1357
1358 do iorb = 1, st%nst
1359 do jorb =1 , iorb
1360 rdm%hartree(iorb ,jorb) = m_zero
1361 rdm%exchange(iorb,jorb) = m_zero
1362 do ist =1, st%nst
1363 do jst =1, st%nst
1364 dd = rdm%vecnat(ist, iorb)*rdm%vecnat(jst, iorb)
1365 rdm%hartree(iorb ,jorb) = rdm%hartree(iorb ,jorb)+rdm%Coul(ist,jst, jorb)*dd
1366 rdm%exchange(iorb ,jorb) = rdm%exchange(iorb ,jorb)+rdm%Exch(ist,jst, jorb)*dd
1367 end do
1368 end do
1369 rdm%hartree(jorb, iorb) = rdm%hartree(iorb, jorb)
1370 rdm%exchange(jorb, iorb) = rdm%exchange(iorb, jorb)
1371 end do
1372 end do
1373 end if
1374
1375 pop_sub(rdm_derivatives)
1376 end subroutine rdm_derivatives
1377
1378 ! --------------------------------------------
1379 !calculates the one electron integrals in the basis of the initial orbitals
1380 subroutine rdm_integrals(rdm, namespace, hm, st, mesh)
1381 type(rdm_t), intent(inout) :: rdm
1382 type(namespace_t), intent(in) :: namespace
1383 type(hamiltonian_elec_t), intent(in) :: hm
1384 type(states_elec_t), intent(in) :: st
1385 class(mesh_t), intent(in) :: mesh
1386
1387 real(real64), allocatable :: hpsi(:, :)
1388 real(real64), allocatable :: dpsi(:, :), dpsi2(:, :)
1389 integer :: ist, jst
1390
1391 push_sub(rdm_integrals)
1392
1393 safe_allocate(dpsi(1:mesh%np_part, 1:st%d%dim))
1394 safe_allocate(dpsi2(1:mesh%np, 1:st%d%dim))
1395 safe_allocate(hpsi(1:mesh%np, 1:st%d%dim))
1396
1397 !calculate integrals of the one-electron energy term with respect to the initial orbital basis
1398 do ist = 1, st%nst
1399 call states_elec_get_state(st, mesh, ist, 1, dpsi)
1400 do jst = ist, st%nst
1401 call states_elec_get_state(st, mesh, jst, 1, dpsi2)
1402
1403 ! calculate one-body integrals
1404 call dhamiltonian_elec_apply_single(hm, namespace, mesh, dpsi, hpsi, ist, 1, &
1406 rdm%eone_int(jst, ist) = dmf_dotp(mesh, dpsi2(:, 1), hpsi(:, 1))
1407 rdm%eone_int(ist, jst) = rdm%eone_int(jst, ist)
1408 end do
1409 end do
1410
1411 safe_deallocate_a(hpsi)
1412 safe_deallocate_a(dpsi)
1413 safe_deallocate_a(dpsi2)
1414
1415 pop_sub(rdm_integrals)
1416 end subroutine rdm_integrals
1417
1418 ! --------------------------------------------
1419 ! constructs the Hartree and Exchange part of the RDMFT Fock matrix
1420 subroutine sum_integrals(rdm)
1421 type(rdm_t), intent(inout) :: rdm
1422
1423 integer :: ist, jst, kst, lst, iorb, icount
1424 logical :: inv_pairs
1425 real(real64) :: two_int, wij, wik, wil, wjk, wjl, wkl
1426 real(real64), allocatable :: dm(:,:,:)
1427
1428 push_sub(sum_integrals)
1429
1430 safe_allocate(dm(1:rdm%nst, 1:rdm%nst, 1:rdm%nst))
1431
1432 rdm%Coul = m_zero
1433 rdm%Exch = m_zero
1434 dm = m_zero
1435
1436 do iorb = 1, rdm%nst
1437 do ist = 1, rdm%nst
1438 do jst = 1, ist
1439 dm(ist, jst, iorb) = rdm%vecnat(ist, iorb)*rdm%vecnat(jst, iorb)
1440 dm(jst, ist, iorb) = dm(ist, jst, iorb)
1441 end do
1442 end do
1443 end do
1444
1445 do icount = 1, rdm%n_twoint
1446
1447 ist = rdm%i_index(1,icount)
1448 jst = rdm%j_index(1,icount)
1449 kst = rdm%k_index(1,icount)
1450 lst = rdm%l_index(1,icount)
1451
1452 two_int = rdm%twoint(icount)
1453
1454 ! create weights of unique integrals
1455 if(ist == jst) then
1456 wij = m_one
1457 else
1458 wij = m_two
1459 endif
1460 if(kst == lst) then
1461 wkl = m_one
1462 else
1463 wkl = m_two
1464 endif
1465
1466 if(ist == kst .and. jst /= lst) then
1467 wik = m_two
1468 else
1469 wik = m_one
1470 endif
1471 if(ist == lst .and. jst /= kst) then
1472 wil = m_two
1473 else
1474 wil = m_one
1475 endif
1476 if(jst == kst .and. ist /= lst) then
1477 wjk = m_two
1478 else
1479 wjk = m_one
1480 endif
1481 if(jst == lst .and. ist /= kst) then
1482 wjl = m_two
1483 else
1484 wjl = m_one
1485 endif
1486
1487 inv_pairs = (ist /= kst .or. jst /= lst)
1488
1489 do iorb = 1, rdm%nst
1490
1491 !the Hartree terms
1492 rdm%Coul(ist, jst, iorb) = rdm%Coul(ist, jst, iorb) + dm(kst, lst, iorb)*wkl*two_int
1493 if (inv_pairs) rdm%Coul(kst, lst, iorb) = rdm%Coul(kst, lst, iorb) + dm(ist, jst, iorb)*wij*two_int
1494
1495 !the exchange terms
1496 !weights are only included if they can differ from one
1497 rdm%Exch(ist, kst, iorb) = rdm%Exch(ist, kst, iorb) + two_int*dm(jst, lst, iorb)*wik
1498 if (kst /= lst) then
1499 rdm%Exch(ist, lst, iorb) = rdm%Exch(ist, lst, iorb) + two_int*dm(jst, kst, iorb)*wil
1500 end if
1501 if (ist /= jst) then
1502 if(jst >= kst) then
1503 rdm%Exch(jst, kst, iorb) = rdm%Exch(jst, kst, iorb) + two_int*dm(ist, lst, iorb)*wjk
1504 else
1505 if (inv_pairs) rdm%Exch(kst, jst, iorb) = rdm%Exch(kst, jst, iorb) + two_int*dm(ist, lst, iorb)
1506 end if
1507 end if
1508 if (ist /=jst .and. kst /= lst) then
1509 if (jst >= lst) then
1510 rdm%Exch(jst, lst, iorb) = rdm%Exch(jst, lst, iorb) + two_int*dm(ist, kst, iorb)*wjl
1511 else
1512 if (inv_pairs) rdm%Exch(lst, jst, iorb) = rdm%Exch(lst, jst, iorb) + two_int*dm(ist, kst, iorb)
1513 end if
1514 end if
1516 end do !iorb
1517 end do !icount
1518
1519 do iorb =1, rdm%nst
1520 do ist = 1, rdm%nst
1521 do jst = 1, ist-1
1522 rdm%Coul(jst, ist, iorb) = rdm%Coul(ist, jst, iorb)
1523 rdm%Exch(jst, ist, iorb) = rdm%Exch(ist, jst, iorb)
1524 end do
1525 end do
1526 end do
1527
1528 safe_deallocate_a(dm)
1529
1530 pop_sub(sum_integrals)
1531 end subroutine sum_integrals
1532
1533end module rdmft_oct_m
1534
1535
1536!! Local Variables:
1537!! mode: f90
1538!! coding: utf-8
1539!! End:
Prints out to iunit a message in the form: ["InputVariable" = value] where "InputVariable" is given b...
Definition: messages.F90:182
double sin(double __x) __attribute__((__nothrow__
double asin(double __x) __attribute__((__nothrow__
type(debug_t), save, public debug
Definition: debug.F90:158
This module implements a calculator for the density and defines related functions.
Definition: density.F90:122
subroutine, public density_calc(st, gr, density, istin)
Computes the density from the orbitals in st.
Definition: density.F90:612
This module calculates the derivatives (gradients, Laplacians, etc.) of a function.
subroutine, public dderivatives_partial(der, ff, op_ff, dir, ghost_update, set_bc)
apply the partial derivative along dir to a mesh function
subroutine, public deigensolver_cg(namespace, mesh, st, hm, pre, tol, niter, converged, ik, diff, energy_change_threshold, orthogonalize_to_all, conjugate_direction, shift)
conjugate-gradients method.
Definition: eigen_cg.F90:199
subroutine, public eigensolver_init(eigens, namespace, gr, st, hm, mc, space, deactivate_oracle)
subroutine, public eigensolver_end(eigens)
subroutine, public dexchange_operator_compute_potentials(this, namespace, space, gr, st, xst, kpoints, F_out)
real(real64), parameter, public m_two
Definition: global.F90:193
real(real64), parameter, public m_zero
Definition: global.F90:191
real(real64), parameter, public m_four
Definition: global.F90:195
real(real64), parameter, public m_pi
some mathematical constants
Definition: global.F90:189
character(len= *), parameter, public static_dir
Definition: global.F90:266
real(real64), parameter, public m_half
Definition: global.F90:197
real(real64), parameter, public m_one
Definition: global.F90:192
This module implements the underlying real-space grid.
Definition: grid.F90:119
subroutine, public grid_write_info(gr, iunit, namespace)
Definition: grid.F90:528
integer, parameter, public term_local_external
integer, parameter, public term_non_local_potential
integer, parameter, public term_kinetic
subroutine, public dhamiltonian_elec_apply_single(hm, namespace, mesh, psi, hpsi, ist, ik, terms, set_bc, set_phase)
This module defines classes and functions for interaction partners.
Definition: io.F90:116
subroutine, public io_close(iunit, grp)
Definition: io.F90:466
subroutine, public io_mkdir(fname, namespace, parents)
Definition: io.F90:360
integer function, public io_open(file, namespace, action, status, form, position, die, recl, grp)
Definition: io.F90:401
This module is intended to contain "only mathematical" functions and procedures.
Definition: math.F90:117
This module defines various routines, operating on mesh functions.
This module defines the meshes, which are used in Octopus.
Definition: mesh.F90:120
subroutine, public messages_print_with_emphasis(msg, iunit, namespace)
Definition: messages.F90:898
subroutine, public messages_not_implemented(feature, namespace)
Definition: messages.F90:1091
character(len=512), private msg
Definition: messages.F90:167
subroutine, public messages_warning(no_lines, all_nodes, namespace)
Definition: messages.F90:525
character(len=256), dimension(max_lines), public message
to be output by fatal, warning
Definition: messages.F90:162
subroutine, public messages_fatal(no_lines, only_root_writes, namespace)
Definition: messages.F90:410
subroutine, public messages_info(no_lines, iunit, debug_only, stress, all_nodes, namespace)
Definition: messages.F90:594
integer, parameter, public minmethod_bfgs
Definition: minimizer.F90:136
This module contains some common usage patterns of MPI routines.
Definition: mpi_lib.F90:117
type(mpi_grp_t), public mpi_world
Definition: mpi.F90:272
This module handles the communicators for the various parallelization strategies.
Definition: multicomm.F90:147
this module contains the low-level part of the output system
Definition: output_low.F90:117
subroutine, public output_modelmb(outp, namespace, space, dir, gr, ions, iter, st)
this module contains the output system
Definition: output.F90:117
subroutine, public output_all(outp, namespace, space, dir, gr, ions, iter, st, hm, ks)
Definition: output.F90:497
subroutine, public photon_mode_write_info(this, iunit, namespace)
subroutine, public profiling_out(label)
Increment out counter and sum up difference between entry and exit time.
Definition: profiling.F90:625
subroutine, public profiling_in(label, exclude)
Increment in counter and save entry time.
Definition: profiling.F90:554
subroutine scf_occ(rdm, namespace, gr, hm, space, st, energy)
Definition: rdmft.F90:851
subroutine calc_maxfo(namespace, hm, st, gr, rdm)
Definition: rdmft.F90:688
subroutine objective_rdmft(size, theta, objective, getgrad, df)
Definition: rdmft.F90:997
subroutine scf_orb_cg(rdm, namespace, space, gr, ions, ext_partners, st, ks, hm, energy)
Definition: rdmft.F90:1130
subroutine, public rdmft_end(rdm)
Definition: rdmft.F90:349
subroutine, public scf_rdmft(rdm, namespace, space, mc, gr, ions, ext_partners, st, ks, hm, outp, restart_dump)
Definition: rdmft.F90:379
subroutine, public rdmft_init(rdm, namespace, gr, st, hm, mc, space, fromScratch)
Definition: rdmft.F90:215
subroutine write_iter_info_rdmft(iter, size, energy, maxdr, maxdf, theta)
Definition: rdmft.F90:1049
subroutine set_occ_pinning(st)
Definition: rdmft.F90:785
subroutine calc_photon_number(space, gr, st, photons, photon_number_state, ekin_state, epot_state)
Definition: rdmft.F90:723
subroutine assign_eigfunctions(rdm, st, lambda)
Definition: rdmft.F90:1288
subroutine construct_lambda(namespace, hm, st, gr, lambda, rdm)
Definition: rdmft.F90:1194
subroutine sum_integrals(rdm)
Definition: rdmft.F90:1516
subroutine rdm_integrals(rdm, namespace, hm, st, mesh)
Definition: rdmft.F90:1476
subroutine scf_orb(rdm, namespace, gr, st, hm, space, energy)
Definition: rdmft.F90:1063
subroutine total_energy_rdm(rdm, occ, energy, dE_dn)
Definition: rdmft.F90:1318
subroutine scf_occ_no(rdm, namespace, gr, hm, space, st, energy)
Definition: rdmft.F90:809
subroutine rdm_derivatives(rdm, namespace, hm, st, gr, space)
Definition: rdmft.F90:1367
pure logical function, public states_are_complex(st)
subroutine, public states_elec_end(st)
finalize the states_elec_t object
subroutine, public states_elec_copy(stout, stin, exclude_wfns, exclude_eigenval, special)
make a (selective) copy of a states_elec_t object
This module handles reading and writing restart information for the states_elec_t.
subroutine, public states_elec_dump(restart, space, st, mesh, kpoints, ierr, iter, lr, verbose)
brief This module defines the class unit_t which is used by the unit_systems_oct_m module.
Definition: unit.F90:134
character(len=20) pure function, public units_abbrev(this)
Definition: unit.F90:225
This module defines the unit system, used for input and output.
type(unit_system_t), public units_out
subroutine, public v_ks_write_info(ks, iunit, namespace)
Definition: v_ks.F90:660
subroutine, public v_ks_calc(ks, namespace, space, hm, st, ions, ext_partners, calc_eigenval, time, calc_energy, calc_current, force_semilocal)
Definition: v_ks.F90:749
This module provices a simple timer class which can be used to trigger the writing of a restart file ...
Definition: walltimer.F90:123
logical function, public restart_walltime_period_alarm(comm)
Definition: walltimer.F90:375
subroutine scf_write_static(dir, fname)
Definition: rdmft.F90:586
Extension of space that contains the knowledge of the spin dimension.
Description of the grid, containing information on derivatives, stencil, and symmetries.
Definition: grid.F90:171
Describes mesh distribution to nodes.
Definition: mesh.F90:187
Stores all communicators and groups.
Definition: multicomm.F90:208
output handler class
Definition: output_low.F90:166
The states_elec_t class contains all electronic wave functions.
int true(void)