(git:ada2ee8)
Loading...
Searching...
No Matches
pao_io.F
Go to the documentation of this file.
1!--------------------------------------------------------------------------------------------------!
2! CP2K: A general program to perform molecular dynamics simulations !
3! Copyright 2000-2026 CP2K developers group <https://cp2k.org> !
4! !
5! SPDX-License-Identifier: GPL-2.0-or-later !
6!--------------------------------------------------------------------------------------------------!
7
8! **************************************************************************************************
9!> \brief Routines for reading and writing restart files.
10!> \author Ole Schuett
11! **************************************************************************************************
12MODULE pao_io
16 USE cell_types, ONLY: cell_type
17 USE cp_dbcsr_api, ONLY: &
19 dbcsr_csr_dbcsr_blkrow_dist, dbcsr_csr_destroy, dbcsr_csr_type, dbcsr_csr_write, &
22 USE cp_files, ONLY: close_file,&
27 USE cp_output_handling, ONLY: cp_p_file,&
35 USE kinds, ONLY: default_path_length,&
37 dp
39 USE pao_input, ONLY: id2str
40 USE pao_param, ONLY: pao_param_count
41 USE pao_types, ONLY: pao_env_type
43 USE physcon, ONLY: angstrom
46 USE qs_kind_types, ONLY: get_qs_kind,&
49#include "./base/base_uses.f90"
50
51 IMPLICIT NONE
52
53 PRIVATE
54
55 CHARACTER(len=*), PARAMETER, PRIVATE :: moduleN = 'pao_io'
56
62
63 ! data types used by pao_read_raw()
65 REAL(dp), DIMENSION(:, :), ALLOCATABLE :: p
66 END TYPE pao_ioblock_type
67
69 CHARACTER(LEN=default_string_length) :: name = ""
70 INTEGER :: z = -1
71 CHARACTER(LEN=default_string_length) :: prim_basis_name = ""
72 INTEGER :: prim_basis_size = -1
73 INTEGER :: pao_basis_size = -1
74 INTEGER :: nparams = -1
75 TYPE(pao_potential_type), ALLOCATABLE, DIMENSION(:) :: pao_potentials
76 END TYPE pao_iokind_type
77
78 INTEGER, PARAMETER, PRIVATE :: file_format_version = 4
79
80CONTAINS
81
82! **************************************************************************************************
83!> \brief Reads restart file
84!> \param pao ...
85!> \param qs_env ...
86! **************************************************************************************************
87 SUBROUTINE pao_read_restart(pao, qs_env)
88 TYPE(pao_env_type), POINTER :: pao
89 TYPE(qs_environment_type), POINTER :: qs_env
90
91 CHARACTER(LEN=default_string_length) :: param
92 INTEGER :: iatom, ikind, natoms
93 INTEGER, ALLOCATABLE, DIMENSION(:) :: atom2kind
94 INTEGER, DIMENSION(:), POINTER :: col_blk_sizes, row_blk_sizes
95 LOGICAL :: found
96 REAL(dp) :: diff
97 REAL(dp), ALLOCATABLE, DIMENSION(:, :) :: hmat, positions
98 REAL(dp), DIMENSION(:, :), POINTER :: block_x, buffer
99 TYPE(cell_type), POINTER :: cell
100 TYPE(mp_para_env_type), POINTER :: para_env
101 TYPE(pao_ioblock_type), ALLOCATABLE, DIMENSION(:) :: xblocks
102 TYPE(pao_iokind_type), ALLOCATABLE, DIMENSION(:) :: kinds
103 TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
104
105 cpassert(len_trim(pao%restart_file) > 0)
106 IF (pao%iw > 0) WRITE (pao%iw, '(A,A)') " PAO| Reading matrix_X from restart file: ", trim(pao%restart_file)
107
108 CALL get_qs_env(qs_env, &
109 para_env=para_env, &
110 natom=natoms, &
111 cell=cell, &
112 particle_set=particle_set)
113
114 ! read and check restart file on first rank only
115 IF (para_env%is_source()) THEN
116 CALL pao_read_raw(pao%restart_file, param, hmat, kinds, atom2kind, positions, xblocks)
117
118 ! check cell
119 IF (maxval(abs(hmat - cell%hmat)) > 1e-10) THEN
120 cpwarn("Restarting from different cell")
121 END IF
122
123 ! check parametrization
124 IF (trim(param) /= trim(adjustl(id2str(pao%parameterization)))) &
125 cpabort("Restart PAO parametrization does not match")
126
127 ! check kinds
128 DO ikind = 1, SIZE(kinds)
129 CALL pao_kinds_ensure_equal(pao, qs_env, ikind, kinds(ikind))
130 END DO
131
132 ! check number of atoms
133 IF (SIZE(positions, 1) /= natoms) &
134 cpabort("Number of atoms do not match")
135
136 ! check atom2kind
137 DO iatom = 1, natoms
138 IF (atom2kind(iatom) /= particle_set(iatom)%atomic_kind%kind_number) &
139 cpabort("Restart atomic kinds do not match.")
140 END DO
141
142 ! check positions, warning only
143 diff = 0.0_dp
144 DO iatom = 1, natoms
145 diff = max(diff, maxval(abs(positions(iatom, :) - particle_set(iatom)%r)))
146 END DO
147 cpwarn_if(diff > 1e-10, "Restarting from different atom positions")
148
149 END IF
150
151 ! scatter xblocks across ranks to fill pao%matrix_X
152 ! this could probably be done more efficiently
153 CALL dbcsr_get_info(pao%matrix_X, row_blk_size=row_blk_sizes, col_blk_size=col_blk_sizes)
154 DO iatom = 1, natoms
155 ALLOCATE (buffer(row_blk_sizes(iatom), col_blk_sizes(iatom)))
156 IF (para_env%is_source()) THEN
157 cpassert(row_blk_sizes(iatom) == SIZE(xblocks(iatom)%p, 1))
158 cpassert(col_blk_sizes(iatom) == SIZE(xblocks(iatom)%p, 2))
159 buffer = xblocks(iatom)%p
160 END IF
161 CALL para_env%bcast(buffer)
162 CALL dbcsr_get_block_p(matrix=pao%matrix_X, row=iatom, col=iatom, block=block_x, found=found)
163 IF (ASSOCIATED(block_x)) &
164 block_x = buffer
165 DEALLOCATE (buffer)
166 END DO
167
168 ! ALLOCATABLEs deallocate themselves
169
170 END SUBROUTINE pao_read_restart
171
172! **************************************************************************************************
173!> \brief Reads a restart file into temporary datastructures
174!> \param filename ...
175!> \param param ...
176!> \param hmat ...
177!> \param kinds ...
178!> \param atom2kind ...
179!> \param positions ...
180!> \param xblocks ...
181!> \param ml_range ...
182! **************************************************************************************************
183 SUBROUTINE pao_read_raw(filename, param, hmat, kinds, atom2kind, positions, xblocks, ml_range)
184 CHARACTER(LEN=default_path_length), INTENT(IN) :: filename
185 CHARACTER(LEN=default_string_length), INTENT(OUT) :: param
186 REAL(dp), ALLOCATABLE, DIMENSION(:, :) :: hmat
187 TYPE(pao_iokind_type), ALLOCATABLE, DIMENSION(:) :: kinds
188 INTEGER, ALLOCATABLE, DIMENSION(:) :: atom2kind
189 REAL(dp), ALLOCATABLE, DIMENSION(:, :) :: positions
190 TYPE(pao_ioblock_type), ALLOCATABLE, DIMENSION(:) :: xblocks
191 INTEGER, DIMENSION(2), INTENT(OUT), OPTIONAL :: ml_range
192
193 CHARACTER(LEN=default_string_length) :: label, str_in
194 INTEGER :: i1, i2, iatom, ikind, ipot, natoms, &
195 nkinds, nparams, unit_nr, xblocks_read
196 REAL(dp) :: r1, r2
197 REAL(dp), DIMENSION(3) :: pos_in
198 REAL(dp), DIMENSION(3, 3) :: hmat_angstrom
199
200 cpassert(.NOT. ALLOCATED(hmat))
201 cpassert(.NOT. ALLOCATED(kinds))
202 cpassert(.NOT. ALLOCATED(atom2kind))
203 cpassert(.NOT. ALLOCATED(positions))
204 cpassert(.NOT. ALLOCATED(xblocks))
205
206 natoms = -1
207 nkinds = -1
208 xblocks_read = 0
209
210 CALL open_file(file_name=filename, file_status="OLD", file_form="FORMATTED", &
211 file_action="READ", unit_number=unit_nr)
212
213 ! check if file starts with proper header !TODO: introduce a more unique header
214 READ (unit_nr, fmt=*) label, i1
215 IF (trim(label) /= "Version") &
216 cpabort("PAO restart file appears to be corrupted.")
217 IF (i1 /= file_format_version) cpabort("Restart PAO file format version is wrong")
218
219 DO WHILE (.true.)
220 READ (unit_nr, fmt=*) label
221 backspace(unit_nr)
222
223 IF (trim(label) == "Parametrization") THEN
224 READ (unit_nr, fmt=*) label, str_in
225 param = str_in
226
227 ELSE IF (trim(label) == "Cell") THEN
228 READ (unit_nr, fmt=*) label, hmat_angstrom
229 ALLOCATE (hmat(3, 3))
230 hmat(:, :) = hmat_angstrom(:, :)/angstrom
231
232 ELSE IF (trim(label) == "Nkinds") THEN
233 READ (unit_nr, fmt=*) label, nkinds
234 ALLOCATE (kinds(nkinds))
235
236 ELSE IF (trim(label) == "Kind") THEN
237 READ (unit_nr, fmt=*) label, ikind, str_in, i1
238 cpassert(ALLOCATED(kinds))
239 kinds(ikind)%name = str_in
240 kinds(ikind)%z = i1
241
242 ELSE IF (trim(label) == "PrimBasis") THEN
243 READ (unit_nr, fmt=*) label, ikind, i1, str_in
244 cpassert(ALLOCATED(kinds))
245 kinds(ikind)%prim_basis_size = i1
246 kinds(ikind)%prim_basis_name = str_in
247
248 ELSE IF (trim(label) == "PaoBasis") THEN
249 READ (unit_nr, fmt=*) label, ikind, i1
250 cpassert(ALLOCATED(kinds))
251 kinds(ikind)%pao_basis_size = i1
252
253 ELSE IF (trim(label) == "NPaoPotentials") THEN
254 READ (unit_nr, fmt=*) label, ikind, i1
255 cpassert(ALLOCATED(kinds))
256 ALLOCATE (kinds(ikind)%pao_potentials(i1))
257
258 ELSE IF (trim(label) == "PaoPotential") THEN
259 READ (unit_nr, fmt=*) label, ikind, ipot, i1, i2, r1, r2
260 cpassert(ALLOCATED(kinds(ikind)%pao_potentials))
261 kinds(ikind)%pao_potentials(ipot)%maxl = i1
262 kinds(ikind)%pao_potentials(ipot)%max_projector = i2
263 kinds(ikind)%pao_potentials(ipot)%beta = r1
264 kinds(ikind)%pao_potentials(ipot)%weight = r2
265
266 ELSE IF (trim(label) == "NParams") THEN
267 READ (unit_nr, fmt=*) label, ikind, i1
268 cpassert(ALLOCATED(kinds))
269 kinds(ikind)%nparams = i1
270
271 ELSE IF (trim(label) == "Natoms") THEN
272 READ (unit_nr, fmt=*) label, natoms
273 ALLOCATE (positions(natoms, 3), atom2kind(natoms), xblocks(natoms))
274 positions = 0.0_dp; atom2kind = -1
275 IF (PRESENT(ml_range)) ml_range = [1, natoms]
276
277 ELSE IF (trim(label) == "MLRange") THEN
278 ! Natoms entry has to come first
279 cpassert(natoms > 0)
280 ! range of atoms whose xblocks are used for machine learning
281 READ (unit_nr, fmt=*) label, i1, i2
282 IF (PRESENT(ml_range)) ml_range = [i1, i2]
283
284 ELSE IF (trim(label) == "Atom") THEN
285 READ (unit_nr, fmt=*) label, iatom, str_in, pos_in
286 cpassert(ALLOCATED(kinds))
287 DO ikind = 1, nkinds
288 IF (trim(kinds(ikind)%name) == trim(str_in)) EXIT
289 END DO
290 cpassert(ALLOCATED(atom2kind) .AND. ALLOCATED(positions))
291 atom2kind(iatom) = ikind
292 positions(iatom, :) = pos_in/angstrom
293
294 ELSE IF (trim(label) == "Xblock") THEN
295 READ (unit_nr, fmt=*) label, iatom
296 cpassert(ALLOCATED(kinds) .AND. ALLOCATED(atom2kind))
297 ikind = atom2kind(iatom)
298 nparams = kinds(ikind)%nparams
299 cpassert(nparams >= 0)
300 ALLOCATE (xblocks(iatom)%p(nparams, 1))
301 backspace(unit_nr)
302 READ (unit_nr, fmt=*) label, iatom, xblocks(iatom)%p
303 xblocks_read = xblocks_read + 1
304 cpassert(iatom == xblocks_read) ! ensure blocks are read in order
305
306 ELSE IF (trim(label) == "THE_END") THEN
307 EXIT
308 ELSE
309 !CPWARN("Skipping restart header with label: "//TRIM(label))
310 READ (unit_nr, fmt=*) label ! just read again and ignore
311 END IF
312 END DO
313 CALL close_file(unit_number=unit_nr)
314
315 cpassert(xblocks_read == natoms) ! ensure we read all blocks
316
317 END SUBROUTINE pao_read_raw
318
319! **************************************************************************************************
320!> \brief Ensure that the kind read from the restart is equal to the kind curretly in use.
321!> \param pao ...
322!> \param qs_env ...
323!> \param ikind ...
324!> \param pao_kind ...
325! **************************************************************************************************
326 SUBROUTINE pao_kinds_ensure_equal(pao, qs_env, ikind, pao_kind)
327 TYPE(pao_env_type), POINTER :: pao
328 TYPE(qs_environment_type), POINTER :: qs_env
329 INTEGER, INTENT(IN) :: ikind
330 TYPE(pao_iokind_type), INTENT(IN) :: pao_kind
331
332 CHARACTER(LEN=default_string_length) :: name
333 INTEGER :: ipot, nparams, pao_basis_size, z
334 TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
335 TYPE(gto_basis_set_type), POINTER :: basis_set
336 TYPE(pao_potential_type), DIMENSION(:), POINTER :: pao_potentials
337 TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
338
339 CALL get_qs_env(qs_env, &
340 atomic_kind_set=atomic_kind_set, &
341 qs_kind_set=qs_kind_set)
342
343 IF (ikind > SIZE(atomic_kind_set) .OR. ikind > SIZE(qs_kind_set)) &
344 cpabort("Some kinds are missing.")
345
346 CALL get_atomic_kind(atomic_kind_set(ikind), z=z, name=name)
347 CALL get_qs_kind(qs_kind_set(ikind), &
348 basis_set=basis_set, &
349 pao_basis_size=pao_basis_size, &
351 CALL pao_param_count(pao, qs_env, ikind=ikind, nparams=nparams)
352
353 IF (pao_kind%nparams /= nparams) &
354 cpabort("Number of parameters do not match")
355 IF (trim(pao_kind%name) /= trim(name)) &
356 cpabort("Kind names do not match")
357 IF (pao_kind%z /= z) &
358 cpabort("Atomic numbers do not match")
359 IF (trim(pao_kind%prim_basis_name) /= trim(basis_set%name)) &
360 cpabort("Primary Basis-set name does not match")
361 IF (pao_kind%prim_basis_size /= basis_set%nsgf) &
362 cpabort("Primary Basis-set size does not match")
363 IF (pao_kind%pao_basis_size /= pao_basis_size) &
364 cpabort("PAO basis size does not match")
365 IF (SIZE(pao_kind%pao_potentials) /= SIZE(pao_potentials)) &
366 cpabort("Number of PAO_POTENTIALS does not match")
367
368 DO ipot = 1, SIZE(pao_potentials)
369 IF (pao_kind%pao_potentials(ipot)%maxl /= pao_potentials(ipot)%maxl) THEN
370 cpabort("PAO_POT_MAXL does not match")
371 END IF
372 IF (pao_kind%pao_potentials(ipot)%max_projector /= pao_potentials(ipot)%max_projector) THEN
373 cpabort("PAO_POT_MAX_PROJECTOR does not match")
374 END IF
375 IF (pao_kind%pao_potentials(ipot)%beta /= pao_potentials(ipot)%beta) THEN
376 cpwarn("PAO_POT_BETA does not match")
377 END IF
378 IF (pao_kind%pao_potentials(ipot)%weight /= pao_potentials(ipot)%weight) THEN
379 cpwarn("PAO_POT_WEIGHT does not match")
380 END IF
381 END DO
382
383 END SUBROUTINE pao_kinds_ensure_equal
384
385! **************************************************************************************************
386!> \brief Writes restart file
387!> \param pao ...
388!> \param qs_env ...
389!> \param energy ...
390! **************************************************************************************************
391 SUBROUTINE pao_write_restart(pao, qs_env, energy)
392 TYPE(pao_env_type), POINTER :: pao
393 TYPE(qs_environment_type), POINTER :: qs_env
394 REAL(dp) :: energy
395
396 CHARACTER(len=*), PARAMETER :: printkey_section = 'DFT%LS_SCF%PAO%PRINT%RESTART', &
397 routinen = 'pao_write_restart'
398
399 INTEGER :: handle, unit_max, unit_nr
400 TYPE(cp_logger_type), POINTER :: logger
401 TYPE(mp_para_env_type), POINTER :: para_env
402 TYPE(section_vals_type), POINTER :: input
403
404 CALL timeset(routinen, handle)
405 logger => cp_get_default_logger()
406
407 CALL get_qs_env(qs_env, input=input, para_env=para_env)
408
409 ! open file
410 unit_nr = cp_print_key_unit_nr(logger, &
411 input, &
412 printkey_section, &
413 extension=".pao", &
414 file_action="WRITE", &
415 file_position="REWIND", &
416 file_status="UNKNOWN", &
417 do_backup=.true.)
418
419 ! although just rank-0 writes the trajectory it requires collective MPI calls
420 unit_max = unit_nr
421 CALL para_env%max(unit_max)
422 IF (unit_max > 0) THEN
423 IF (pao%iw > 0) WRITE (pao%iw, '(A,A)') " PAO| Writing restart file."
424 IF (unit_nr > 0) &
425 CALL write_restart_header(pao, qs_env, energy, unit_nr)
426
427 CALL pao_write_diagonal_blocks(para_env, pao%matrix_X, "Xblock", unit_nr)
428
429 END IF
430
431 ! close file
432 IF (unit_nr > 0) WRITE (unit_nr, '(A)') "THE_END"
433 CALL cp_print_key_finished_output(unit_nr, logger, input, printkey_section)
434
435 CALL timestop(handle)
436 END SUBROUTINE pao_write_restart
437
438! **************************************************************************************************
439!> \brief Write the digonal blocks of given DBCSR matrix into the provided unit_nr
440!> \param para_env ...
441!> \param matrix ...
442!> \param label ...
443!> \param unit_nr ...
444! **************************************************************************************************
445 SUBROUTINE pao_write_diagonal_blocks(para_env, matrix, label, unit_nr)
446 TYPE(mp_para_env_type), POINTER :: para_env
447 TYPE(dbcsr_type) :: matrix
448 CHARACTER(LEN=*), INTENT(IN) :: label
449 INTEGER, INTENT(IN) :: unit_nr
450
451 INTEGER :: iatom, natoms
452 INTEGER, DIMENSION(:), POINTER :: col_blk_sizes, row_blk_sizes
453 LOGICAL :: found
454 REAL(dp), DIMENSION(:, :), POINTER :: local_block, mpi_buffer
455
456 !TODO: this is a serial algorithm
457 CALL dbcsr_get_info(matrix, row_blk_size=row_blk_sizes, col_blk_size=col_blk_sizes)
458 cpassert(SIZE(row_blk_sizes) == SIZE(col_blk_sizes))
459 natoms = SIZE(row_blk_sizes)
460
461 DO iatom = 1, natoms
462 ALLOCATE (mpi_buffer(row_blk_sizes(iatom), col_blk_sizes(iatom)))
463 NULLIFY (local_block)
464 CALL dbcsr_get_block_p(matrix=matrix, row=iatom, col=iatom, block=local_block, found=found)
465 IF (ASSOCIATED(local_block)) THEN
466 IF (SIZE(local_block) > 0) & ! catch corner-case
467 mpi_buffer(:, :) = local_block(:, :)
468 ELSE
469 mpi_buffer(:, :) = 0.0_dp
470 END IF
471
472 CALL para_env%sum(mpi_buffer)
473 IF (unit_nr > 0) THEN
474 WRITE (unit_nr, fmt="(A,1X,I10,1X)", advance='no') label, iatom
475 WRITE (unit_nr, *) mpi_buffer
476 END IF
477 DEALLOCATE (mpi_buffer)
478 END DO
479
480 ! flush
481 IF (unit_nr > 0) FLUSH (unit_nr)
482
483 END SUBROUTINE pao_write_diagonal_blocks
484
485! **************************************************************************************************
486!> \brief Writes header of restart file
487!> \param pao ...
488!> \param qs_env ...
489!> \param energy ...
490!> \param unit_nr ...
491! **************************************************************************************************
492 SUBROUTINE write_restart_header(pao, qs_env, energy, unit_nr)
493 TYPE(pao_env_type), POINTER :: pao
494 TYPE(qs_environment_type), POINTER :: qs_env
495 REAL(dp) :: energy
496 INTEGER, INTENT(IN) :: unit_nr
497
498 CHARACTER(LEN=default_string_length) :: kindname
499 INTEGER :: iatom, ikind, ipot, nparams, &
500 pao_basis_size, z
501 TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
502 TYPE(cell_type), POINTER :: cell
503 TYPE(gto_basis_set_type), POINTER :: basis_set
504 TYPE(pao_potential_type), DIMENSION(:), POINTER :: pao_potentials
505 TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
506 TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
507
508 CALL get_qs_env(qs_env, &
509 cell=cell, &
510 particle_set=particle_set, &
511 atomic_kind_set=atomic_kind_set, &
512 qs_kind_set=qs_kind_set)
513
514 WRITE (unit_nr, "(A,5X,I0)") "Version", file_format_version
515 WRITE (unit_nr, "(A,5X,F20.10)") "Energy", energy
516 WRITE (unit_nr, "(A,5X,I0)") "Step", pao%istep
517 WRITE (unit_nr, "(A,5X,A)") "Parametrization", id2str(pao%parameterization)
518
519 ! write kinds
520 WRITE (unit_nr, "(A,5X,I0)") "Nkinds", SIZE(atomic_kind_set)
521 DO ikind = 1, SIZE(atomic_kind_set)
522 CALL get_atomic_kind(atomic_kind_set(ikind), name=kindname, z=z)
523 CALL get_qs_kind(qs_kind_set(ikind), &
524 pao_basis_size=pao_basis_size, &
526 basis_set=basis_set)
527 CALL pao_param_count(pao, qs_env, ikind, nparams)
528 WRITE (unit_nr, "(A,5X,I10,1X,A,1X,I3)") "Kind", ikind, trim(kindname), z
529 WRITE (unit_nr, "(A,5X,I10,1X,I3)") "NParams", ikind, nparams
530 WRITE (unit_nr, "(A,5X,I10,1X,I10,1X,A)") "PrimBasis", ikind, basis_set%nsgf, trim(basis_set%name)
531 WRITE (unit_nr, "(A,5X,I10,1X,I3)") "PaoBasis", ikind, pao_basis_size
532 WRITE (unit_nr, "(A,5X,I10,1X,I3)") "NPaoPotentials", ikind, SIZE(pao_potentials)
533 DO ipot = 1, SIZE(pao_potentials)
534 WRITE (unit_nr, "(A,5X,I10,1X,I3)", advance='no') "PaoPotential", ikind, ipot
535 WRITE (unit_nr, "(1X,I3)", advance='no') pao_potentials(ipot)%maxl
536 WRITE (unit_nr, "(1X,I3)", advance='no') pao_potentials(ipot)%max_projector
537 WRITE (unit_nr, "(1X,F20.16)", advance='no') pao_potentials(ipot)%beta
538 WRITE (unit_nr, "(1X,F20.16)") pao_potentials(ipot)%weight
539 END DO
540 END DO
541
542 ! write cell
543 WRITE (unit_nr, fmt="(A,5X)", advance='no') "Cell"
544 WRITE (unit_nr, *) cell%hmat*angstrom
545
546 ! write atoms
547 WRITE (unit_nr, "(A,5X,I0)") "Natoms", SIZE(particle_set)
548 DO iatom = 1, SIZE(particle_set)
549 kindname = particle_set(iatom)%atomic_kind%name
550 WRITE (unit_nr, fmt="(A,5X,I10,5X,A,1X)", advance='no') "Atom ", iatom, trim(kindname)
551 WRITE (unit_nr, *) particle_set(iatom)%r*angstrom
552 END DO
553
554 END SUBROUTINE write_restart_header
555
556!**************************************************************************************************
557!> \brief writing the KS matrix (in terms of the PAO basis) in csr format into a file
558!> \param qs_env qs environment
559!> \param ls_scf_env ls environment
560!> \author Mohammad Hossein Bani-Hashemian
561! **************************************************************************************************
562 SUBROUTINE pao_write_ks_matrix_csr(qs_env, ls_scf_env)
563 TYPE(qs_environment_type), POINTER :: qs_env
564 TYPE(ls_scf_env_type), TARGET :: ls_scf_env
565
566 CHARACTER(len=*), PARAMETER :: routinen = 'pao_write_ks_matrix_csr'
567
568 CHARACTER(LEN=default_path_length) :: file_name, fileformat
569 INTEGER :: handle, ispin, output_unit, unit_nr
570 LOGICAL :: bin, do_kpoints, do_ks_csr_write, uptr
571 REAL(kind=dp) :: thld
572 TYPE(cp_logger_type), POINTER :: logger
573 TYPE(dbcsr_csr_type) :: ks_mat_csr
574 TYPE(dbcsr_type) :: matrix_ks_nosym
575 TYPE(section_vals_type), POINTER :: dft_section, input
576
577 CALL timeset(routinen, handle)
578
579 NULLIFY (dft_section)
580
581 logger => cp_get_default_logger()
582 output_unit = cp_logger_get_default_io_unit(logger)
583
584 CALL get_qs_env(qs_env, input=input)
585 dft_section => section_vals_get_subs_vals(input, "DFT")
586 do_ks_csr_write = btest(cp_print_key_should_output(logger%iter_info, dft_section, &
587 "PRINT%KS_CSR_WRITE"), cp_p_file)
588
589 ! NOTE: k-points has to be treated differently later. k-points has KS matrix as double pointer.
590 CALL get_qs_env(qs_env=qs_env, do_kpoints=do_kpoints)
591
592 IF (do_ks_csr_write .AND. (.NOT. do_kpoints)) THEN
593 CALL section_vals_val_get(dft_section, "PRINT%KS_CSR_WRITE%THRESHOLD", r_val=thld)
594 CALL section_vals_val_get(dft_section, "PRINT%KS_CSR_WRITE%UPPER_TRIANGULAR", l_val=uptr)
595 CALL section_vals_val_get(dft_section, "PRINT%KS_CSR_WRITE%BINARY", l_val=bin)
596
597 IF (bin) THEN
598 fileformat = "UNFORMATTED"
599 ELSE
600 fileformat = "FORMATTED"
601 END IF
602
603 DO ispin = 1, SIZE(ls_scf_env%matrix_ks)
604
605 IF (dbcsr_has_symmetry(ls_scf_env%matrix_ks(ispin))) THEN
606 CALL dbcsr_desymmetrize(ls_scf_env%matrix_ks(ispin), matrix_ks_nosym)
607 ELSE
608 CALL dbcsr_copy(matrix_ks_nosym, ls_scf_env%matrix_ks(ispin))
609 END IF
610
611 CALL dbcsr_csr_create_from_dbcsr(matrix_ks_nosym, ks_mat_csr, dbcsr_csr_dbcsr_blkrow_dist)
612 CALL dbcsr_convert_dbcsr_to_csr(matrix_ks_nosym, ks_mat_csr)
613
614 WRITE (file_name, '(A,I0)') "PAO_KS_SPIN_", ispin
615 unit_nr = cp_print_key_unit_nr(logger, dft_section, "PRINT%KS_CSR_WRITE", &
616 extension=".csr", middle_name=trim(file_name), &
617 file_status="REPLACE", file_form=fileformat)
618 CALL dbcsr_csr_write(ks_mat_csr, unit_nr, upper_triangle=uptr, threshold=thld, binary=bin)
619
620 CALL cp_print_key_finished_output(unit_nr, logger, dft_section, "PRINT%KS_CSR_WRITE")
621
622 CALL dbcsr_csr_destroy(ks_mat_csr)
623 CALL dbcsr_release(matrix_ks_nosym)
624 END DO
625 END IF
626
627 CALL timestop(handle)
628
629 END SUBROUTINE pao_write_ks_matrix_csr
630
631!**************************************************************************************************
632!> \brief writing the overlap matrix (in terms of the PAO basis) in csr format into a file
633!> \param qs_env qs environment
634!> \param ls_scf_env ls environment
635!> \author Mohammad Hossein Bani-Hashemian
636! **************************************************************************************************
637 SUBROUTINE pao_write_s_matrix_csr(qs_env, ls_scf_env)
638 TYPE(qs_environment_type), POINTER :: qs_env
639 TYPE(ls_scf_env_type), TARGET :: ls_scf_env
640
641 CHARACTER(len=*), PARAMETER :: routinen = 'pao_write_s_matrix_csr'
642
643 CHARACTER(LEN=default_path_length) :: file_name, fileformat
644 INTEGER :: handle, output_unit, unit_nr
645 LOGICAL :: bin, do_kpoints, do_s_csr_write, uptr
646 REAL(kind=dp) :: thld
647 TYPE(cp_logger_type), POINTER :: logger
648 TYPE(dbcsr_csr_type) :: s_mat_csr
649 TYPE(dbcsr_type) :: matrix_s_nosym
650 TYPE(section_vals_type), POINTER :: dft_section, input
651
652 CALL timeset(routinen, handle)
653
654 NULLIFY (dft_section)
655
656 logger => cp_get_default_logger()
657 output_unit = cp_logger_get_default_io_unit(logger)
658
659 CALL get_qs_env(qs_env, input=input)
660 dft_section => section_vals_get_subs_vals(input, "DFT")
661 do_s_csr_write = btest(cp_print_key_should_output(logger%iter_info, dft_section, &
662 "PRINT%S_CSR_WRITE"), cp_p_file)
663
664 ! NOTE: k-points has to be treated differently later. k-points has overlap matrix as double pointer.
665 CALL get_qs_env(qs_env=qs_env, do_kpoints=do_kpoints)
666
667 IF (do_s_csr_write .AND. (.NOT. do_kpoints)) THEN
668 CALL section_vals_val_get(dft_section, "PRINT%S_CSR_WRITE%THRESHOLD", r_val=thld)
669 CALL section_vals_val_get(dft_section, "PRINT%S_CSR_WRITE%UPPER_TRIANGULAR", l_val=uptr)
670 CALL section_vals_val_get(dft_section, "PRINT%S_CSR_WRITE%BINARY", l_val=bin)
671
672 IF (bin) THEN
673 fileformat = "UNFORMATTED"
674 ELSE
675 fileformat = "FORMATTED"
676 END IF
677
678 IF (dbcsr_has_symmetry(ls_scf_env%matrix_s)) THEN
679 CALL dbcsr_desymmetrize(ls_scf_env%matrix_s, matrix_s_nosym)
680 ELSE
681 CALL dbcsr_copy(matrix_s_nosym, ls_scf_env%matrix_s)
682 END IF
683
684 CALL dbcsr_csr_create_from_dbcsr(matrix_s_nosym, s_mat_csr, dbcsr_csr_dbcsr_blkrow_dist)
685 CALL dbcsr_convert_dbcsr_to_csr(matrix_s_nosym, s_mat_csr)
686
687 WRITE (file_name, '(A,I0)') "PAO_S"
688 unit_nr = cp_print_key_unit_nr(logger, dft_section, "PRINT%S_CSR_WRITE", &
689 extension=".csr", middle_name=trim(file_name), &
690 file_status="REPLACE", file_form=fileformat)
691 CALL dbcsr_csr_write(s_mat_csr, unit_nr, upper_triangle=uptr, threshold=thld, binary=bin)
692
693 CALL cp_print_key_finished_output(unit_nr, logger, dft_section, "PRINT%S_CSR_WRITE")
694
695 CALL dbcsr_csr_destroy(s_mat_csr)
696 CALL dbcsr_release(matrix_s_nosym)
697 END IF
698
699 CALL timestop(handle)
700
701 END SUBROUTINE pao_write_s_matrix_csr
702
703!**************************************************************************************************
704!> \brief writing the core Hamiltonian matrix (NYA)
705!> \param qs_env qs environment
706!> \param ls_scf_env ls environment
707!> \author Mohammad Hossein Bani-Hashemian
708! **************************************************************************************************
709 SUBROUTINE pao_write_hcore_matrix_csr(qs_env, ls_scf_env)
710 TYPE(qs_environment_type), POINTER :: qs_env
711 TYPE(ls_scf_env_type), TARGET :: ls_scf_env
712
713 CHARACTER(len=*), PARAMETER :: routinen = 'pao_write_hcore_matrix_csr'
714
715 INTEGER :: handle, output_unit
716 LOGICAL :: do_h_csr_write, do_kpoints
717 TYPE(cp_logger_type), POINTER :: logger
718 TYPE(section_vals_type), POINTER :: dft_section, input
719
720 mark_used(ls_scf_env)
721
722 CALL timeset(routinen, handle)
723
724 NULLIFY (dft_section)
725
726 logger => cp_get_default_logger()
727 output_unit = cp_logger_get_default_io_unit(logger)
728
729 CALL get_qs_env(qs_env, input=input)
730 dft_section => section_vals_get_subs_vals(input, "DFT")
731 do_h_csr_write = btest(cp_print_key_should_output(logger%iter_info, dft_section, &
732 "PRINT%HCORE_CSR_WRITE"), cp_p_file)
733
734 ! NOTE: k-points has to be treated differently later. k-points has KS matrix as double pointer.
735 CALL get_qs_env(qs_env=qs_env, do_kpoints=do_kpoints)
736
737 IF (do_h_csr_write .AND. (.NOT. do_kpoints)) THEN
738 CALL cp_warn(__location__, "Writing the PAO Core Hamiltonian matrix in CSR format NYA")
739 END IF
740
741 CALL timestop(handle)
742
743 END SUBROUTINE pao_write_hcore_matrix_csr
744
745!**************************************************************************************************
746!> \brief writing the density matrix (NYA)
747!> \param qs_env qs environment
748!> \param ls_scf_env ls environment
749!> \author Mohammad Hossein Bani-Hashemian
750! **************************************************************************************************
751 SUBROUTINE pao_write_p_matrix_csr(qs_env, ls_scf_env)
752 TYPE(qs_environment_type), POINTER :: qs_env
753 TYPE(ls_scf_env_type), TARGET :: ls_scf_env
754
755 CHARACTER(len=*), PARAMETER :: routinen = 'pao_write_p_matrix_csr'
756
757 INTEGER :: handle, output_unit
758 LOGICAL :: do_kpoints, do_p_csr_write
759 TYPE(cp_logger_type), POINTER :: logger
760 TYPE(section_vals_type), POINTER :: dft_section, input
761
762 mark_used(ls_scf_env)
763
764 CALL timeset(routinen, handle)
765
766 NULLIFY (dft_section)
767
768 logger => cp_get_default_logger()
769 output_unit = cp_logger_get_default_io_unit(logger)
770
771 CALL get_qs_env(qs_env, input=input)
772 dft_section => section_vals_get_subs_vals(input, "DFT")
773 do_p_csr_write = btest(cp_print_key_should_output(logger%iter_info, dft_section, &
774 "PRINT%P_CSR_WRITE"), cp_p_file)
775
776 ! NOTE: k-points has to be treated differently later. k-points has KS matrix as double pointer.
777 CALL get_qs_env(qs_env=qs_env, do_kpoints=do_kpoints)
778
779 IF (do_p_csr_write .AND. (.NOT. do_kpoints)) THEN
780 CALL cp_warn(__location__, "Writing the PAO density matrix in CSR format NYA")
781 END IF
782
783 CALL timestop(handle)
784
785 END SUBROUTINE pao_write_p_matrix_csr
786
787END MODULE pao_io
Define the atomic kind types and their sub types.
subroutine, public get_atomic_kind(atomic_kind, fist_potential, element_symbol, name, mass, kind_number, natom, atom_list, rcov, rvdw, z, qeff, apol, cpol, mm_radius, shell, shell_active, damping)
Get attributes of an atomic kind.
Handles all functions related to the CELL.
Definition cell_types.F:15
logical function, public dbcsr_has_symmetry(matrix)
...
subroutine, public dbcsr_convert_dbcsr_to_csr(dbcsr_mat, csr_mat)
...
subroutine, public dbcsr_desymmetrize(matrix_a, matrix_b)
...
subroutine, public dbcsr_copy(matrix_b, matrix_a, name, keep_sparsity, keep_imaginary)
...
subroutine, public dbcsr_get_block_p(matrix, row, col, block, found, row_size, col_size)
...
subroutine, public dbcsr_get_info(matrix, nblkrows_total, nblkcols_total, nfullrows_total, nfullcols_total, nblkrows_local, nblkcols_local, nfullrows_local, nfullcols_local, my_prow, my_pcol, local_rows, local_cols, proc_row_dist, proc_col_dist, row_blk_size, col_blk_size, row_blk_offset, col_blk_offset, distribution, name, matrix_type, group)
...
subroutine, public dbcsr_csr_create_from_dbcsr(dbcsr_mat, csr_mat, dist_format, csr_sparsity, numnodes)
...
subroutine, public dbcsr_release(matrix)
...
Utility routines to open and close files. Tracking of preconnections.
Definition cp_files.F:16
subroutine, public open_file(file_name, file_status, file_form, file_action, file_position, file_pad, unit_number, debug, skip_get_unit_number, file_access)
Opens the requested file using a free unit number.
Definition cp_files.F:311
subroutine, public close_file(unit_number, file_status, keep_preconnection)
Close an open file given by its logical unit number. Optionally, keep the file and unit preconnected.
Definition cp_files.F:122
various routines to log and control the output. The idea is that decisions about where to log should ...
integer function, public cp_logger_get_default_io_unit(logger)
returns the unit nr for the ionode (-1 on all other processors) skips as well checks if the procs cal...
type(cp_logger_type) function, pointer, public cp_get_default_logger()
returns the default logger
routines to handle the output, The idea is to remove the decision of wheter to output and what to out...
integer function, public cp_print_key_unit_nr(logger, basis_section, print_key_path, extension, middle_name, local, log_filename, ignore_should_output, file_form, file_position, file_action, file_status, do_backup, on_file, is_new_file, mpi_io, fout)
...
subroutine, public cp_print_key_finished_output(unit_nr, logger, basis_section, print_key_path, local, ignore_should_output, on_file, mpi_io)
should be called after you finish working with a unit obtained with cp_print_key_unit_nr,...
integer, parameter, public cp_p_file
integer function, public cp_print_key_should_output(iteration_info, basis_section, print_key_path, used_print_key, first_time)
returns what should be done with the given property if btest(res,cp_p_store) then the property should...
Types needed for a linear scaling quickstep SCF run based on the density matrix.
objects that represent the structure of input sections and the data contained in an input section
recursive type(section_vals_type) function, pointer, public section_vals_get_subs_vals(section_vals, subsection_name, i_rep_section, can_return_null)
returns the values of the requested subsection
subroutine, public section_vals_val_get(section_vals, keyword_name, i_rep_section, i_rep_val, n_rep_val, val, l_val, i_val, r_val, c_val, l_vals, i_vals, r_vals, c_vals, explicit)
returns the requested value
Defines the basic variable types.
Definition kinds.F:23
integer, parameter, public dp
Definition kinds.F:34
integer, parameter, public default_string_length
Definition kinds.F:57
integer, parameter, public default_path_length
Definition kinds.F:58
Interface to the message passing library MPI.
character(len=20) function, public id2str(id)
Helper routine.
Definition pao_input.F:216
Routines for reading and writing restart files.
Definition pao_io.F:12
subroutine, public pao_write_p_matrix_csr(qs_env, ls_scf_env)
writing the density matrix (NYA)
Definition pao_io.F:752
subroutine, public pao_write_hcore_matrix_csr(qs_env, ls_scf_env)
writing the core Hamiltonian matrix (NYA)
Definition pao_io.F:710
subroutine, public pao_kinds_ensure_equal(pao, qs_env, ikind, pao_kind)
Ensure that the kind read from the restart is equal to the kind curretly in use.
Definition pao_io.F:327
subroutine, public pao_write_restart(pao, qs_env, energy)
Writes restart file.
Definition pao_io.F:392
subroutine, public pao_write_ks_matrix_csr(qs_env, ls_scf_env)
writing the KS matrix (in terms of the PAO basis) in csr format into a file
Definition pao_io.F:563
subroutine, public pao_read_raw(filename, param, hmat, kinds, atom2kind, positions, xblocks, ml_range)
Reads a restart file into temporary datastructures.
Definition pao_io.F:184
subroutine, public pao_write_s_matrix_csr(qs_env, ls_scf_env)
writing the overlap matrix (in terms of the PAO basis) in csr format into a file
Definition pao_io.F:638
subroutine, public pao_read_restart(pao, qs_env)
Reads restart file.
Definition pao_io.F:88
Front-End for any PAO parametrization.
Definition pao_param.F:12
subroutine, public pao_param_count(pao, qs_env, ikind, nparams)
Returns the number of parameters for given atomic kind.
Definition pao_param.F:173
Factory routines for potentials used e.g. by pao_param_exp and pao_ml.
Types used by the PAO machinery.
Definition pao_types.F:12
Define the data structure for the particle information.
Definition of physical constants:
Definition physcon.F:68
real(kind=dp), parameter, public angstrom
Definition physcon.F:144
subroutine, public get_qs_env(qs_env, atomic_kind_set, qs_kind_set, cell, super_cell, cell_ref, use_ref_cell, kpoints, dft_control, mos, sab_orb, sab_all, qmmm, qmmm_periodic, mimic, sac_ae, sac_ppl, sac_lri, sap_ppnl, sab_vdw, sab_scp, sap_oce, sab_lrc, sab_se, sab_xtbe, sab_tbe, sab_core, sab_xb, sab_xtb_pp, sab_xtb_nonbond, sab_almo, sab_kp, sab_kp_nosym, sab_cneo, particle_set, energy, force, matrix_h, matrix_h_im, matrix_ks, matrix_ks_im, matrix_vxc, run_rtp, rtp, matrix_h_kp, matrix_h_im_kp, matrix_ks_kp, matrix_ks_im_kp, matrix_vxc_kp, kinetic_kp, matrix_s_kp, matrix_w_kp, matrix_s_ri_aux_kp, matrix_s, matrix_s_ri_aux, matrix_w, matrix_p_mp2, matrix_p_mp2_admm, rho, rho_xc, pw_env, ewald_env, ewald_pw, active_space, mpools, input, para_env, blacs_env, scf_control, rel_control, kinetic, qs_charges, vppl, rho_core, rho_nlcc, rho_nlcc_g, ks_env, ks_qmmm_env, wf_history, scf_env, local_particles, local_molecules, distribution_2d, dbcsr_dist, molecule_kind_set, molecule_set, subsys, cp_subsys, oce, local_rho_set, rho_atom_set, task_list, task_list_soft, rho0_atom_set, rho0_mpole, rhoz_set, rhoz_cneo_set, ecoul_1c, rho0_s_rs, rho0_s_gs, rhoz_cneo_s_rs, rhoz_cneo_s_gs, do_kpoints, has_unit_metric, requires_mo_derivs, mo_derivs, mo_loc_history, nkind, natom, nelectron_total, nelectron_spin, efield, neighbor_list_id, linres_control, xas_env, virial, cp_ddapc_env, cp_ddapc_ewald, outer_scf_history, outer_scf_ihistory, x_data, et_coupling, dftb_potential, results, se_taper, se_store_int_env, se_nddo_mpole, se_nonbond_env, admm_env, lri_env, lri_density, exstate_env, ec_env, harris_env, dispersion_env, gcp_env, vee, rho_external, external_vxc, mask, mp2_env, bs_env, kg_env, wanniercentres, atprop, ls_scf_env, do_transport, transport_env, v_hartree_rspace, s_mstruct_changed, rho_changed, potential_changed, forces_up_to_date, mscfg_env, almo_scf_env, gradient_history, variable_history, embed_pot, spin_embed_pot, polar_env, mos_last_converged, eeq, rhs, do_rixs, tb_tblite)
Get the QUICKSTEP environment.
Define the quickstep kind type and their sub types.
subroutine, public get_qs_kind(qs_kind, basis_set, basis_type, ncgf, nsgf, all_potential, tnadd_potential, gth_potential, sgp_potential, upf_potential, cneo_potential, se_parameter, dftb_parameter, xtb_parameter, dftb3_param, zatom, zeff, elec_conf, mao, lmax_dftb, alpha_core_charge, ccore_charge, core_charge, core_charge_radius, paw_proj_set, paw_atom, hard_radius, hard0_radius, max_rad_local, covalent_radius, vdw_radius, gpw_type_forced, harmonics, max_iso_not0, max_s_harm, grid_atom, ngrid_ang, ngrid_rad, lmax_rho0, dft_plus_u_atom, l_of_dft_plus_u, n_of_dft_plus_u, u_minus_j, u_of_dft_plus_u, j_of_dft_plus_u, alpha_of_dft_plus_u, beta_of_dft_plus_u, j0_of_dft_plus_u, occupation_of_dft_plus_u, dispersion, bs_occupation, magnetization, no_optimize, addel, laddel, naddel, orbitals, max_scf, eps_scf, smear, u_ramping, u_minus_j_target, eps_u_ramping, init_u_ramping_each_scf, reltmat, ghost, monovalent, floating, name, element_symbol, pao_basis_size, pao_model_file, pao_potentials, pao_descriptors, nelec)
Get attributes of an atomic kind.
Provides all information about an atomic kind.
Type defining parameters related to the simulation cell.
Definition cell_types.F:60
type of a logger, at the moment it contains just a print level starting at which level it should be l...
stores all the informations relevant to an mpi environment
Holds information about a PAO potential.
Provides all information about a quickstep kind.