(git:bb35279)
Loading...
Searching...
No Matches
dm_ls_scf_methods.F
Go to the documentation of this file.
1!--------------------------------------------------------------------------------------------------!
2! CP2K: A general program to perform molecular dynamics simulations !
3! Copyright 2000-2025 CP2K developers group <https://cp2k.org> !
4! !
5! SPDX-License-Identifier: GPL-2.0-or-later !
6!--------------------------------------------------------------------------------------------------!
7
8! **************************************************************************************************
9!> \brief lower level routines for linear scaling SCF
10!> \par History
11!> 2010.10 created [Joost VandeVondele]
12!> \author Joost VandeVondele
13! **************************************************************************************************
16 USE cp_dbcsr_api, ONLY: &
22 dbcsr_dot,&
29 USE dm_ls_scf_types, ONLY: ls_cluster_atomic,&
32 USE input_constants, ONLY: &
44 USE kinds, ONLY: dp,&
45 int_8
46 USE machine, ONLY: m_flush,&
48 USE mathlib, ONLY: abnormal_value
49#include "./base/base_uses.f90"
50
51 IMPLICIT NONE
52
53 PRIVATE
54
55 CHARACTER(len=*), PARAMETER, PRIVATE :: moduleN = 'dm_ls_scf_methods'
56
57 PUBLIC :: ls_scf_init_matrix_s
61
62CONTAINS
63
64! **************************************************************************************************
65!> \brief initialize S matrix related properties (sqrt, inverse...)
66!> Might be factored-out since this seems common code with the other SCF.
67!> \param matrix_s ...
68!> \param ls_scf_env ...
69!> \par History
70!> 2010.10 created [Joost VandeVondele]
71!> \author Joost VandeVondele
72! **************************************************************************************************
73 SUBROUTINE ls_scf_init_matrix_s(matrix_s, ls_scf_env)
74 TYPE(dbcsr_type) :: matrix_s
75 TYPE(ls_scf_env_type) :: ls_scf_env
76
77 CHARACTER(len=*), PARAMETER :: routinen = 'ls_scf_init_matrix_S'
78
79 INTEGER :: handle, unit_nr
80 REAL(kind=dp) :: frob_matrix, frob_matrix_base
81 TYPE(cp_logger_type), POINTER :: logger
82 TYPE(dbcsr_type) :: matrix_tmp1, matrix_tmp2
83
84 CALL timeset(routinen, handle)
85
86 ! get a useful output_unit
87 logger => cp_get_default_logger()
88 IF (logger%para_env%is_source()) THEN
89 unit_nr = cp_logger_get_default_unit_nr(logger, local=.true.)
90 ELSE
91 unit_nr = -1
92 END IF
93
94 ! make our own copy of S
95 IF (ls_scf_env%has_unit_metric) THEN
96 CALL dbcsr_set(ls_scf_env%matrix_s, 0.0_dp)
97 CALL dbcsr_add_on_diag(ls_scf_env%matrix_s, 1.0_dp)
98 ELSE
99 CALL matrix_qs_to_ls(ls_scf_env%matrix_s, matrix_s, ls_scf_env%ls_mstruct, covariant=.true.)
100 END IF
101
102 CALL dbcsr_filter(ls_scf_env%matrix_s, ls_scf_env%eps_filter)
103
104 ! needs a preconditioner for S
105 IF (ls_scf_env%has_s_preconditioner) THEN
106 CALL dbcsr_create(ls_scf_env%matrix_bs_sqrt, template=ls_scf_env%matrix_s, &
107 matrix_type=dbcsr_type_no_symmetry)
108 CALL dbcsr_create(ls_scf_env%matrix_bs_sqrt_inv, template=ls_scf_env%matrix_s, &
109 matrix_type=dbcsr_type_no_symmetry)
110 CALL compute_matrix_preconditioner(ls_scf_env%matrix_s, &
111 ls_scf_env%s_preconditioner_type, ls_scf_env%ls_mstruct, &
112 ls_scf_env%matrix_bs_sqrt, ls_scf_env%matrix_bs_sqrt_inv, &
113 ls_scf_env%eps_filter, ls_scf_env%s_sqrt_order, &
114 ls_scf_env%eps_lanczos, ls_scf_env%max_iter_lanczos)
115 END IF
116
117 ! precondition S
118 IF (ls_scf_env%has_s_preconditioner) THEN
119 CALL apply_matrix_preconditioner(ls_scf_env%matrix_s, "forward", &
120 ls_scf_env%matrix_bs_sqrt, ls_scf_env%matrix_bs_sqrt_inv)
121 END IF
122
123 ! compute sqrt(S) and inv(sqrt(S))
124 IF (ls_scf_env%use_s_sqrt) THEN
125
126 CALL dbcsr_create(ls_scf_env%matrix_s_sqrt, template=ls_scf_env%matrix_s, &
127 matrix_type=dbcsr_type_no_symmetry)
128 CALL dbcsr_create(ls_scf_env%matrix_s_sqrt_inv, template=ls_scf_env%matrix_s, &
129 matrix_type=dbcsr_type_no_symmetry)
130
131 SELECT CASE (ls_scf_env%s_sqrt_method)
132 CASE (ls_s_sqrt_proot)
133 CALL matrix_sqrt_proot(ls_scf_env%matrix_s_sqrt, ls_scf_env%matrix_s_sqrt_inv, &
134 ls_scf_env%matrix_s, ls_scf_env%eps_filter, &
135 ls_scf_env%s_sqrt_order, &
136 ls_scf_env%eps_lanczos, ls_scf_env%max_iter_lanczos, &
137 symmetrize=.true.)
138 CASE (ls_s_sqrt_ns)
139 CALL matrix_sqrt_newton_schulz(ls_scf_env%matrix_s_sqrt, ls_scf_env%matrix_s_sqrt_inv, &
140 ls_scf_env%matrix_s, ls_scf_env%eps_filter, &
141 ls_scf_env%s_sqrt_order, &
142 ls_scf_env%eps_lanczos, ls_scf_env%max_iter_lanczos, &
143 iounit=-1)
144 CASE DEFAULT
145 cpabort("Unknown sqrt method.")
146 END SELECT
147
148 IF (ls_scf_env%check_s_inv) THEN
149 CALL dbcsr_create(matrix_tmp1, template=ls_scf_env%matrix_s, &
150 matrix_type=dbcsr_type_no_symmetry)
151 CALL dbcsr_create(matrix_tmp2, template=ls_scf_env%matrix_s, &
152 matrix_type=dbcsr_type_no_symmetry)
153
154 CALL dbcsr_multiply("N", "N", 1.0_dp, ls_scf_env%matrix_s_sqrt_inv, ls_scf_env%matrix_s, &
155 0.0_dp, matrix_tmp1, filter_eps=ls_scf_env%eps_filter)
156
157 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_tmp1, ls_scf_env%matrix_s_sqrt_inv, &
158 0.0_dp, matrix_tmp2, filter_eps=ls_scf_env%eps_filter)
159
160 frob_matrix_base = dbcsr_frobenius_norm(matrix_tmp2)
161 CALL dbcsr_add_on_diag(matrix_tmp2, -1.0_dp)
162 frob_matrix = dbcsr_frobenius_norm(matrix_tmp2)
163 IF (unit_nr > 0) THEN
164 WRITE (unit_nr, *) "Error for (inv(sqrt(S))*S*inv(sqrt(S))-I)", frob_matrix/frob_matrix_base
165 END IF
166
167 CALL dbcsr_release(matrix_tmp1)
168 CALL dbcsr_release(matrix_tmp2)
169 END IF
170 END IF
171
172 ! compute the inverse of S
173 IF (ls_scf_env%needs_s_inv) THEN
174 CALL dbcsr_create(ls_scf_env%matrix_s_inv, template=ls_scf_env%matrix_s, &
175 matrix_type=dbcsr_type_no_symmetry)
176 IF (.NOT. ls_scf_env%use_s_sqrt) THEN
177 CALL invert_hotelling(ls_scf_env%matrix_s_inv, ls_scf_env%matrix_s, ls_scf_env%eps_filter)
178 ELSE
179 CALL dbcsr_multiply("N", "N", 1.0_dp, ls_scf_env%matrix_s_sqrt_inv, ls_scf_env%matrix_s_sqrt_inv, &
180 0.0_dp, ls_scf_env%matrix_s_inv, filter_eps=ls_scf_env%eps_filter)
181 END IF
182 IF (ls_scf_env%check_s_inv) THEN
183 CALL dbcsr_create(matrix_tmp1, template=ls_scf_env%matrix_s, &
184 matrix_type=dbcsr_type_no_symmetry)
185 CALL dbcsr_multiply("N", "N", 1.0_dp, ls_scf_env%matrix_s_inv, ls_scf_env%matrix_s, &
186 0.0_dp, matrix_tmp1, filter_eps=ls_scf_env%eps_filter)
187 frob_matrix_base = dbcsr_frobenius_norm(matrix_tmp1)
188 CALL dbcsr_add_on_diag(matrix_tmp1, -1.0_dp)
189 frob_matrix = dbcsr_frobenius_norm(matrix_tmp1)
190 IF (unit_nr > 0) THEN
191 WRITE (unit_nr, *) "Error for (inv(S)*S-I)", frob_matrix/frob_matrix_base
192 END IF
193 CALL dbcsr_release(matrix_tmp1)
194 END IF
195 END IF
196
197 CALL timestop(handle)
198 END SUBROUTINE ls_scf_init_matrix_s
199
200! **************************************************************************************************
201!> \brief compute for a block positive definite matrix s (bs)
202!> the sqrt(bs) and inv(sqrt(bs))
203!> \param matrix_s ...
204!> \param preconditioner_type ...
205!> \param ls_mstruct ...
206!> \param matrix_bs_sqrt ...
207!> \param matrix_bs_sqrt_inv ...
208!> \param threshold ...
209!> \param order ...
210!> \param eps_lanczos ...
211!> \param max_iter_lanczos ...
212!> \par History
213!> 2010.10 created [Joost VandeVondele]
214!> \author Joost VandeVondele
215! **************************************************************************************************
216 SUBROUTINE compute_matrix_preconditioner(matrix_s, preconditioner_type, ls_mstruct, &
217 matrix_bs_sqrt, matrix_bs_sqrt_inv, threshold, order, &
218 eps_lanczos, max_iter_lanczos)
219
220 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_s
221 INTEGER :: preconditioner_type
222 TYPE(ls_mstruct_type) :: ls_mstruct
223 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_bs_sqrt, matrix_bs_sqrt_inv
224 REAL(kind=dp) :: threshold
225 INTEGER :: order
226 REAL(kind=dp) :: eps_lanczos
227 INTEGER :: max_iter_lanczos
228
229 CHARACTER(LEN=*), PARAMETER :: routinen = 'compute_matrix_preconditioner'
230
231 INTEGER :: handle, iblock_col, iblock_row
232 LOGICAL :: block_needed
233 REAL(dp), DIMENSION(:, :), POINTER :: block_dp
234 TYPE(dbcsr_iterator_type) :: iter
235 TYPE(dbcsr_type) :: matrix_bs
236
237 CALL timeset(routinen, handle)
238
239 ! first generate a block diagonal copy of s
240 CALL dbcsr_create(matrix_bs, template=matrix_s)
241
242 SELECT CASE (preconditioner_type)
245 CALL dbcsr_iterator_start(iter, matrix_s)
246 DO WHILE (dbcsr_iterator_blocks_left(iter))
247 CALL dbcsr_iterator_next_block(iter, iblock_row, iblock_col, block_dp)
248
249 ! do we need the block ?
250 ! this depends on the preconditioner, but also the matrix clustering method employed
251 ! for a clustered matrix, right now, we assume that atomic and molecular preconditioners
252 ! are actually the same, and only require that the diagonal blocks (clustered) are present
253
254 block_needed = .false.
255
256 IF (iblock_row == iblock_col) THEN
257 block_needed = .true.
258 ELSE
259 IF (preconditioner_type == ls_s_preconditioner_molecular .AND. &
260 ls_mstruct%cluster_type == ls_cluster_atomic) THEN
261 IF (ls_mstruct%atom_to_molecule(iblock_row) == ls_mstruct%atom_to_molecule(iblock_col)) block_needed = .true.
262 END IF
263 END IF
264
265 ! add it
266 IF (block_needed) THEN
267 CALL dbcsr_put_block(matrix=matrix_bs, row=iblock_row, col=iblock_col, block=block_dp)
268 END IF
269
270 END DO
271 CALL dbcsr_iterator_stop(iter)
272 END SELECT
273
274 CALL dbcsr_finalize(matrix_bs)
275
276 SELECT CASE (preconditioner_type)
278 ! for now make it a simple identity matrix
279 CALL dbcsr_copy(matrix_bs_sqrt, matrix_bs)
280 CALL dbcsr_set(matrix_bs_sqrt, 0.0_dp)
281 CALL dbcsr_add_on_diag(matrix_bs_sqrt, 1.0_dp)
282
283 ! for now make it a simple identity matrix
284 CALL dbcsr_copy(matrix_bs_sqrt_inv, matrix_bs)
285 CALL dbcsr_set(matrix_bs_sqrt_inv, 0.0_dp)
286 CALL dbcsr_add_on_diag(matrix_bs_sqrt_inv, 1.0_dp)
288 CALL dbcsr_copy(matrix_bs_sqrt, matrix_bs)
289 CALL dbcsr_copy(matrix_bs_sqrt_inv, matrix_bs)
290 ! XXXXXXXXXXX
291 ! XXXXXXXXXXX the threshold here could be done differently,
292 ! XXXXXXXXXXX using eps_filter is reducing accuracy for no good reason, this is cheap
293 ! XXXXXXXXXXX
294 CALL matrix_sqrt_newton_schulz(matrix_bs_sqrt, matrix_bs_sqrt_inv, matrix_bs, &
295 threshold=min(threshold, 1.0e-10_dp), order=order, &
296 eps_lanczos=eps_lanczos, max_iter_lanczos=max_iter_lanczos, &
297 iounit=-1)
298 END SELECT
299
300 CALL dbcsr_release(matrix_bs)
301
302 CALL timestop(handle)
303
304 END SUBROUTINE compute_matrix_preconditioner
305
306! **************************************************************************************************
307!> \brief apply a preconditioner either
308!> forward (precondition) inv(sqrt(bs)) * A * inv(sqrt(bs))
309!> backward (restore to old form) sqrt(bs) * A * sqrt(bs)
310!> \param matrix ...
311!> \param direction ...
312!> \param matrix_bs_sqrt ...
313!> \param matrix_bs_sqrt_inv ...
314!> \par History
315!> 2010.10 created [Joost VandeVondele]
316!> \author Joost VandeVondele
317! **************************************************************************************************
318 SUBROUTINE apply_matrix_preconditioner(matrix, direction, matrix_bs_sqrt, matrix_bs_sqrt_inv)
319
320 TYPE(dbcsr_type), INTENT(INOUT) :: matrix
321 CHARACTER(LEN=*) :: direction
322 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_bs_sqrt, matrix_bs_sqrt_inv
323
324 CHARACTER(LEN=*), PARAMETER :: routinen = 'apply_matrix_preconditioner'
325
326 INTEGER :: handle
327 TYPE(dbcsr_type) :: matrix_tmp
328
329 CALL timeset(routinen, handle)
330 CALL dbcsr_create(matrix_tmp, template=matrix, matrix_type=dbcsr_type_no_symmetry)
331
332 SELECT CASE (direction)
333 CASE ("forward")
334 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix, matrix_bs_sqrt_inv, &
335 0.0_dp, matrix_tmp)
336 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_bs_sqrt_inv, matrix_tmp, &
337 0.0_dp, matrix)
338 CASE ("backward")
339 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix, matrix_bs_sqrt, &
340 0.0_dp, matrix_tmp)
341 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_bs_sqrt, matrix_tmp, &
342 0.0_dp, matrix)
343 CASE DEFAULT
344 cpabort("")
345 END SELECT
346
347 CALL dbcsr_release(matrix_tmp)
348
349 CALL timestop(handle)
350
351 END SUBROUTINE apply_matrix_preconditioner
352
353! **************************************************************************************************
354!> \brief compute the density matrix with a trace that is close to nelectron.
355!> take a mu as input, and improve by bisection as needed.
356!> \param matrix_p ...
357!> \param mu ...
358!> \param fixed_mu ...
359!> \param sign_method ...
360!> \param sign_order ...
361!> \param matrix_ks ...
362!> \param matrix_s ...
363!> \param matrix_s_inv ...
364!> \param nelectron ...
365!> \param threshold ...
366!> \param sign_symmetric ...
367!> \param submatrix_sign_method ...
368!> \param matrix_s_sqrt_inv ...
369!> \par History
370!> 2010.10 created [Joost VandeVondele]
371!> 2020.07 support for methods with internal mu adjustment [Michael Lass]
372!> \author Joost VandeVondele
373! **************************************************************************************************
374 SUBROUTINE density_matrix_sign(matrix_p, mu, fixed_mu, sign_method, sign_order, matrix_ks, &
375 matrix_s, matrix_s_inv, nelectron, threshold, sign_symmetric, submatrix_sign_method, &
376 matrix_s_sqrt_inv)
377
378 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_p
379 REAL(kind=dp), INTENT(INOUT) :: mu
380 LOGICAL :: fixed_mu
381 INTEGER :: sign_method, sign_order
382 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_ks, matrix_s, matrix_s_inv
383 INTEGER, INTENT(IN) :: nelectron
384 REAL(kind=dp), INTENT(IN) :: threshold
385 LOGICAL, OPTIONAL :: sign_symmetric
386 INTEGER, OPTIONAL :: submatrix_sign_method
387 TYPE(dbcsr_type), INTENT(IN), OPTIONAL :: matrix_s_sqrt_inv
388
389 CHARACTER(LEN=*), PARAMETER :: routinen = 'density_matrix_sign'
390 REAL(kind=dp), PARAMETER :: initial_increment = 0.01_dp
391
392 INTEGER :: handle, iter, unit_nr, &
393 used_submatrix_sign_method
394 LOGICAL :: do_sign_symmetric, has_mu_high, &
395 has_mu_low, internal_mu_adjust
396 REAL(kind=dp) :: increment, mu_high, mu_low, trace
397 TYPE(cp_logger_type), POINTER :: logger
398
399 CALL timeset(routinen, handle)
400
401 logger => cp_get_default_logger()
402 IF (logger%para_env%is_source()) THEN
403 unit_nr = cp_logger_get_default_unit_nr(logger, local=.true.)
404 ELSE
405 unit_nr = -1
406 END IF
407
408 do_sign_symmetric = .false.
409 IF (PRESENT(sign_symmetric)) do_sign_symmetric = sign_symmetric
410
411 used_submatrix_sign_method = ls_scf_submatrix_sign_ns
412 IF (PRESENT(submatrix_sign_method)) used_submatrix_sign_method = submatrix_sign_method
413
414 internal_mu_adjust = ((sign_method .EQ. ls_scf_sign_submatrix) .AND. &
415 (used_submatrix_sign_method .EQ. ls_scf_submatrix_sign_direct_muadj .OR. &
416 used_submatrix_sign_method .EQ. ls_scf_submatrix_sign_direct_muadj_lowmem))
417
418 IF (internal_mu_adjust) THEN
419 CALL density_matrix_sign_internal_mu(matrix_p, trace, mu, sign_method, &
420 matrix_ks, matrix_s, threshold, &
421 used_submatrix_sign_method, &
422 nelectron, matrix_s_sqrt_inv)
423 ELSE
424 increment = initial_increment
425
426 has_mu_low = .false.
427 has_mu_high = .false.
428
429 ! bisect if both bounds are known, otherwise find the bounds with a linear search
430 DO iter = 1, 30
431 IF (has_mu_low .AND. has_mu_high) THEN
432 mu = (mu_low + mu_high)/2
433 IF (abs(mu_high - mu_low) < threshold) EXIT
434 END IF
435
436 CALL density_matrix_sign_fixed_mu(matrix_p, trace, mu, sign_method, sign_order, &
437 matrix_ks, matrix_s, matrix_s_inv, threshold, &
438 do_sign_symmetric, used_submatrix_sign_method, &
439 matrix_s_sqrt_inv)
440 IF (unit_nr > 0) WRITE (unit_nr, '(T2,A,I2,1X,F13.9,1X,F15.9)') &
441 "Density matrix: iter, mu, trace error: ", iter, mu, trace - nelectron
442
443 ! OK, we can skip early if we are as close as possible to the exact result
444 ! smaller differences should be considered 'noise'
445 IF (abs(trace - nelectron) < 0.5_dp .OR. fixed_mu) EXIT
446
447 IF (trace < nelectron) THEN
448 mu_low = mu
449 mu = mu + increment
450 has_mu_low = .true.
451 increment = increment*2
452 ELSE
453 mu_high = mu
454 mu = mu - increment
455 has_mu_high = .true.
456 increment = increment*2
457 END IF
458 END DO
459
460 END IF
461
462 CALL timestop(handle)
463
464 END SUBROUTINE density_matrix_sign
465
466! **************************************************************************************************
467!> \brief for a fixed mu, compute the corresponding density matrix and its trace
468!> \param matrix_p ...
469!> \param trace ...
470!> \param mu ...
471!> \param sign_method ...
472!> \param sign_order ...
473!> \param matrix_ks ...
474!> \param matrix_s ...
475!> \param matrix_s_inv ...
476!> \param threshold ...
477!> \param sign_symmetric ...
478!> \param submatrix_sign_method ...
479!> \param matrix_s_sqrt_inv ...
480!> \par History
481!> 2010.10 created [Joost VandeVondele]
482!> \author Joost VandeVondele
483! **************************************************************************************************
484 SUBROUTINE density_matrix_sign_fixed_mu(matrix_p, trace, mu, sign_method, sign_order, matrix_ks, &
485 matrix_s, matrix_s_inv, threshold, sign_symmetric, submatrix_sign_method, &
486 matrix_s_sqrt_inv)
487
488 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_p
489 REAL(kind=dp), INTENT(OUT) :: trace
490 REAL(kind=dp), INTENT(INOUT) :: mu
491 INTEGER :: sign_method, sign_order
492 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_ks, matrix_s, matrix_s_inv
493 REAL(kind=dp), INTENT(IN) :: threshold
494 LOGICAL :: sign_symmetric
495 INTEGER :: submatrix_sign_method
496 TYPE(dbcsr_type), INTENT(IN), OPTIONAL :: matrix_s_sqrt_inv
497
498 CHARACTER(LEN=*), PARAMETER :: routinen = 'density_matrix_sign_fixed_mu'
499
500 INTEGER :: handle, unit_nr
501 REAL(kind=dp) :: frob_matrix
502 TYPE(cp_logger_type), POINTER :: logger
503 TYPE(dbcsr_type) :: matrix_p_ud, matrix_sign, matrix_sinv_ks, matrix_ssqrtinv_ks_ssqrtinv, &
504 matrix_ssqrtinv_ks_ssqrtinv2, matrix_tmp
505
506 CALL timeset(routinen, handle)
507
508 logger => cp_get_default_logger()
509 IF (logger%para_env%is_source()) THEN
510 unit_nr = cp_logger_get_default_unit_nr(logger, local=.true.)
511 ELSE
512 unit_nr = -1
513 END IF
514
515 CALL dbcsr_create(matrix_sign, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
516
517 IF (sign_symmetric) THEN
518
519 IF (.NOT. PRESENT(matrix_s_sqrt_inv)) &
520 cpabort("Argument matrix_s_sqrt_inv required if sign_symmetric is set")
521
522 CALL dbcsr_create(matrix_ssqrtinv_ks_ssqrtinv, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
523 CALL dbcsr_create(matrix_ssqrtinv_ks_ssqrtinv2, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
524 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_ks, &
525 0.0_dp, matrix_ssqrtinv_ks_ssqrtinv2, filter_eps=threshold)
526 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_ssqrtinv_ks_ssqrtinv2, matrix_s_sqrt_inv, &
527 0.0_dp, matrix_ssqrtinv_ks_ssqrtinv, filter_eps=threshold)
528 CALL dbcsr_add_on_diag(matrix_ssqrtinv_ks_ssqrtinv, -mu)
529
530 SELECT CASE (sign_method)
531 CASE (ls_scf_sign_ns)
532 CALL matrix_sign_newton_schulz(matrix_sign, matrix_ssqrtinv_ks_ssqrtinv, threshold, sign_order, iounit=-1)
533 CASE (ls_scf_sign_proot)
534 CALL matrix_sign_proot(matrix_sign, matrix_ssqrtinv_ks_ssqrtinv, threshold, sign_order)
536 CALL matrix_sign_submatrix(matrix_sign, matrix_ssqrtinv_ks_ssqrtinv, threshold, sign_order, submatrix_sign_method)
537 CASE DEFAULT
538 cpabort("Unkown sign method.")
539 END SELECT
540 CALL dbcsr_release(matrix_ssqrtinv_ks_ssqrtinv)
541 CALL dbcsr_release(matrix_ssqrtinv_ks_ssqrtinv2)
542
543 ELSE ! .NOT. sign_symmetric
544 ! get inv(S)*H-I*mu
545 CALL dbcsr_create(matrix_sinv_ks, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
546 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_inv, matrix_ks, &
547 0.0_dp, matrix_sinv_ks, filter_eps=threshold)
548 CALL dbcsr_add_on_diag(matrix_sinv_ks, -mu)
549
550 ! compute sign(inv(S)*H-I*mu)
551 SELECT CASE (sign_method)
552 CASE (ls_scf_sign_ns)
553 CALL matrix_sign_newton_schulz(matrix_sign, matrix_sinv_ks, threshold, sign_order, iounit=-1)
554 CASE (ls_scf_sign_proot)
555 CALL matrix_sign_proot(matrix_sign, matrix_sinv_ks, threshold, sign_order)
557 CALL matrix_sign_submatrix(matrix_sign, matrix_sinv_ks, threshold, sign_order, submatrix_sign_method)
558 CASE DEFAULT
559 cpabort("Unkown sign method.")
560 END SELECT
561 CALL dbcsr_release(matrix_sinv_ks)
562 END IF
563
564 ! now construct the density matrix PS=0.5*(I-sign(inv(S)H-I*mu))
565 CALL dbcsr_create(matrix_p_ud, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
566 CALL dbcsr_copy(matrix_p_ud, matrix_sign)
567 CALL dbcsr_scale(matrix_p_ud, -0.5_dp)
568 CALL dbcsr_add_on_diag(matrix_p_ud, 0.5_dp)
569 CALL dbcsr_release(matrix_sign)
570
571 ! we now have PS, lets get its trace
572 CALL dbcsr_trace(matrix_p_ud, trace)
573
574 ! we can also check it is idempotent PS*PS=PS
575 CALL dbcsr_create(matrix_tmp, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
576 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_p_ud, matrix_p_ud, &
577 0.0_dp, matrix_tmp, filter_eps=threshold)
578 CALL dbcsr_add(matrix_tmp, matrix_p_ud, 1.0_dp, -1.0_dp)
579 frob_matrix = dbcsr_frobenius_norm(matrix_tmp)
580 IF (unit_nr > 0 .AND. frob_matrix > 0.001_dp) &
581 WRITE (unit_nr, '(T2,A,F20.12)') "Deviation from idempotency: ", frob_matrix
582
583 IF (sign_symmetric) THEN
584 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_p_ud, &
585 0.0_dp, matrix_tmp, filter_eps=threshold)
586 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_tmp, matrix_s_sqrt_inv, &
587 0.0_dp, matrix_p, filter_eps=threshold)
588 ELSE
589
590 ! get P=PS*inv(S)
591 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_p_ud, matrix_s_inv, &
592 0.0_dp, matrix_p, filter_eps=threshold)
593 END IF
594 CALL dbcsr_release(matrix_p_ud)
595 CALL dbcsr_release(matrix_tmp)
596
597 CALL timestop(handle)
598
599 END SUBROUTINE density_matrix_sign_fixed_mu
600
601! **************************************************************************************************
602!> \brief compute the corresponding density matrix and its trace, using methods with internal mu adjustment
603!> \param matrix_p ...
604!> \param trace ...
605!> \param mu ...
606!> \param sign_method ...
607!> \param matrix_ks ...
608!> \param matrix_s ...
609!> \param threshold ...
610!> \param submatrix_sign_method ...
611!> \param nelectron ...
612!> \param matrix_s_sqrt_inv ...
613!> \par History
614!> 2020.07 created, based on density_matrix_sign_fixed_mu [Michael Lass]
615!> \author Michael Lass
616! **************************************************************************************************
617 SUBROUTINE density_matrix_sign_internal_mu(matrix_p, trace, mu, sign_method, matrix_ks, &
618 matrix_s, threshold, submatrix_sign_method, &
619 nelectron, matrix_s_sqrt_inv)
620
621 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_p
622 REAL(kind=dp), INTENT(OUT) :: trace
623 REAL(kind=dp), INTENT(INOUT) :: mu
624 INTEGER :: sign_method
625 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_ks, matrix_s
626 REAL(kind=dp), INTENT(IN) :: threshold
627 INTEGER :: submatrix_sign_method
628 INTEGER, INTENT(IN) :: nelectron
629 TYPE(dbcsr_type), INTENT(IN) :: matrix_s_sqrt_inv
630
631 CHARACTER(LEN=*), PARAMETER :: routinen = 'density_matrix_sign_internal_mu'
632
633 INTEGER :: handle, unit_nr
634 REAL(kind=dp) :: frob_matrix
635 TYPE(cp_logger_type), POINTER :: logger
636 TYPE(dbcsr_type) :: matrix_p_ud, matrix_sign, &
637 matrix_ssqrtinv_ks_ssqrtinv, &
638 matrix_ssqrtinv_ks_ssqrtinv2, &
639 matrix_tmp
640
641 CALL timeset(routinen, handle)
642
643 logger => cp_get_default_logger()
644 IF (logger%para_env%is_source()) THEN
645 unit_nr = cp_logger_get_default_unit_nr(logger, local=.true.)
646 ELSE
647 unit_nr = -1
648 END IF
649
650 CALL dbcsr_create(matrix_sign, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
651
652 CALL dbcsr_create(matrix_ssqrtinv_ks_ssqrtinv, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
653 CALL dbcsr_create(matrix_ssqrtinv_ks_ssqrtinv2, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
654 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_ks, &
655 0.0_dp, matrix_ssqrtinv_ks_ssqrtinv2, filter_eps=threshold)
656 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_ssqrtinv_ks_ssqrtinv2, matrix_s_sqrt_inv, &
657 0.0_dp, matrix_ssqrtinv_ks_ssqrtinv, filter_eps=threshold)
658 CALL dbcsr_add_on_diag(matrix_ssqrtinv_ks_ssqrtinv, -mu)
659
660 SELECT CASE (sign_method)
662 SELECT CASE (submatrix_sign_method)
664 CALL matrix_sign_submatrix_mu_adjust(matrix_sign, matrix_ssqrtinv_ks_ssqrtinv, mu, nelectron, threshold, &
665 submatrix_sign_method)
666 CASE DEFAULT
667 cpabort("density_matrix_sign_internal_mu called with invalid submatrix sign method")
668 END SELECT
669 CASE DEFAULT
670 cpabort("density_matrix_sign_internal_mu called with invalid sign method.")
671 END SELECT
672 CALL dbcsr_release(matrix_ssqrtinv_ks_ssqrtinv)
673 CALL dbcsr_release(matrix_ssqrtinv_ks_ssqrtinv2)
674
675 ! now construct the density matrix PS=0.5*(I-sign(inv(S)H-I*mu))
676 CALL dbcsr_create(matrix_p_ud, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
677 CALL dbcsr_copy(matrix_p_ud, matrix_sign)
678 CALL dbcsr_scale(matrix_p_ud, -0.5_dp)
679 CALL dbcsr_add_on_diag(matrix_p_ud, 0.5_dp)
680 CALL dbcsr_release(matrix_sign)
681
682 ! we now have PS, lets get its trace
683 CALL dbcsr_trace(matrix_p_ud, trace)
684
685 ! we can also check it is idempotent PS*PS=PS
686 CALL dbcsr_create(matrix_tmp, template=matrix_s, matrix_type=dbcsr_type_no_symmetry)
687 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_p_ud, matrix_p_ud, &
688 0.0_dp, matrix_tmp, filter_eps=threshold)
689 CALL dbcsr_add(matrix_tmp, matrix_p_ud, 1.0_dp, -1.0_dp)
690 frob_matrix = dbcsr_frobenius_norm(matrix_tmp)
691 IF (unit_nr > 0 .AND. frob_matrix > 0.001_dp) &
692 WRITE (unit_nr, '(T2,A,F20.12)') "Deviation from idempotency: ", frob_matrix
693
694 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_p_ud, &
695 0.0_dp, matrix_tmp, filter_eps=threshold)
696 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_tmp, matrix_s_sqrt_inv, &
697 0.0_dp, matrix_p, filter_eps=threshold)
698 CALL dbcsr_release(matrix_p_ud)
699 CALL dbcsr_release(matrix_tmp)
700
701 CALL timestop(handle)
702
703 END SUBROUTINE density_matrix_sign_internal_mu
704
705! **************************************************************************************************
706!> \brief compute the density matrix using a trace-resetting algorithm
707!> \param matrix_p ...
708!> \param matrix_ks ...
709!> \param matrix_s_sqrt_inv ...
710!> \param nelectron ...
711!> \param threshold ...
712!> \param e_homo ...
713!> \param e_lumo ...
714!> \param e_mu ...
715!> \param dynamic_threshold ...
716!> \param matrix_ks_deviation ...
717!> \param max_iter_lanczos ...
718!> \param eps_lanczos ...
719!> \param converged ...
720!> \param iounit ...
721!> \par History
722!> 2012.06 created [Florian Thoele]
723!> \author Florian Thoele
724! **************************************************************************************************
725 SUBROUTINE density_matrix_trs4(matrix_p, matrix_ks, matrix_s_sqrt_inv, &
726 nelectron, threshold, e_homo, e_lumo, e_mu, &
727 dynamic_threshold, matrix_ks_deviation, &
728 max_iter_lanczos, eps_lanczos, converged, iounit)
729
730 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_p
731 TYPE(dbcsr_type), INTENT(IN) :: matrix_ks, matrix_s_sqrt_inv
732 INTEGER, INTENT(IN) :: nelectron
733 REAL(kind=dp), INTENT(IN) :: threshold
734 REAL(kind=dp), INTENT(INOUT) :: e_homo, e_lumo, e_mu
735 LOGICAL, INTENT(IN), OPTIONAL :: dynamic_threshold
736 TYPE(dbcsr_type), INTENT(INOUT), OPTIONAL :: matrix_ks_deviation
737 INTEGER, INTENT(IN) :: max_iter_lanczos
738 REAL(kind=dp), INTENT(IN) :: eps_lanczos
739 LOGICAL, INTENT(OUT), OPTIONAL :: converged
740 INTEGER, INTENT(IN), OPTIONAL :: iounit
741
742 CHARACTER(LEN=*), PARAMETER :: routinen = 'density_matrix_trs4'
743 INTEGER, PARAMETER :: max_iter = 100
744 REAL(kind=dp), PARAMETER :: gamma_max = 6.0_dp, gamma_min = 0.0_dp
745
746 INTEGER :: branch, estimated_steps, handle, i, j, &
747 unit_nr
748 INTEGER(kind=int_8) :: flop1, flop2
749 LOGICAL :: arnoldi_converged, do_dyn_threshold
750 REAL(kind=dp) :: current_threshold, delta_n, eps_max, eps_min, est_threshold, frob_id, &
751 frob_x, gam, homo, lumo, max_eig, max_threshold, maxdev, maxev, min_eig, minev, mmin, mu, &
752 mu_a, mu_b, mu_c, mu_fa, mu_fc, occ_matrix, scaled_homo_bound, scaled_lumo_bound, t1, t2, &
753 trace_fx, trace_gx, xi
754 REAL(kind=dp), ALLOCATABLE, DIMENSION(:) :: gamma_values
755 TYPE(cp_logger_type), POINTER :: logger
756 TYPE(dbcsr_type) :: matrix_k0, matrix_x, matrix_x_nosym, &
757 matrix_xidsq, matrix_xsq, tmp_gx
758
759 IF (nelectron == 0) THEN
760 CALL dbcsr_set(matrix_p, 0.0_dp)
761 RETURN
762 END IF
763
764 CALL timeset(routinen, handle)
765
766 IF (PRESENT(iounit)) THEN
767 unit_nr = iounit
768 ELSE
769 logger => cp_get_default_logger()
770 IF (logger%para_env%is_source()) THEN
771 unit_nr = cp_logger_get_default_unit_nr(logger, local=.true.)
772 ELSE
773 unit_nr = -1
774 END IF
775 END IF
776
777 do_dyn_threshold = .false.
778 IF (PRESENT(dynamic_threshold)) do_dyn_threshold = dynamic_threshold
779
780 IF (PRESENT(converged)) converged = .false.
781
782 ! init X = (eps_n*I - H)/(eps_n - eps_0) ... H* = S^-1/2*H*S^-1/2
783 CALL dbcsr_create(matrix_x, template=matrix_ks, matrix_type="S")
784
785 ! at some points the non-symmetric version of x is required
786 CALL dbcsr_create(matrix_x_nosym, template=matrix_ks, matrix_type=dbcsr_type_no_symmetry)
787
788 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_ks, &
789 0.0_dp, matrix_x_nosym, filter_eps=threshold)
790 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_x_nosym, matrix_s_sqrt_inv, &
791 0.0_dp, matrix_x, filter_eps=threshold)
792 CALL dbcsr_desymmetrize(matrix_x, matrix_x_nosym)
793
794 CALL dbcsr_create(matrix_k0, template=matrix_ks, matrix_type=dbcsr_type_no_symmetry)
795 CALL dbcsr_copy(matrix_k0, matrix_x_nosym)
796
797 ! compute the deviation in the mixed matrix, as seen in the ortho basis
798 IF (do_dyn_threshold) THEN
799 cpassert(PRESENT(matrix_ks_deviation))
800 CALL dbcsr_add(matrix_ks_deviation, matrix_x_nosym, -1.0_dp, 1.0_dp)
801 CALL arnoldi_extremal(matrix_ks_deviation, maxev, minev, max_iter=max_iter_lanczos, threshold=eps_lanczos, &
802 converged=arnoldi_converged)
803 maxdev = max(abs(maxev), abs(minev))
804 IF (unit_nr > 0) THEN
805 WRITE (unit_nr, '(T6,A,1X,L12)') "Lanczos converged: ", arnoldi_converged
806 WRITE (unit_nr, '(T6,A,1X,F12.5)') "change in mixed matrix: ", maxdev
807 WRITE (unit_nr, '(T6,A,1X,F12.5)') "HOMO upper bound: ", e_homo + maxdev
808 WRITE (unit_nr, '(T6,A,1X,F12.5)') "LUMO lower bound: ", e_lumo - maxdev
809 WRITE (unit_nr, '(T6,A,1X,L12)') "Predicts a gap ? ", ((e_lumo - maxdev) - (e_homo + maxdev)) > 0
810 END IF
811 ! save the old mixed matrix
812 CALL dbcsr_copy(matrix_ks_deviation, matrix_x_nosym)
813
814 END IF
815
816 ! get largest/smallest eigenvalues for scaling
817 CALL arnoldi_extremal(matrix_x_nosym, max_eig, min_eig, max_iter=max_iter_lanczos, threshold=eps_lanczos, &
818 converged=arnoldi_converged)
819 IF (unit_nr > 0) WRITE (unit_nr, '(T6,A,1X,2F12.5,1X,A,1X,L1)') "Est. extremal eigenvalues", &
820 min_eig, max_eig, " converged: ", arnoldi_converged
821 eps_max = max_eig
822 eps_min = min_eig
823
824 ! scale KS matrix
825 IF (eps_max == eps_min) THEN
826 CALL dbcsr_scale(matrix_x, 1.0_dp/eps_max)
827 ELSE
828 CALL dbcsr_add_on_diag(matrix_x, -eps_max)
829 CALL dbcsr_scale(matrix_x, -1.0_dp/(eps_max - eps_min))
830 END IF
831
832 current_threshold = threshold
833 IF (do_dyn_threshold) THEN
834 ! scale bounds for HOMO/LUMO
835 scaled_homo_bound = (eps_max - (e_homo + maxdev))/(eps_max - eps_min)
836 scaled_lumo_bound = (eps_max - (e_lumo - maxdev))/(eps_max - eps_min)
837 END IF
838
839 CALL dbcsr_create(matrix_xsq, template=matrix_ks, matrix_type="S")
840
841 CALL dbcsr_create(matrix_xidsq, template=matrix_ks, matrix_type="S")
842
843 CALL dbcsr_create(tmp_gx, template=matrix_ks, matrix_type="S")
844
845 ALLOCATE (gamma_values(max_iter))
846
847 DO i = 1, max_iter
848 t1 = m_walltime()
849 flop1 = 0; flop2 = 0
850
851 ! get X*X
852 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_x, matrix_x, &
853 0.0_dp, matrix_xsq, &
854 filter_eps=current_threshold, flop=flop1)
855
856 ! intermediate use matrix_xidsq to compute = X*X-X
857 CALL dbcsr_copy(matrix_xidsq, matrix_x)
858 CALL dbcsr_add(matrix_xidsq, matrix_xsq, -1.0_dp, 1.0_dp)
859 frob_id = dbcsr_frobenius_norm(matrix_xidsq)
860 frob_x = dbcsr_frobenius_norm(matrix_x)
861
862 ! xidsq = (1-X)*(1-X)
863 ! use (1-x)*(1-x) = 1 + x*x - 2*x
864 CALL dbcsr_copy(matrix_xidsq, matrix_x)
865 CALL dbcsr_add(matrix_xidsq, matrix_xsq, -2.0_dp, 1.0_dp)
866 CALL dbcsr_add_on_diag(matrix_xidsq, 1.0_dp)
867
868 ! tmp_gx = 4X-3X*X
869 CALL dbcsr_copy(tmp_gx, matrix_x)
870 CALL dbcsr_add(tmp_gx, matrix_xsq, 4.0_dp, -3.0_dp)
871
872 ! get gamma
873 ! Tr(F) = Tr(XX*tmp_gx) Tr(G) is equivalent
874 CALL dbcsr_dot(matrix_xsq, matrix_xidsq, trace_gx)
875 CALL dbcsr_dot(matrix_xsq, tmp_gx, trace_fx)
876
877 ! if converged, and gam becomes noisy, fix it to 3, which results in a final McWeeny step.
878 ! do this only if the electron count is reasonable.
879 ! maybe tune if the current criterion is not good enough
880 delta_n = nelectron - trace_fx
881 ! condition: ABS(frob_id/frob_x) < SQRT(threshold) ...
882 IF (((frob_id*frob_id) < (threshold*frob_x*frob_x)) .AND. (abs(delta_n) < 0.5_dp)) THEN
883 gam = 3.0_dp
884 ELSE IF (abs(delta_n) < 1e-14_dp) THEN
885 gam = 0.0_dp ! rare case of perfect electron count
886 ELSE
887 ! make sure, we don't divide by zero, as soon as gam is outside the interval gam_min,gam_max, it doesn't matter
888 gam = delta_n/max(trace_gx, abs(delta_n)/100)
889 END IF
890 gamma_values(i) = gam
891
892 IF (unit_nr > 0 .AND. .false.) THEN
893 WRITE (unit_nr, *) "trace_fx", trace_fx, "trace_gx", trace_gx, "gam", gam, &
894 "frob_id", frob_id, "conv", abs(frob_id/frob_x)
895 END IF
896
897 IF (do_dyn_threshold) THEN
898 ! quantities used for dynamic thresholding, when the estimated gap is larger than zero
899 xi = (scaled_homo_bound - scaled_lumo_bound)
900 IF (xi > 0.0_dp) THEN
901 mmin = 0.5*(scaled_homo_bound + scaled_lumo_bound)
902 max_threshold = abs(1 - 2*mmin)*xi
903
904 scaled_homo_bound = evaluate_trs4_polynomial(scaled_homo_bound, gamma_values(i:), 1)
905 scaled_lumo_bound = evaluate_trs4_polynomial(scaled_lumo_bound, gamma_values(i:), 1)
906 estimated_steps = estimate_steps(scaled_homo_bound, scaled_lumo_bound, threshold)
907
908 est_threshold = (threshold/(estimated_steps + i + 1))*xi/(1 + threshold/(estimated_steps + i + 1))
909 est_threshold = min(max_threshold, est_threshold)
910 IF (i > 1) est_threshold = max(est_threshold, 0.1_dp*current_threshold)
911 current_threshold = est_threshold
912 ELSE
913 current_threshold = threshold
914 END IF
915 END IF
916
917 IF (gam > gamma_max) THEN
918 ! Xn+1 = 2X-X*X
919 CALL dbcsr_add(matrix_x, matrix_xsq, 2.0_dp, -1.0_dp)
920 CALL dbcsr_filter(matrix_x, current_threshold)
921 branch = 1
922 ELSE IF (gam < gamma_min) THEN
923 ! Xn+1 = X*X
924 CALL dbcsr_copy(matrix_x, matrix_xsq)
925 branch = 2
926 ELSE
927 ! Xn+1 = F(X) + gam*G(X)
928 CALL dbcsr_add(tmp_gx, matrix_xidsq, 1.0_dp, gam)
929 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_xsq, tmp_gx, &
930 0.0_dp, matrix_x, &
931 flop=flop2, filter_eps=current_threshold)
932 branch = 3
933 END IF
934
935 occ_matrix = dbcsr_get_occupation(matrix_x)
936 t2 = m_walltime()
937 IF (unit_nr > 0) THEN
938 WRITE (unit_nr, &
939 '(T6,A,I3,1X,F10.8,E12.3,F12.3,F13.3,E12.3)') "TRS4 it ", &
940 i, occ_matrix, abs(trace_gx), t2 - t1, &
941 (flop1 + flop2)/(1.0e6_dp*max(t2 - t1, 0.001_dp)), current_threshold
942 CALL m_flush(unit_nr)
943 END IF
944
945 IF (abnormal_value(trace_gx)) &
946 cpabort("trace_gx is an abnormal value (NaN/Inf).")
947
948 ! a branch of 1 or 2 appears to lead to a less accurate electron number count and premature exit
949 ! if it turns out this does not exit because we get stuck in branch 1/2 for a reason we need to refine further
950 ! condition: ABS(frob_id/frob_x) < SQRT(threshold) ...
951 IF ((frob_id*frob_id) < (threshold*frob_x*frob_x) .AND. branch == 3 .AND. (abs(delta_n) < 0.5_dp)) THEN
952 IF (PRESENT(converged)) converged = .true.
953 EXIT
954 END IF
955
956 END DO
957
958 occ_matrix = dbcsr_get_occupation(matrix_x)
959 IF (unit_nr > 0) WRITE (unit_nr, '(T6,A,I3,1X,F10.8,E12.3)') 'Final TRS4 iteration ', i, occ_matrix, abs(trace_gx)
960
961 ! free some memory
962 CALL dbcsr_release(tmp_gx)
963 CALL dbcsr_release(matrix_xsq)
964 CALL dbcsr_release(matrix_xidsq)
965
966 ! output to matrix_p, P = inv(S)^0.5 X inv(S)^0.5
967 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_x, matrix_s_sqrt_inv, &
968 0.0_dp, matrix_x_nosym, filter_eps=threshold)
969 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_x_nosym, &
970 0.0_dp, matrix_p, filter_eps=threshold)
971
972 ! calculate the chemical potential by doing a bisection of fk(x0)-0.5, where fk is evaluated using the stored values for gamma
973 ! E. Rubensson et al., Chem Phys Lett 432, 2006, 591-594
974 mu_a = 0.0_dp; mu_b = 1.0_dp;
975 mu_fa = evaluate_trs4_polynomial(mu_a, gamma_values, i - 1) - 0.5_dp
976 DO j = 1, 40
977 mu_c = 0.5*(mu_a + mu_b)
978 mu_fc = evaluate_trs4_polynomial(mu_c, gamma_values, i - 1) - 0.5_dp ! i-1 because in the last iteration, only convergence is checked
979 IF (abs(mu_fc) < 1.0e-6_dp .OR. (mu_b - mu_a)/2 < 1.0e-6_dp) EXIT !TODO: define threshold values
980
981 IF (mu_fc*mu_fa > 0) THEN
982 mu_a = mu_c
983 mu_fa = mu_fc
984 ELSE
985 mu_b = mu_c
986 END IF
987 END DO
988 mu = (eps_min - eps_max)*mu_c + eps_max
989 DEALLOCATE (gamma_values)
990 IF (unit_nr > 0) THEN
991 WRITE (unit_nr, '(T6,A,1X,F12.5)') 'Chemical potential (mu): ', mu
992 END IF
993 e_mu = mu
994
995 IF (do_dyn_threshold) THEN
996 CALL dbcsr_desymmetrize(matrix_x, matrix_x_nosym)
997 CALL compute_homo_lumo(matrix_k0, matrix_x_nosym, eps_min, eps_max, &
998 threshold, max_iter_lanczos, eps_lanczos, homo, lumo, unit_nr)
999 e_homo = homo
1000 e_lumo = lumo
1001 END IF
1002
1003 CALL dbcsr_release(matrix_x)
1004 CALL dbcsr_release(matrix_x_nosym)
1005 CALL dbcsr_release(matrix_k0)
1006 CALL timestop(handle)
1007
1008 END SUBROUTINE density_matrix_trs4
1009
1010! **************************************************************************************************
1011!> \brief compute the density matrix using a non monotonic trace conserving
1012!> algorithm based on SIAM DOI. 10.1137/130911585.
1013!> 2014.04 created [Jonathan Mullin]
1014!> \param matrix_p ...
1015!> \param matrix_ks ...
1016!> \param matrix_s_sqrt_inv ...
1017!> \param nelectron ...
1018!> \param threshold ...
1019!> \param e_homo ...
1020!> \param e_lumo ...
1021!> \param non_monotonic ...
1022!> \param eps_lanczos ...
1023!> \param max_iter_lanczos ...
1024!> \param iounit ...
1025!> \author Jonathan Mullin
1026! **************************************************************************************************
1027 SUBROUTINE density_matrix_tc2(matrix_p, matrix_ks, matrix_s_sqrt_inv, &
1028 nelectron, threshold, e_homo, e_lumo, &
1029 non_monotonic, eps_lanczos, max_iter_lanczos, iounit)
1030
1031 TYPE(dbcsr_type), INTENT(INOUT) :: matrix_p
1032 TYPE(dbcsr_type), INTENT(IN) :: matrix_ks, matrix_s_sqrt_inv
1033 INTEGER, INTENT(IN) :: nelectron
1034 REAL(kind=dp), INTENT(IN) :: threshold
1035 REAL(kind=dp), INTENT(INOUT) :: e_homo, e_lumo
1036 LOGICAL, INTENT(IN), OPTIONAL :: non_monotonic
1037 REAL(kind=dp), INTENT(IN) :: eps_lanczos
1038 INTEGER, INTENT(IN) :: max_iter_lanczos
1039 INTEGER, INTENT(IN), OPTIONAL :: iounit
1040
1041 CHARACTER(LEN=*), PARAMETER :: routinen = 'density_matrix_tc2'
1042 INTEGER, PARAMETER :: max_iter = 100
1043
1044 INTEGER :: handle, i, j, k, unit_nr
1045 INTEGER(kind=int_8) :: flop1, flop2
1046 LOGICAL :: converged, do_non_monotonic
1047 REAL(kind=dp) :: beta, betab, eps_max, eps_min, gama, &
1048 max_eig, min_eig, occ_matrix, t1, t2, &
1049 trace_fx, trace_gx
1050 REAL(kind=dp), ALLOCATABLE, DIMENSION(:) :: alpha, lambda, nu, poly, wu, x, y
1051 TYPE(cp_logger_type), POINTER :: logger
1052 TYPE(dbcsr_type) :: matrix_tmp, matrix_x, matrix_xsq
1053
1054 CALL timeset(routinen, handle)
1055
1056 IF (PRESENT(iounit)) THEN
1057 unit_nr = iounit
1058 ELSE
1059 logger => cp_get_default_logger()
1060 IF (logger%para_env%is_source()) THEN
1061 unit_nr = cp_logger_get_default_unit_nr(logger, local=.true.)
1062 ELSE
1063 unit_nr = -1
1064 END IF
1065 END IF
1066
1067 do_non_monotonic = .false.
1068 IF (PRESENT(non_monotonic)) do_non_monotonic = non_monotonic
1069
1070 ! init X = (eps_n*I - H)/(eps_n - eps_0) ... H* = S^-1/2*H*S^-1/2
1071 CALL dbcsr_create(matrix_x, template=matrix_ks, matrix_type=dbcsr_type_no_symmetry)
1072 CALL dbcsr_create(matrix_xsq, template=matrix_ks, matrix_type=dbcsr_type_no_symmetry)
1073
1074 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_ks, &
1075 0.0_dp, matrix_xsq, filter_eps=threshold)
1076 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_xsq, matrix_s_sqrt_inv, &
1077 0.0_dp, matrix_x, filter_eps=threshold)
1078
1079 IF (unit_nr > 0) THEN
1080 WRITE (unit_nr, '(T6,A,1X,F12.5)') "HOMO upper bound: ", e_homo
1081 WRITE (unit_nr, '(T6,A,1X,F12.5)') "LUMO lower bound: ", e_lumo
1082 WRITE (unit_nr, '(T6,A,1X,L12)') "Predicts a gap ? ", ((e_lumo) - (e_homo)) > 0
1083 END IF
1084
1085 ! get largest/smallest eigenvalues for scaling
1086 CALL arnoldi_extremal(matrix_x, max_eig, min_eig, max_iter=max_iter_lanczos, threshold=eps_lanczos, &
1087 converged=converged)
1088 IF (unit_nr > 0) WRITE (unit_nr, '(T6,A,1X,2F12.5,1X,A,1X,L1)') "Est. extremal eigenvalues", &
1089 min_eig, max_eig, " converged: ", converged
1090
1091 eps_max = max_eig
1092 eps_min = min_eig
1093
1094 ! scale KS matrix
1095 CALL dbcsr_scale(matrix_x, -1.0_dp)
1096 CALL dbcsr_add_on_diag(matrix_x, eps_max)
1097 CALL dbcsr_scale(matrix_x, 1/(eps_max - eps_min))
1098
1099 CALL dbcsr_copy(matrix_xsq, matrix_x)
1100
1101 CALL dbcsr_create(matrix_tmp, template=matrix_ks, matrix_type=dbcsr_type_no_symmetry)
1102
1103 ALLOCATE (poly(max_iter))
1104 ALLOCATE (nu(max_iter))
1105 ALLOCATE (wu(max_iter))
1106 ALLOCATE (alpha(max_iter))
1107 ALLOCATE (x(4))
1108 ALLOCATE (y(4))
1109 ALLOCATE (lambda(4))
1110
1111! Controls over the non_monotonic bounds, First if low gap, bias slightly
1112 beta = (eps_max - abs(e_lumo))/(eps_max - eps_min)
1113 betab = (eps_max + abs(e_homo))/(eps_max - eps_min)
1114
1115 IF ((beta - betab) < 0.005_dp) THEN
1116 beta = beta - 0.002_dp
1117 betab = betab + 0.002_dp
1118 END IF
1119! Check if input specifies to use monotonic bounds.
1120 IF (.NOT. do_non_monotonic) THEN
1121 beta = 0.0_dp
1122 betab = 1.0_dp
1123 END IF
1124! initial SCF cycle has no reliable estimate of homo/lumo, force monotinic bounds.
1125 IF (e_homo == 0.0_dp) THEN
1126 beta = 0.0_dp
1127 betab = 1.0_dp
1128 END IF
1129
1130 ! init to take true branch first
1131 trace_fx = nelectron
1132 trace_gx = 0
1133
1134 DO i = 1, max_iter
1135 t1 = m_walltime()
1136 flop1 = 0; flop2 = 0
1137
1138 IF (abs(trace_fx - nelectron) <= abs(trace_gx - nelectron)) THEN
1139! Xn+1 = (aX+ (1-a)I)^2
1140 poly(i) = 1.0_dp
1141 alpha(i) = 2.0_dp/(2.0_dp - beta)
1142
1143 CALL dbcsr_scale(matrix_x, alpha(i))
1144 CALL dbcsr_add_on_diag(matrix_x, 1.0_dp - alpha(i))
1145 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_x, matrix_x, &
1146 0.0_dp, matrix_xsq, &
1147 filter_eps=threshold, flop=flop1)
1148
1149!save X for control variables
1150 CALL dbcsr_copy(matrix_tmp, matrix_x)
1151
1152 CALL dbcsr_copy(matrix_x, matrix_xsq)
1153
1154 beta = (1.0_dp - alpha(i)) + alpha(i)*beta
1155 beta = beta*beta
1156 betab = (1.0_dp - alpha(i)) + alpha(i)*betab
1157 betab = betab*betab
1158 ELSE
1159! Xn+1 = 2aX-a^2*X^2
1160 poly(i) = 0.0_dp
1161 alpha(i) = 2.0_dp/(1.0_dp + betab)
1162
1163 CALL dbcsr_scale(matrix_x, alpha(i))
1164 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_x, matrix_x, &
1165 0.0_dp, matrix_xsq, &
1166 filter_eps=threshold, flop=flop1)
1167
1168!save X for control variables
1169 CALL dbcsr_copy(matrix_tmp, matrix_x)
1170!
1171 CALL dbcsr_add(matrix_x, matrix_xsq, 2.0_dp, -1.0_dp)
1172
1173 beta = alpha(i)*beta
1174 beta = 2.0_dp*beta - beta*beta
1175 betab = alpha(i)*betab
1176 betab = 2.0_dp*betab - betab*betab
1177
1178 END IF
1179 occ_matrix = dbcsr_get_occupation(matrix_x)
1180 t2 = m_walltime()
1181 IF (unit_nr > 0) THEN
1182 WRITE (unit_nr, &
1183 '(T6,A,I3,1X,F10.8,E12.3,F12.3,F13.3,E12.3)') "TC2 it ", &
1184 i, occ_matrix, t2 - t1, &
1185 (flop1 + flop2)/(1.0e6_dp*(t2 - t1)), threshold
1186 CALL m_flush(unit_nr)
1187 END IF
1188
1189! calculate control terms
1190 CALL dbcsr_trace(matrix_xsq, trace_fx)
1191
1192! intermediate use matrix_xsq compute X- X*X , temorarily use trace_gx
1193 CALL dbcsr_add(matrix_xsq, matrix_tmp, -1.0_dp, 1.0_dp)
1194 CALL dbcsr_trace(matrix_xsq, trace_gx)
1195 nu(i) = dbcsr_frobenius_norm(matrix_xsq)
1196 wu(i) = trace_gx
1197
1198! intermediate use matrix_xsq to compute = 2X - X*X
1199 CALL dbcsr_add(matrix_xsq, matrix_tmp, 1.0_dp, 1.0_dp)
1200 CALL dbcsr_trace(matrix_xsq, trace_gx)
1201! TC2 has quadratic convergence, using the frobeniums norm as an idempotency deviation test.
1202 IF (abs(nu(i)) < (threshold)) EXIT
1203 END DO
1204
1205 occ_matrix = dbcsr_get_occupation(matrix_x)
1206 IF (unit_nr > 0) WRITE (unit_nr, '(T6,A,I3,1X,1F10.8,1X,1F10.8)') 'Final TC2 iteration ', i, occ_matrix, abs(nu(i))
1207
1208 ! output to matrix_p, P = inv(S)^0.5 X inv(S)^0.5
1209 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_x, matrix_s_sqrt_inv, &
1210 0.0_dp, matrix_tmp, filter_eps=threshold)
1211 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_s_sqrt_inv, matrix_tmp, &
1212 0.0_dp, matrix_p, filter_eps=threshold)
1213
1214 CALL dbcsr_release(matrix_xsq)
1215 CALL dbcsr_release(matrix_tmp)
1216
1217 ! ALGO 3 from. SIAM DOI. 10.1137/130911585
1218 x(1) = 1.0_dp
1219 x(2) = 1.0_dp
1220 x(3) = 0.0_dp
1221 x(4) = 0.0_dp
1222 gama = 6.0_dp - 4.0_dp*(sqrt(2.0_dp))
1223 gama = gama - gama*gama
1224 DO WHILE (nu(i) < gama)
1225 ! safeguard against negative root, is skipping correct?
1226 IF (wu(i) < 1.0e-14_dp) THEN
1227 i = i - 1
1228 cycle
1229 END IF
1230 IF ((1.0_dp - 4.0_dp*nu(i)*nu(i)/wu(i)) < 0.0_dp) THEN
1231 i = i - 1
1232 cycle
1233 END IF
1234 y(1) = 0.5_dp*(1.0_dp - sqrt(1.0_dp - 4.0_dp*nu(i)*nu(i)/wu(i)))
1235 y(2) = 0.5_dp*(1.0_dp - sqrt(1.0_dp - 4.0_dp*nu(i)))
1236 y(3) = 0.5_dp*(1.0_dp + sqrt(1.0_dp - 4.0_dp*nu(i)))
1237 y(4) = 0.5_dp*(1.0_dp + sqrt(1.0_dp - 4.0_dp*nu(i)*nu(i)/wu(i)))
1238 y(:) = min(1.0_dp, max(0.0_dp, y(:)))
1239 DO j = i, 1, -1
1240 IF (poly(j) == 1.0_dp) THEN
1241 DO k = 1, 4
1242 y(k) = sqrt(y(k))
1243 y(k) = (y(k) - 1.0_dp + alpha(j))/alpha(j)
1244 END DO ! end K
1245 ELSE
1246 DO k = 1, 4
1247 y(k) = 1.0_dp - sqrt(1.0_dp - y(k))
1248 y(k) = y(k)/alpha(j)
1249 END DO ! end K
1250 END IF ! end poly
1251 END DO ! end j
1252 x(1) = min(x(1), y(1))
1253 x(2) = min(x(2), y(2))
1254 x(3) = max(x(3), y(3))
1255 x(4) = max(x(4), y(4))
1256 i = i - 1
1257 END DO ! end i
1258! lambda 1,2,3,4 are:: out lumo, in lumo, in homo, out homo
1259 DO k = 1, 4
1260 lambda(k) = eps_max - (eps_max - eps_min)*x(k)
1261 END DO ! end k
1262! END ALGO 3 from. SIAM DOI. 10.1137/130911585
1263 e_homo = lambda(4)
1264 e_lumo = lambda(1)
1265 IF (unit_nr > 0) WRITE (unit_nr, '(T6,A,3E12.4)') "outer homo/lumo/gap", e_homo, e_lumo, (e_lumo - e_homo)
1266 IF (unit_nr > 0) WRITE (unit_nr, '(T6,A,3E12.4)') "inner homo/lumo/gap", lambda(3), lambda(2), (lambda(2) - lambda(3))
1267
1268 DEALLOCATE (poly)
1269 DEALLOCATE (nu)
1270 DEALLOCATE (wu)
1271 DEALLOCATE (alpha)
1272 DEALLOCATE (x)
1273 DEALLOCATE (y)
1274 DEALLOCATE (lambda)
1275
1276 CALL dbcsr_release(matrix_x)
1277 CALL timestop(handle)
1278
1279 END SUBROUTINE density_matrix_tc2
1280
1281! **************************************************************************************************
1282!> \brief compute the homo and lumo given a KS matrix and a density matrix in the orthonormalized basis
1283!> and the eps_min and eps_max, min and max eigenvalue of the ks matrix
1284!> \param matrix_k ...
1285!> \param matrix_p ...
1286!> \param eps_min ...
1287!> \param eps_max ...
1288!> \param threshold ...
1289!> \param max_iter_lanczos ...
1290!> \param eps_lanczos ...
1291!> \param homo ...
1292!> \param lumo ...
1293!> \param unit_nr ...
1294!> \par History
1295!> 2012.06 created [Florian Thoele]
1296!> \author Florian Thoele
1297! **************************************************************************************************
1298 SUBROUTINE compute_homo_lumo(matrix_k, matrix_p, eps_min, eps_max, threshold, max_iter_lanczos, eps_lanczos, homo, lumo, unit_nr)
1299 TYPE(dbcsr_type) :: matrix_k, matrix_p
1300 REAL(kind=dp) :: eps_min, eps_max, threshold
1301 INTEGER, INTENT(IN) :: max_iter_lanczos
1302 REAL(kind=dp), INTENT(IN) :: eps_lanczos
1303 REAL(kind=dp) :: homo, lumo
1304 INTEGER :: unit_nr
1305
1306 LOGICAL :: converged
1307 REAL(kind=dp) :: max_eig, min_eig, shift1, shift2
1308 TYPE(dbcsr_type) :: tmp1, tmp2, tmp3
1309
1310! temporary matrices used for HOMO/LUMO calculation
1311
1312 CALL dbcsr_create(tmp1, template=matrix_k, matrix_type=dbcsr_type_no_symmetry)
1313
1314 CALL dbcsr_create(tmp2, template=matrix_k, matrix_type=dbcsr_type_no_symmetry)
1315
1316 CALL dbcsr_create(tmp3, template=matrix_k, matrix_type=dbcsr_type_no_symmetry)
1317
1318 shift1 = -eps_min
1319 shift2 = eps_max
1320
1321 ! find largest ev of P*(K+shift*1), where shift is the neg. val. of the smallest ev of K
1322 CALL dbcsr_copy(tmp2, matrix_k)
1323 CALL dbcsr_add_on_diag(tmp2, shift1)
1324 CALL dbcsr_multiply("N", "N", 1.0_dp, matrix_p, tmp2, &
1325 0.0_dp, tmp1, filter_eps=threshold)
1326 CALL arnoldi_extremal(tmp1, max_eig, min_eig, converged=converged, &
1327 threshold=eps_lanczos, max_iter=max_iter_lanczos)
1328 homo = max_eig - shift1
1329 IF (unit_nr > 0) THEN
1330 WRITE (unit_nr, '(T6,A,1X,L12)') "Lanczos converged: ", converged
1331 END IF
1332
1333 ! -(1-P)*(K-shift*1) = (1-P)*(shift*1 - K), where shift is the largest ev of K
1334 CALL dbcsr_copy(tmp3, matrix_p)
1335 CALL dbcsr_scale(tmp3, -1.0_dp)
1336 CALL dbcsr_add_on_diag(tmp3, 1.0_dp) !tmp3 = 1-P
1337 CALL dbcsr_copy(tmp2, matrix_k)
1338 CALL dbcsr_add_on_diag(tmp2, -shift2)
1339 CALL dbcsr_multiply("N", "N", -1.0_dp, tmp3, tmp2, &
1340 0.0_dp, tmp1, filter_eps=threshold)
1341 CALL arnoldi_extremal(tmp1, max_eig, min_eig, converged=converged, &
1342 threshold=eps_lanczos, max_iter=max_iter_lanczos)
1343 lumo = -max_eig + shift2
1344
1345 IF (unit_nr > 0) THEN
1346 WRITE (unit_nr, '(T6,A,1X,L12)') "Lanczos converged: ", converged
1347 WRITE (unit_nr, '(T6,A,1X,3F12.5)') 'HOMO/LUMO/gap', homo, lumo, lumo - homo
1348 END IF
1349 CALL dbcsr_release(tmp1)
1350 CALL dbcsr_release(tmp2)
1351 CALL dbcsr_release(tmp3)
1352
1353 END SUBROUTINE compute_homo_lumo
1354
1355! **************************************************************************************************
1356!> \brief ...
1357!> \param x ...
1358!> \param gamma_values ...
1359!> \param i ...
1360!> \return ...
1361! **************************************************************************************************
1362 FUNCTION evaluate_trs4_polynomial(x, gamma_values, i) RESULT(xr)
1363 REAL(kind=dp) :: x
1364 REAL(kind=dp), DIMENSION(:) :: gamma_values
1365 INTEGER :: i
1366 REAL(kind=dp) :: xr
1367
1368 REAL(kind=dp), PARAMETER :: gam_max = 6.0_dp, gam_min = 0.0_dp
1369
1370 INTEGER :: k
1371
1372 xr = x
1373 DO k = 1, i
1374 IF (gamma_values(k) > gam_max) THEN
1375 xr = 2*xr - xr**2
1376 ELSE IF (gamma_values(k) < gam_min) THEN
1377 xr = xr**2
1378 ELSE
1379 xr = (xr*xr)*(4*xr - 3*xr*xr) + gamma_values(k)*xr*xr*((1 - xr)**2)
1380 END IF
1381 END DO
1382 END FUNCTION evaluate_trs4_polynomial
1383
1384! **************************************************************************************************
1385!> \brief ...
1386!> \param homo ...
1387!> \param lumo ...
1388!> \param threshold ...
1389!> \return ...
1390! **************************************************************************************************
1391 FUNCTION estimate_steps(homo, lumo, threshold) RESULT(steps)
1392 REAL(kind=dp) :: homo, lumo, threshold
1393 INTEGER :: steps
1394
1395 INTEGER :: i
1396 REAL(kind=dp) :: h, l, m
1397
1398 l = lumo
1399 h = homo
1400
1401 DO i = 1, 200
1402 IF (abs(l) < threshold .AND. abs(1 - h) < threshold) EXIT
1403 m = 0.5_dp*(h + l)
1404 IF (m > 0.5_dp) THEN
1405 h = h**2
1406 l = l**2
1407 ELSE
1408 h = 2*h - h**2
1409 l = 2*l - l**2
1410 END IF
1411 END DO
1412 steps = i - 1
1413 END FUNCTION estimate_steps
1414
1415END MODULE dm_ls_scf_methods
arnoldi iteration using dbcsr
Definition arnoldi_api.F:16
subroutine, public arnoldi_extremal(matrix_a, max_ev, min_ev, converged, threshold, max_iter)
simple wrapper to estimate extremal eigenvalues with arnoldi, using the old lanczos interface this hi...
subroutine, public dbcsr_scale(matrix, alpha_scalar)
...
subroutine, public dbcsr_iterator_next_block(iterator, row, column, block, block_number_argument_has_been_removed, row_size, col_size, row_offset, col_offset)
...
logical function, public dbcsr_iterator_blocks_left(iterator)
...
subroutine, public dbcsr_iterator_stop(iterator)
...
subroutine, public dbcsr_desymmetrize(matrix_a, matrix_b)
...
subroutine, public dbcsr_copy(matrix_b, matrix_a, name, keep_sparsity, keep_imaginary)
...
subroutine, public dbcsr_multiply(transa, transb, alpha, matrix_a, matrix_b, beta, matrix_c, first_row, last_row, first_column, last_column, first_k, last_k, retain_sparsity, filter_eps, flop)
...
subroutine, public dbcsr_filter(matrix, eps)
...
real(kind=dp) function, public dbcsr_get_occupation(matrix)
...
subroutine, public dbcsr_finalize(matrix)
...
subroutine, public dbcsr_iterator_start(iterator, matrix, shared, dynamic, dynamic_byrows)
...
subroutine, public dbcsr_set(matrix, alpha)
...
subroutine, public dbcsr_release(matrix)
...
subroutine, public dbcsr_put_block(matrix, row, col, block, summation)
...
subroutine, public dbcsr_add(matrix_a, matrix_b, alpha_scalar, beta_scalar)
...
subroutine, public dbcsr_add_on_diag(matrix, alpha)
Adds the given scalar to the diagonal of the matrix. Reserves any missing diagonal blocks.
subroutine, public dbcsr_trace(matrix, trace)
Computes the trace of the given matrix, also known as the sum of its diagonal elements.
real(dp) function, public dbcsr_frobenius_norm(matrix)
Compute the frobenius norm of a dbcsr matrix.
subroutine, public dbcsr_dot(matrix_a, matrix_b, trace)
Computes the dot product of two matrices, also known as the trace of their matrix product.
various routines to log and control the output. The idea is that decisions about where to log should ...
recursive integer function, public cp_logger_get_default_unit_nr(logger, local, skip_not_ionode)
asks the default unit number of the given logger. try to use cp_logger_get_unit_nr
type(cp_logger_type) function, pointer, public cp_get_default_logger()
returns the default logger
lower level routines for linear scaling SCF
subroutine, public density_matrix_trs4(matrix_p, matrix_ks, matrix_s_sqrt_inv, nelectron, threshold, e_homo, e_lumo, e_mu, dynamic_threshold, matrix_ks_deviation, max_iter_lanczos, eps_lanczos, converged, iounit)
compute the density matrix using a trace-resetting algorithm
subroutine, public ls_scf_init_matrix_s(matrix_s, ls_scf_env)
initialize S matrix related properties (sqrt, inverse...) Might be factored-out since this seems comm...
subroutine, public density_matrix_sign_fixed_mu(matrix_p, trace, mu, sign_method, sign_order, matrix_ks, matrix_s, matrix_s_inv, threshold, sign_symmetric, submatrix_sign_method, matrix_s_sqrt_inv)
for a fixed mu, compute the corresponding density matrix and its trace
subroutine, public apply_matrix_preconditioner(matrix, direction, matrix_bs_sqrt, matrix_bs_sqrt_inv)
apply a preconditioner either forward (precondition) inv(sqrt(bs)) * A * inv(sqrt(bs)) backward (rest...
subroutine, public density_matrix_sign(matrix_p, mu, fixed_mu, sign_method, sign_order, matrix_ks, matrix_s, matrix_s_inv, nelectron, threshold, sign_symmetric, submatrix_sign_method, matrix_s_sqrt_inv)
compute the density matrix with a trace that is close to nelectron. take a mu as input,...
subroutine, public compute_matrix_preconditioner(matrix_s, preconditioner_type, ls_mstruct, matrix_bs_sqrt, matrix_bs_sqrt_inv, threshold, order, eps_lanczos, max_iter_lanczos)
compute for a block positive definite matrix s (bs) the sqrt(bs) and inv(sqrt(bs))
subroutine, public density_matrix_tc2(matrix_p, matrix_ks, matrix_s_sqrt_inv, nelectron, threshold, e_homo, e_lumo, non_monotonic, eps_lanczos, max_iter_lanczos, iounit)
compute the density matrix using a non monotonic trace conserving algorithm based on SIAM DOI....
subroutine, public compute_homo_lumo(matrix_k, matrix_p, eps_min, eps_max, threshold, max_iter_lanczos, eps_lanczos, homo, lumo, unit_nr)
compute the homo and lumo given a KS matrix and a density matrix in the orthonormalized basis and the...
Routines for a linear scaling quickstep SCF run based on the density matrix, with a focus on the inte...
subroutine, public matrix_qs_to_ls(matrix_ls, matrix_qs, ls_mstruct, covariant)
first link to QS, copy a QS matrix to LS matrix used to isolate QS style matrices from LS style will ...
Types needed for a linear scaling quickstep SCF run based on the density matrix.
collects all constants needed in input so that they can be used without circular dependencies
integer, parameter, public ls_scf_submatrix_sign_direct_muadj
integer, parameter, public ls_s_preconditioner_molecular
integer, parameter, public ls_s_preconditioner_atomic
integer, parameter, public ls_scf_sign_submatrix
integer, parameter, public ls_s_sqrt_proot
integer, parameter, public ls_s_sqrt_ns
integer, parameter, public ls_s_preconditioner_none
integer, parameter, public ls_scf_sign_proot
integer, parameter, public ls_scf_submatrix_sign_ns
integer, parameter, public ls_scf_sign_ns
integer, parameter, public ls_scf_submatrix_sign_direct_muadj_lowmem
integer, parameter, public ls_cluster_atomic
Routines useful for iterative matrix calculations.
subroutine, public matrix_sign_newton_schulz(matrix_sign, matrix, threshold, sign_order, iounit)
compute the sign a matrix using Newton-Schulz iterations
subroutine, public matrix_sign_submatrix(matrix_sign, matrix, threshold, sign_order, submatrix_sign_method)
Submatrix method.
subroutine, public matrix_sign_submatrix_mu_adjust(matrix_sign, matrix, mu, nelectron, threshold, variant)
Submatrix method with internal adjustment of chemical potential.
subroutine, public invert_hotelling(matrix_inverse, matrix, threshold, use_inv_as_guess, norm_convergence, filter_eps, accelerator_order, max_iter_lanczos, eps_lanczos, silent)
invert a symmetric positive definite matrix by Hotelling's method explicit symmetrization makes this ...
subroutine, public matrix_sign_proot(matrix_sign, matrix, threshold, sign_order)
compute the sign a matrix using the general algorithm for the p-th root of Richters et al....
subroutine, public matrix_sqrt_newton_schulz(matrix_sqrt, matrix_sqrt_inv, matrix, threshold, order, eps_lanczos, max_iter_lanczos, symmetrize, converged, iounit)
compute the sqrt of a matrix via the sign function and the corresponding Newton-Schulz iterations the...
subroutine, public matrix_sqrt_proot(matrix_sqrt, matrix_sqrt_inv, matrix, threshold, order, eps_lanczos, max_iter_lanczos, symmetrize, converged)
compute the sqrt of a matrix via the general algorithm for the p-th root of Richters et al....
Defines the basic variable types.
Definition kinds.F:23
integer, parameter, public int_8
Definition kinds.F:54
integer, parameter, public dp
Definition kinds.F:34
Machine interface based on Fortran 2003 and POSIX.
Definition machine.F:17
subroutine, public m_flush(lunit)
flushes units if the &GLOBAL flag is set accordingly
Definition machine.F:131
real(kind=dp) function, public m_walltime()
returns time from a real-time clock, protected against rolling early/easily
Definition machine.F:148
Collection of simple mathematical functions and subroutines.
Definition mathlib.F:15
logical function, public abnormal_value(a)
determines if a value is not normal (e.g. for Inf and Nan) based on IO to work also under optimizatio...
Definition mathlib.F:151
type of a logger, at the moment it contains just a print level starting at which level it should be l...