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