(git:ddb311d)
Loading...
Searching...
No Matches
cp2k_runs.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! **************************************************************************************************
10 USE atom, ONLY: atom_code
11 USE bibliography, ONLY: hutter2014,&
12 cite_reference
13 USE bsse, ONLY: do_bsse_calculation
14 USE cell_opt, ONLY: cp_cell_opt
16 USE cp2k_info, ONLY: compile_date,&
21 USE cp_dbcsr_api, ONLY: dbcsr_finalize_lib,&
22 dbcsr_init_lib,&
23 dbcsr_print_config,&
24 dbcsr_print_statistics
26 USE cp_files, ONLY: close_file,&
40 USE cp_units, ONLY: cp_unit_set_create,&
45 USE environment, ONLY: cp2k_finalize,&
46 cp2k_init,&
47 cp2k_read,&
51 f77_default_para_env => default_para_env,&
55 USE farming_methods, ONLY: do_deadlock,&
57 do_wait,&
68 USE geo_opt, ONLY: cp_geo_opt
74 USE input_constants, ONLY: &
86 USE input_section_types, ONLY: &
90 USE ipi_driver, ONLY: run_driver
91 USE kinds, ONLY: default_path_length,&
93 dp,&
94 int_8
95 USE library_tests, ONLY: lib_test
96 USE machine, ONLY: default_output_unit,&
97 m_chdir,&
98 m_flush,&
99 m_getcwd,&
100 m_memory,&
103 USE mc_run, ONLY: do_mon_car
104 USE md_run, ONLY: qs_mol_dyn
105 USE message_passing, ONLY: mp_any_source,&
109 USE mscfg_methods, ONLY: do_mol_loop,&
111 USE neb_methods, ONLY: neb
112 USE negf_methods, ONLY: do_negf
118 USE pint_methods, ONLY: do_pint_run
122 USE rt_bse, ONLY: run_propagation_bse
124 USE swarm, ONLY: run_swarm
125 USE tamc_run, ONLY: qs_tamc
126 USE tmc_setup, ONLY: do_analyze_files,&
127 do_tmc
129#include "../base/base_uses.f90"
130
131 IMPLICIT NONE
132
133 PRIVATE
134
135 PUBLIC :: write_xml_file, run_input
136
137 CHARACTER(len=*), PARAMETER, PRIVATE :: moduleN = 'cp2k_runs'
138
139CONTAINS
140
141! **************************************************************************************************
142!> \brief performs an instance of a cp2k run
143!> \param input_declaration ...
144!> \param input_file_name name of the file to be opened for input
145!> \param output_unit unit to which output should be written
146!> \param mpi_comm ...
147!> \param initial_variables key-value list of initial preprocessor variables
148!> \author Joost VandeVondele
149!> \note
150!> para_env should be a valid communicator
151!> output_unit should be writeable by at least the lowest rank of the mpi group
152!>
153!> recursive because a given run_type might need to be able to perform
154!> another cp2k_run as part of its job (e.g. farming, classical equilibration, ...)
155!>
156!> the idea is that a cp2k instance should be able to run with just three
157!> arguments, i.e. a given input file, output unit, mpi communicator.
158!> giving these three to cp2k_run should produce a valid run.
159!> the only task of the PROGRAM cp2k is to create valid instances of the
160!> above arguments. Ideally, anything that is called afterwards should be
161!> able to run simultaneously / multithreaded / sequential / parallel / ...
162!> and able to fail safe
163! **************************************************************************************************
164 RECURSIVE SUBROUTINE cp2k_run(input_declaration, input_file_name, output_unit, mpi_comm, initial_variables)
165 TYPE(section_type), POINTER :: input_declaration
166 CHARACTER(LEN=*), INTENT(IN) :: input_file_name
167 INTEGER, INTENT(IN) :: output_unit
168
169 CLASS(mp_comm_type) :: mpi_comm
170 CHARACTER(len=default_path_length), &
171 DIMENSION(:, :), INTENT(IN) :: initial_variables
172
173 INTEGER :: f_env_handle, grid_backend, ierr, &
174 iter_level, method_name_id, &
175 new_env_id, prog_name_id, run_type_id
176#if defined(__DBCSR_ACC)
177 INTEGER, TARGET :: offload_chosen_device
178#endif
179 INTEGER, POINTER :: active_device_id
180 INTEGER(KIND=int_8) :: m_memory_max_mpi
181 LOGICAL :: echo_input, grid_apply_cutoff, &
182 grid_validate, I_was_ionode
183 TYPE(cp_logger_type), POINTER :: logger, sublogger
184 TYPE(mp_para_env_type), POINTER :: para_env
185 TYPE(dft_control_type), POINTER :: dft_control
186 TYPE(f_env_type), POINTER :: f_env
187 TYPE(force_env_type), POINTER :: force_env
188 TYPE(global_environment_type), POINTER :: globenv
189 TYPE(section_vals_type), POINTER :: glob_section, input_file, root_section
190
191 NULLIFY (para_env, f_env, dft_control, active_device_id)
192 ALLOCATE (para_env)
193 para_env = mpi_comm
194
195#if defined(__DBCSR_ACC)
196 IF (offload_get_device_count() > 0) THEN
197 offload_chosen_device = offload_get_chosen_device()
198 active_device_id => offload_chosen_device
199 END IF
200#endif
201 CALL dbcsr_init_lib(mpi_comm%get_handle(), io_unit=output_unit, &
202 accdrv_active_device_id=active_device_id)
203
204 NULLIFY (globenv, force_env)
205
207
208 ! Parse the input
209 input_file => read_input(input_declaration, input_file_name, &
210 initial_variables=initial_variables, &
211 para_env=para_env)
212
213 CALL para_env%sync()
214
215 logger => cp_get_default_logger()
216
217 glob_section => section_vals_get_subs_vals(input_file, "GLOBAL")
218 CALL section_vals_val_get(glob_section, "ECHO_INPUT", l_val=echo_input)
219 IF (echo_input .AND. (output_unit > 0)) THEN
220 CALL section_vals_write(input_file, &
221 unit_nr=output_unit, &
222 hide_root=.true., &
223 hide_defaults=.false.)
224 END IF
225
226 CALL check_cp2k_input(input_declaration, input_file, para_env=para_env, output_unit=output_unit)
227 root_section => input_file
228 CALL section_vals_val_get(input_file, "GLOBAL%PROGRAM_NAME", &
229 i_val=prog_name_id)
230 CALL section_vals_val_get(input_file, "GLOBAL%RUN_TYPE", &
231 i_val=run_type_id)
232 CALL section_vals_val_get(root_section, "FORCE_EVAL%METHOD", i_val=method_name_id)
233
234 IF (prog_name_id /= do_cp2k) THEN
235 ! initial setup (cp2k does in in the creation of the force_env)
236 CALL globenv_create(globenv)
237 CALL section_vals_retain(input_file)
238 CALL cp2k_init(para_env, output_unit, globenv, input_file_name=input_file_name)
239 CALL cp2k_read(root_section, para_env, globenv)
240 CALL cp2k_setup(root_section, para_env, globenv)
241 END IF
242
243 CALL cp_dbcsr_config(root_section)
244 IF (output_unit > 0 .AND. &
246 CALL dbcsr_print_config(unit_nr=output_unit)
247 WRITE (unit=output_unit, fmt='()')
248 END IF
249
250 ! Configure the grid library.
251 CALL section_vals_val_get(root_section, "GLOBAL%GRID%BACKEND", i_val=grid_backend)
252 CALL section_vals_val_get(root_section, "GLOBAL%GRID%VALIDATE", l_val=grid_validate)
253 CALL section_vals_val_get(root_section, "GLOBAL%GRID%APPLY_CUTOFF", l_val=grid_apply_cutoff)
254
255 CALL grid_library_set_config(backend=grid_backend, &
256 validate=grid_validate, &
257 apply_cutoff=grid_apply_cutoff)
258
259 SELECT CASE (prog_name_id)
260 CASE (do_atom)
261 globenv%run_type_id = none_run
262 CALL atom_code(root_section)
263 CASE (do_optimize_input)
264 CALL run_optimize_input(input_declaration, root_section, para_env)
265 CASE (do_swarm)
266 CALL run_swarm(input_declaration, root_section, para_env, globenv, input_file_name)
267 CASE (do_farming) ! TODO: refactor cp2k's startup code
268 CALL dbcsr_finalize_lib()
269 CALL farming_run(input_declaration, root_section, para_env, initial_variables)
270 CALL dbcsr_init_lib(mpi_comm%get_handle(), io_unit=output_unit, &
271 accdrv_active_device_id=active_device_id)
272 CASE (do_opt_basis)
273 CALL run_optimize_basis(input_declaration, root_section, para_env)
274 globenv%run_type_id = none_run
275 CASE (do_cp2k)
276 CALL create_force_env(new_env_id, &
277 input_declaration=input_declaration, &
278 input_path=input_file_name, &
279 output_path="__STD_OUT__", mpi_comm=para_env, &
280 output_unit=output_unit, &
281 owns_out_unit=.false., &
282 input=input_file, ierr=ierr)
283 cpassert(ierr == 0)
284 CALL f_env_add_defaults(new_env_id, f_env, handle=f_env_handle)
285 force_env => f_env%force_env
286 CALL force_env_get(force_env, globenv=globenv)
287 CASE (do_test)
288 CALL lib_test(root_section, para_env, globenv)
289 CASE (do_tree_mc) ! TMC entry point
290 CALL do_tmc(input_declaration, root_section, para_env, globenv)
291 CASE (do_tree_mc_ana)
292 CALL do_analyze_files(input_declaration, root_section, para_env)
293 CASE default
294 cpabort("")
295 END SELECT
296 CALL section_vals_release(input_file)
297
298 SELECT CASE (globenv%run_type_id)
299 CASE (pint_run)
300 CALL do_pint_run(para_env, root_section, input_declaration, globenv)
301 CASE (none_run, tree_mc_run)
302 ! do nothing
303 CASE (driver_run)
304 CALL run_driver(force_env, globenv)
306 IF (method_name_id /= do_qs .AND. &
307 method_name_id /= do_sirius .AND. &
308 method_name_id /= do_qmmm .AND. &
309 method_name_id /= do_mixed .AND. &
310 method_name_id /= do_nnp .AND. &
311 method_name_id /= do_embed .AND. &
312 method_name_id /= do_fist .AND. &
313 method_name_id /= do_ipi) &
314 cpabort("Energy/Force run not available for all methods ")
315
316 sublogger => cp_get_default_logger()
317 CALL cp_add_iter_level(sublogger%iter_info, "JUST_ENERGY", &
318 n_rlevel_new=iter_level)
319
320 ! loop over molecules to generate a molecular guess
321 ! this procedure is initiated here to avoid passing globenv deep down
322 ! the subroutine stack
323 IF (do_mol_loop(force_env=force_env)) &
324 CALL loop_over_molecules(globenv, force_env)
325
326 SELECT CASE (globenv%run_type_id)
327 CASE (energy_run)
328 CALL force_env_calc_energy_force(force_env, calc_force=.false.)
329 CASE (energy_force_run)
330 CALL force_env_calc_energy_force(force_env, calc_force=.true.)
331 CASE default
332 cpabort("")
333 END SELECT
334 CALL cp_rm_iter_level(sublogger%iter_info, level_name="JUST_ENERGY", n_rlevel_att=iter_level)
335 CASE (mol_dyn_run)
336 CALL qs_mol_dyn(force_env, globenv)
337 CASE (geo_opt_run)
338 CALL cp_geo_opt(force_env, globenv)
339 CASE (cell_opt_run)
340 CALL cp_cell_opt(force_env, globenv)
341 CASE (mon_car_run)
342 CALL do_mon_car(force_env, globenv, input_declaration, input_file_name)
343 CASE (do_tamc)
344 CALL qs_tamc(force_env, globenv)
346 IF (method_name_id /= do_qs) &
347 cpabort("Real time propagation needs METHOD QS. ")
348 CALL get_qs_env(force_env%qs_env, dft_control=dft_control)
349 dft_control%rtp_control%fixed_ions = .true.
350 SELECT CASE (dft_control%rtp_control%rtp_method)
351 CASE (rtp_method_bse)
352 ! Run the TD-BSE method
353 CALL run_propagation_bse(force_env%qs_env, force_env)
354 CASE default
355 ! Run the TDDFT method
356 CALL rt_prop_setup(force_env)
357 END SELECT
358 CASE (ehrenfest)
359 IF (method_name_id /= do_qs) &
360 cpabort("Ehrenfest dynamics needs METHOD QS ")
361 CALL get_qs_env(force_env%qs_env, dft_control=dft_control)
362 dft_control%rtp_control%fixed_ions = .false.
363 CALL qs_mol_dyn(force_env, globenv)
364 CASE (bsse_run)
365 CALL do_bsse_calculation(force_env, globenv)
367 IF (method_name_id /= do_qs .AND. &
368 method_name_id /= do_qmmm) &
369 cpabort("Property calculations by Linear Response only within the QS or QMMM program ")
370 ! The Ground State is needed, it can be read from Restart
371 CALL force_env_calc_energy_force(force_env, calc_force=.false., linres=.true.)
372 CALL linres_calculation(force_env)
373 CASE (debug_run)
374 SELECT CASE (method_name_id)
375 CASE (do_qs, do_qmmm, do_fist)
376 CALL cp2k_debug_energy_and_forces(force_env)
377 CASE DEFAULT
378 cpabort("Debug run available only with QS, FIST, and QMMM program ")
379 END SELECT
380 CASE (vib_anal)
381 CALL vb_anal(root_section, input_declaration, para_env, globenv)
382 CASE (do_band)
383 CALL neb(root_section, input_declaration, para_env, globenv)
384 CASE (negf_run)
385 CALL do_negf(force_env)
386 CASE default
387 cpabort("")
388 END SELECT
389
390 ! Sample peak memory
391 CALL m_memory()
392
393 CALL dbcsr_print_statistics()
394 CALL dbm_library_print_stats(mpi_comm=mpi_comm, output_unit=output_unit)
395 CALL grid_library_print_stats(mpi_comm=mpi_comm, output_unit=output_unit)
396 CALL offload_mempool_stats_print(mpi_comm=mpi_comm, output_unit=output_unit)
397
398 m_memory_max_mpi = m_memory_max
399 CALL mpi_comm%max(m_memory_max_mpi)
400 IF (output_unit > 0) THEN
401 WRITE (output_unit, *)
402 WRITE (output_unit, '(T2,"MEMORY| Estimated peak process memory [MiB]",T73,I8)') &
403 (m_memory_max_mpi + (1024*1024) - 1)/(1024*1024)
404 END IF
405
406 IF (prog_name_id == do_cp2k) THEN
407 f_env%force_env => force_env ! for mc
408 IF (ASSOCIATED(force_env%globenv)) THEN
409 IF (.NOT. ASSOCIATED(force_env%globenv, globenv)) THEN
410 CALL globenv_release(force_env%globenv) !mc
411 END IF
412 END IF
413 force_env%globenv => globenv !mc
414 CALL f_env_rm_defaults(f_env, ierr=ierr, &
415 handle=f_env_handle)
416 cpassert(ierr == 0)
417 CALL destroy_force_env(new_env_id, ierr=ierr)
418 cpassert(ierr == 0)
419 ELSE
420 i_was_ionode = para_env%is_source()
421 CALL cp2k_finalize(root_section, para_env, globenv)
422 cpassert(globenv%ref_count == 1)
423 CALL section_vals_release(root_section)
424 CALL globenv_release(globenv)
425 END IF
426
427 CALL dbcsr_finalize_lib()
428
429 CALL mp_para_env_release(para_env)
430
431 END SUBROUTINE cp2k_run
432
433! **************************************************************************************************
434!> \brief performs a farming run that performs several independent cp2k_runs
435!> \param input_declaration ...
436!> \param root_section ...
437!> \param para_env ...
438!> \param initial_variables ...
439!> \author Joost VandeVondele
440!> \note
441!> needs to be part of this module as the cp2k_run -> farming_run -> cp2k_run
442!> calling style creates a hard circular dependency
443! **************************************************************************************************
444 RECURSIVE SUBROUTINE farming_run(input_declaration, root_section, para_env, initial_variables)
445 TYPE(section_type), POINTER :: input_declaration
446 TYPE(section_vals_type), POINTER :: root_section
447 TYPE(mp_para_env_type), POINTER :: para_env
448 CHARACTER(len=default_path_length), DIMENSION(:, :), INTENT(IN) :: initial_variables
449
450 CHARACTER(len=*), PARAMETER :: routineN = 'farming_run'
451 INTEGER, PARAMETER :: minion_status_done = -3, &
452 minion_status_wait = -4
453
454 CHARACTER(len=7) :: label
455 CHARACTER(LEN=default_path_length) :: output_file
456 CHARACTER(LEN=default_string_length) :: str
457 INTEGER :: dest, handle, i, i_job_to_restart, ierr, ijob, ijob_current, &
458 ijob_end, ijob_start, iunit, n_jobs_to_run, new_output_unit, &
459 new_rank, ngroups, num_minions, output_unit, primus_minion, &
460 minion_rank, source, tag, todo
461 INTEGER, DIMENSION(:), POINTER :: group_distribution, &
462 captain_minion_partition, &
463 minion_distribution, &
464 minion_status
465 LOGICAL :: found, captain, minion
466 REAL(KIND=dp) :: t1, t2
467 REAL(KIND=dp), ALLOCATABLE, DIMENSION(:) :: waittime
468 TYPE(cp_logger_type), POINTER :: logger
469 TYPE(cp_parser_type), POINTER :: my_parser
470 TYPE(cp_unit_set_type) :: default_units
471 TYPE(farming_env_type), POINTER :: farming_env
472 TYPE(section_type), POINTER :: g_section
473 TYPE(section_vals_type), POINTER :: g_data
474 TYPE(mp_comm_type) :: minion_group, new_group
475
476 ! the primus of all minions, talks to the captain on topics concerning all minions
477 CALL timeset(routinen, handle)
478 NULLIFY (my_parser, g_section, g_data)
479
480 logger => cp_get_default_logger()
481 output_unit = cp_print_key_unit_nr(logger, root_section, "FARMING%PROGRAM_RUN_INFO", &
482 extension=".log")
483
484 IF (output_unit > 0) WRITE (output_unit, fmt="(T2,A)") "FARMING| Hi, welcome on this farm!"
485
486 ALLOCATE (farming_env)
487 CALL init_farming_env(farming_env)
488 ! remember where we started
489 CALL m_getcwd(farming_env%cwd)
490 CALL farming_parse_input(farming_env, root_section, para_env)
491
492 ! the full mpi group is first split in a minion group and a captain group, the latter being at most 1 process
493 minion = .true.
494 captain = .false.
495 IF (farming_env%captain_minion) THEN
496 IF (output_unit > 0) WRITE (output_unit, fmt="(T2,A)") "FARMING| Using a Captain-Minion setup"
497
498 ALLOCATE (captain_minion_partition(0:1))
499 captain_minion_partition = [1, para_env%num_pe - 1]
500 ALLOCATE (group_distribution(0:para_env%num_pe - 1))
501
502 CALL minion_group%from_split(para_env, ngroups, group_distribution, &
503 n_subgroups=2, group_partition=captain_minion_partition)
504 DEALLOCATE (captain_minion_partition)
505 DEALLOCATE (group_distribution)
506 num_minions = minion_group%num_pe
507 minion_rank = minion_group%mepos
508
509 IF (para_env%mepos == 0) THEN
510 minion = .false.
511 captain = .true.
512 ! on the captain node, num_minions corresponds to the size of the captain group
513 cpassert(num_minions == 1)
514 num_minions = para_env%num_pe - 1
515 minion_rank = -1
516 END IF
517 cpassert(num_minions == para_env%num_pe - 1)
518 ELSE
519 ! all processes are minions
520 IF (output_unit > 0) WRITE (output_unit, fmt="(T2,A)") "FARMING| Using a Minion-only setup"
521 CALL minion_group%from_dup(para_env)
522 num_minions = minion_group%num_pe
523 minion_rank = minion_group%mepos
524 END IF
525 IF (output_unit > 0) WRITE (output_unit, fmt="(T2,A,I0)") "FARMING| Number of Minions ", num_minions
526
527 ! keep track of which para_env rank is which minion/captain
528 ALLOCATE (minion_distribution(0:para_env%num_pe - 1))
529 minion_distribution = 0
530 minion_distribution(para_env%mepos) = minion_rank
531 CALL para_env%sum(minion_distribution)
532 ! we do have a primus inter pares
533 primus_minion = 0
534 DO i = 1, para_env%num_pe - 1
535 IF (minion_distribution(i) == 0) primus_minion = i
536 END DO
537
538 ! split the current communicator for the minions
539 ! in a new_group, new_size and new_rank according to the number of groups required according to the input
540 ALLOCATE (group_distribution(0:num_minions - 1))
541 group_distribution = -1
542 IF (minion) THEN
543 IF (farming_env%group_size_wish_set) THEN
544 farming_env%group_size_wish = min(farming_env%group_size_wish, para_env%num_pe)
545 CALL new_group%from_split(minion_group, ngroups, group_distribution, &
546 subgroup_min_size=farming_env%group_size_wish, stride=farming_env%stride)
547 ELSE IF (farming_env%ngroup_wish_set) THEN
548 IF (ASSOCIATED(farming_env%group_partition)) THEN
549 CALL new_group%from_split(minion_group, ngroups, group_distribution, &
550 n_subgroups=farming_env%ngroup_wish, &
551 group_partition=farming_env%group_partition, stride=farming_env%stride)
552 ELSE
553 CALL new_group%from_split(minion_group, ngroups, group_distribution, &
554 n_subgroups=farming_env%ngroup_wish, stride=farming_env%stride)
555 END IF
556 ELSE
557 cpabort("must set either group_size_wish or ngroup_wish")
558 END IF
559 new_rank = new_group%mepos
560 END IF
561
562 ! transfer the info about the minion group distribution to the captain
563 IF (farming_env%captain_minion) THEN
564 IF (para_env%mepos == primus_minion) THEN
565 tag = 1
566 CALL para_env%send(group_distribution, 0, tag)
567 tag = 2
568 CALL para_env%send(ngroups, 0, tag)
569 END IF
570 IF (para_env%mepos == 0) THEN
571 tag = 1
572 CALL para_env%recv(group_distribution, primus_minion, tag)
573 tag = 2
574 CALL para_env%recv(ngroups, primus_minion, tag)
575 END IF
576 END IF
577
578 ! write info on group distribution
579 IF (output_unit > 0) THEN
580 WRITE (output_unit, fmt="(T2,A,T71,I10)") "FARMING| Number of created MPI (Minion) groups:", ngroups
581 WRITE (output_unit, fmt="(T2,A)", advance="NO") "FARMING| MPI (Minion) process to group correspondence:"
582 DO i = 0, num_minions - 1
583 IF (modulo(i, 4) == 0) WRITE (output_unit, *)
584 WRITE (output_unit, fmt='(A3,I6,A3,I6,A1)', advance="NO") &
585 " (", i, " : ", group_distribution(i), ")"
586 END DO
587 WRITE (output_unit, *)
588 CALL m_flush(output_unit)
589 END IF
590
591 ! protect about too many jobs being run in single go. Not more jobs are allowed than the number in the input file
592 ! and determine the future restart point
593 IF (farming_env%cycle) THEN
594 n_jobs_to_run = farming_env%max_steps*ngroups
595 i_job_to_restart = modulo(farming_env%restart_n + n_jobs_to_run - 1, farming_env%njobs) + 1
596 ELSE
597 n_jobs_to_run = min(farming_env%njobs, farming_env%max_steps*ngroups)
598 n_jobs_to_run = min(n_jobs_to_run, farming_env%njobs - farming_env%restart_n + 1)
599 i_job_to_restart = n_jobs_to_run + farming_env%restart_n
600 END IF
601
602 ! and write the restart now, that's the point where the next job starts, even if this one is running
603 iunit = cp_print_key_unit_nr(logger, root_section, "FARMING%RESTART", &
604 extension=".restart")
605 IF (iunit > 0) THEN
606 WRITE (iunit, *) i_job_to_restart
607 END IF
608 CALL cp_print_key_finished_output(iunit, logger, root_section, "FARMING%RESTART")
609
610 ! this is the job range to be executed.
611 ijob_start = farming_env%restart_n
612 ijob_end = ijob_start + n_jobs_to_run - 1
613 IF (output_unit > 0 .AND. ijob_end - ijob_start < 0) THEN
614 WRITE (output_unit, fmt="(T2,A)") "FARMING| --- WARNING --- NO JOBS NEED EXECUTION ? "
615 WRITE (output_unit, fmt="(T2,A)") "FARMING| is the cycle keyword required ?"
616 WRITE (output_unit, fmt="(T2,A)") "FARMING| or is a stray RESTART file present ?"
617 WRITE (output_unit, fmt="(T2,A)") "FARMING| or is the group_size requested smaller than the number of CPUs?"
618 END IF
619
620 ! actual executions of the jobs in two different modes
621 IF (farming_env%captain_minion) THEN
622 IF (minion) THEN
623 ! keep on doing work until captain has decided otherwise
624 todo = do_wait
625 DO
626 IF (new_rank == 0) THEN
627 ! the head minion tells the captain he's done or ready to start
628 ! the message tells what has been done lately
629 tag = 1
630 dest = 0
631 CALL para_env%send(todo, dest, tag)
632
633 ! gets the new todo item
634 tag = 2
635 source = 0
636 CALL para_env%recv(todo, source, tag)
637
638 ! and informs his peer minions
639 CALL new_group%bcast(todo, 0)
640 ELSE
641 CALL new_group%bcast(todo, 0)
642 END IF
643
644 ! if the todo is do_nothing we are flagged to quit. Otherwise it is the job number
645 SELECT CASE (todo)
646 CASE (do_wait, do_deadlock)
647 ! go for a next round, but we first wait a bit
648 t1 = m_walltime()
649 DO
650 t2 = m_walltime()
651 IF (t2 - t1 > farming_env%wait_time) EXIT
652 END DO
653 CASE (do_nothing)
654 EXIT
655 CASE (1:)
656 CALL execute_job(todo)
657 END SELECT
658 END DO
659 ELSE ! captain
660 ALLOCATE (minion_status(0:ngroups - 1))
661 minion_status = minion_status_wait
662 ijob_current = ijob_start - 1
663
664 DO
665 IF (all(minion_status == minion_status_done)) EXIT
666
667 ! who's the next minion waiting for work
668 tag = 1
669 source = mp_any_source
670 CALL para_env%recv(todo, source, tag) ! updates source
671 IF (todo > 0) THEN
672 farming_env%Job(todo)%status = job_finished
673 IF (output_unit > 0) THEN
674 WRITE (output_unit, fmt=*) "Job finished: ", todo
675 CALL m_flush(output_unit)
676 END IF
677 END IF
678
679 ! get the next job in line, this could be do_nothing, if we're finished
680 CALL get_next_job(farming_env, ijob_start, ijob_end, ijob_current, todo)
681 dest = source
682 tag = 2
683 CALL para_env%send(todo, dest, tag)
684
685 IF (todo > 0) THEN
686 farming_env%Job(todo)%status = job_running
687 IF (output_unit > 0) THEN
688 WRITE (output_unit, fmt=*) "Job: ", todo, " Dir: ", trim(farming_env%Job(todo)%cwd), &
689 " assigned to group ", group_distribution(minion_distribution(dest))
690 CALL m_flush(output_unit)
691 END IF
692 ELSE
693 IF (todo == do_nothing) THEN
694 minion_status(group_distribution(minion_distribution(dest))) = minion_status_done
695 IF (output_unit > 0) THEN
696 WRITE (output_unit, fmt=*) "group done: ", group_distribution(minion_distribution(dest))
697 CALL m_flush(output_unit)
698 END IF
699 END IF
700 IF (todo == do_deadlock) THEN
701 IF (output_unit > 0) THEN
702 WRITE (output_unit, fmt=*) ""
703 WRITE (output_unit, fmt=*) "FARMING JOB DEADLOCKED ... CIRCULAR DEPENDENCIES"
704 WRITE (output_unit, fmt=*) ""
705 CALL m_flush(output_unit)
706 END IF
707 cpassert(todo /= do_deadlock)
708 END IF
709 END IF
710
711 END DO
712
713 DEALLOCATE (minion_status)
714
715 END IF
716 ELSE
717 ! this is the non-captain-minion mode way of executing the jobs
718 ! the i-th job in the input is always executed by the MODULO(i-1,ngroups)-th group
719 ! (needed for cyclic runs, we don't want two groups working on the same job)
720 IF (output_unit > 0) THEN
721 IF (ijob_end - ijob_start >= 0) THEN
722 WRITE (output_unit, fmt="(T2,A)") "FARMING| List of jobs : "
723 DO ijob = ijob_start, ijob_end
724 i = modulo(ijob - 1, farming_env%njobs) + 1
725 WRITE (output_unit, fmt=*) "Job: ", i, " Dir: ", trim(farming_env%Job(i)%cwd), " Input: ", &
726 trim(farming_env%Job(i)%input), " MPI group:", modulo(i - 1, ngroups)
727 END DO
728 END IF
729 CALL m_flush(output_unit)
730 END IF
731
732 DO ijob = ijob_start, ijob_end
733 i = modulo(ijob - 1, farming_env%njobs) + 1
734 ! this farms out the jobs
735 IF (modulo(i - 1, ngroups) == group_distribution(minion_rank)) THEN
736 IF (output_unit > 0) THEN
737 WRITE (output_unit, fmt="(T2,A,I5.5,A)", advance="NO") " Running Job ", i, &
738 " in "//trim(farming_env%Job(i)%cwd)//"."
739 CALL m_flush(output_unit)
740 END IF
741 CALL execute_job(i)
742 IF (output_unit > 0) THEN
743 WRITE (output_unit, fmt="(A)") " Done, output in "//trim(output_file)
744 CALL m_flush(output_unit)
745 END IF
746 END IF
747 END DO
748 END IF
749
750 ! keep information about how long each process has to wait
751 ! i.e. the load imbalance
752 t1 = m_walltime()
753 CALL para_env%sync()
754 t2 = m_walltime()
755 ALLOCATE (waittime(0:para_env%num_pe - 1))
756 waittime = 0.0_dp
757 waittime(para_env%mepos) = t2 - t1
758 CALL para_env%sum(waittime)
759 IF (output_unit > 0) THEN
760 WRITE (output_unit, '(T2,A)') "Process idle times [s] at the end of the run"
761 DO i = 0, para_env%num_pe - 1
762 WRITE (output_unit, fmt='(A2,I6,A3,F8.3,A1)', advance="NO") &
763 " (", i, " : ", waittime(i), ")"
764 IF (mod(i + 1, 4) == 0) WRITE (output_unit, '(A)') ""
765 END DO
766 CALL m_flush(output_unit)
767 END IF
768 DEALLOCATE (waittime)
769
770 ! give back the communicators of the split groups
771 IF (minion) CALL new_group%free()
772 CALL minion_group%free()
773
774 ! and message passing deallocate structures
775 DEALLOCATE (group_distribution)
776 DEALLOCATE (minion_distribution)
777
778 ! clean the farming env
779 CALL deallocate_farming_env(farming_env)
780
781 CALL cp_print_key_finished_output(output_unit, logger, root_section, &
782 "FARMING%PROGRAM_RUN_INFO")
783
784 CALL timestop(handle)
785
786 CONTAINS
787! **************************************************************************************************
788!> \brief ...
789!> \param i ...
790! **************************************************************************************************
791 RECURSIVE SUBROUTINE execute_job(i)
792 INTEGER :: i
793
794 ! change to the new working directory
795
796 CALL m_chdir(trim(farming_env%Job(i)%cwd), ierr)
797 IF (ierr /= 0) &
798 cpabort("Failed to change dir to: "//trim(farming_env%Job(i)%cwd))
799
800 ! generate a fresh call to cp2k_run
801 IF (new_rank == 0) THEN
802
803 IF (farming_env%Job(i)%output == "") THEN
804 ! generate the output file
805 WRITE (output_file, '(A12,I5.5)') "FARMING_OUT_", i
806 ALLOCATE (my_parser)
807 CALL parser_create(my_parser, file_name=trim(farming_env%Job(i)%input))
808 label = "&GLOBAL"
809 CALL parser_search_string(my_parser, label, ignore_case=.true., found=found)
810 IF (found) THEN
811 CALL create_global_section(g_section)
812 CALL section_vals_create(g_data, g_section)
813 CALL cp_unit_set_create(default_units, "OUTPUT")
814 CALL section_vals_parse(g_data, my_parser, default_units)
815 CALL cp_unit_set_release(default_units)
816 CALL section_vals_val_get(g_data, "PROJECT", &
817 c_val=str)
818 IF (str /= "") output_file = trim(str)//".out"
819 CALL section_vals_val_get(g_data, "OUTPUT_FILE_NAME", &
820 c_val=str)
821 IF (str /= "") output_file = str
822 CALL section_vals_release(g_data)
823 CALL section_release(g_section)
824 END IF
825 CALL parser_release(my_parser)
826 DEALLOCATE (my_parser)
827 ELSE
828 output_file = farming_env%Job(i)%output
829 END IF
830
831 CALL open_file(file_name=trim(output_file), &
832 file_action="WRITE", &
833 file_status="UNKNOWN", &
834 file_position="APPEND", &
835 unit_number=new_output_unit)
836 ELSE
837 ! this unit should be negative, otherwise all processors that get a default unit
838 ! start writing output (to the same file, adding to confusion).
839 ! error handling should be careful, asking for a local output unit if required
840 new_output_unit = -1
841 END IF
842
843 CALL cp2k_run(input_declaration, trim(farming_env%Job(i)%input), new_output_unit, new_group, initial_variables)
844
845 IF (new_rank == 0) CALL close_file(unit_number=new_output_unit)
846
847 ! change to the original working directory
848 CALL m_chdir(trim(farming_env%cwd), ierr)
849 cpassert(ierr == 0)
850
851 END SUBROUTINE execute_job
852 END SUBROUTINE farming_run
853
854! **************************************************************************************************
855!> \brief ...
856! **************************************************************************************************
857 SUBROUTINE write_xml_file()
858
859 INTEGER :: i, unit_number
860 TYPE(section_type), POINTER :: root_section
861
862 NULLIFY (root_section)
863 CALL create_cp2k_root_section(root_section)
864 CALL keyword_release(root_section%keywords(0)%keyword)
865 CALL open_file(unit_number=unit_number, &
866 file_name="cp2k_input.xml", &
867 file_action="WRITE", &
868 file_status="REPLACE")
869
870 WRITE (unit=unit_number, fmt="(A)") '<?xml version="1.0" encoding="utf-8"?>'
871
872 !MK CP2K input structure
873 WRITE (unit=unit_number, fmt="(A)") &
874 "<CP2K_INPUT>", &
875 " <CP2K_VERSION>"//trim(cp2k_version)//"</CP2K_VERSION>", &
876 " <CP2K_YEAR>"//trim(cp2k_year)//"</CP2K_YEAR>", &
877 " <COMPILE_DATE>"//trim(compile_date)//"</COMPILE_DATE>", &
878 " <COMPILE_REVISION>"//trim(compile_revision)//"</COMPILE_REVISION>"
879
880 CALL export_references_as_xml(unit_number)
881 CALL export_units_as_xml(unit_number)
882
883 DO i = 1, root_section%n_subsections
884 CALL write_section_xml(root_section%subsections(i)%section, 1, unit_number)
885 END DO
886
887 WRITE (unit=unit_number, fmt="(A)") "</CP2K_INPUT>"
888 CALL close_file(unit_number=unit_number)
889 CALL section_release(root_section)
890
891 END SUBROUTINE write_xml_file
892
893! **************************************************************************************************
894!> \brief runs the given input
895!> \param input_declaration ...
896!> \param input_file_path the path of the input file
897!> \param output_file_path path of the output file (to which it is appended)
898!> if it is "__STD_OUT__" the default_output_unit is used
899!> \param initial_variables key-value list of initial preprocessor variables
900!> \param mpi_comm the mpi communicator to be used for this environment
901!> it will not be freed
902!> \author fawzi
903!> \note
904!> moved here because of circular dependencies
905! **************************************************************************************************
906 SUBROUTINE run_input(input_declaration, input_file_path, output_file_path, initial_variables, mpi_comm)
907 TYPE(section_type), POINTER :: input_declaration
908 CHARACTER(len=*), INTENT(in) :: input_file_path, output_file_path
909 CHARACTER(len=default_path_length), &
910 DIMENSION(:, :), INTENT(IN) :: initial_variables
911 TYPE(mp_comm_type), INTENT(in), OPTIONAL :: mpi_comm
912
913 INTEGER :: unit_nr
914 TYPE(mp_para_env_type), POINTER :: para_env
915
916 IF (PRESENT(mpi_comm)) THEN
917 ALLOCATE (para_env)
918 para_env = mpi_comm
919 ELSE
920 para_env => f77_default_para_env
921 CALL para_env%retain()
922 END IF
923 IF (para_env%is_source()) THEN
924 IF (output_file_path == "__STD_OUT__") THEN
925 unit_nr = default_output_unit
926 ELSE
927 INQUIRE (file=output_file_path, number=unit_nr)
928 END IF
929 ELSE
930 unit_nr = -1
931 END IF
932 CALL cp2k_run(input_declaration, input_file_path, unit_nr, para_env, initial_variables)
933 CALL mp_para_env_release(para_env)
934 END SUBROUTINE run_input
935
936END MODULE cp2k_runs
static GRID_HOST_DEVICE int modulo(int a, int m)
Equivalent of Fortran's MODULO, which always return a positive number. https://gcc....
void apply_cutoff(void *ptr)
void grid_library_set_config(const enum grid_backend backend, const bool validate, const bool apply_cutoff)
Configures the grid library.
void grid_library_print_stats(const int fortran_comm, void(*print_func)(const char *, int, int), const int output_unit)
Prints statistics gathered by the grid library.
Definition atom.F:9
subroutine, public atom_code(root_section)
Driver routine to perform atomic calculations.
Definition atom.F:46
collects all references to literature in CP2K as new algorithms / method are included from literature...
integer, save, public hutter2014
Module to perform a counterpoise correction (BSSE)
Definition bsse.F:14
subroutine, public do_bsse_calculation(force_env, globenv)
Perform an COUNTERPOISE CORRECTION (BSSE) For a 2-body system the correction scheme can be represente...
Definition bsse.F:80
performs CELL optimization
Definition cell_opt.F:13
subroutine, public cp_cell_opt(force_env, globenv)
Main driver to perform geometry optimization.
Definition cell_opt.F:56
Debug energy and derivatives w.r.t. finite differences.
Definition cp2k_debug.F:26
subroutine, public cp2k_debug_energy_and_forces(force_env)
...
Definition cp2k_debug.F:76
some minimal info about CP2K, including its version and license
Definition cp2k_info.F:16
character(len= *), parameter, public compile_revision
Definition cp2k_info.F:39
character(len= *), parameter, public compile_date
Definition cp2k_info.F:57
character(len= *), parameter, public cp2k_year
Definition cp2k_info.F:44
character(len= *), parameter, public cp2k_version
Definition cp2k_info.F:43
subroutine, public run_input(input_declaration, input_file_path, output_file_path, initial_variables, mpi_comm)
runs the given input
Definition cp2k_runs.F:907
subroutine, public write_xml_file()
...
Definition cp2k_runs.F:858
Defines control structures, which contain the parameters and the settings for the DFT-based calculati...
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 ...
logical function, public cp_logger_would_log(logger, level)
this function can be called to check if the logger would log a message with the given level from the ...
integer, parameter, public cp_note_level
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,...
subroutine, public cp_rm_iter_level(iteration_info, level_name, n_rlevel_att)
Removes an iteration level.
subroutine, public cp_add_iter_level(iteration_info, level_name, n_rlevel_new)
Adds an iteration level.
Utility routines to read data from files. Kept as close as possible to the old parser because.
subroutine, public parser_search_string(parser, string, ignore_case, found, line, begin_line, search_from_begin_of_file)
Search a string pattern in a file defined by its logical unit number "unit". A case sensitive search ...
Utility routines to read data from files. Kept as close as possible to the old parser because.
subroutine, public parser_release(parser)
releases the parser
subroutine, public parser_create(parser, file_name, unit_nr, para_env, end_section_label, separator_chars, comment_char, continuation_char, quote_char, section_char, parse_white_lines, initial_variables, apply_preprocessing)
Start a parser run. Initial variables allow to @SET stuff before opening the file.
unit conversion facility
Definition cp_units.F:30
subroutine, public cp_unit_set_release(unit_set)
releases the given unit set
Definition cp_units.F:1298
subroutine, public cp_unit_set_create(unit_set, name)
initializes the given unit set
Definition cp_units.F:1227
subroutine, public export_units_as_xml(iw)
Exports all available units as XML.
Definition cp_units.F:1315
subroutine validate(matrix)
Dummy for when DBM_VALIDATE_AGAINST_DBCSR is not defined.
Definition dbm_api.F:250
subroutine, public dbm_library_print_stats(mpi_comm, output_unit)
Print DBM library statistics.
Definition dbm_api.F:1512
Sets up and terminates the global environment variables.
Definition environment.F:17
subroutine, public cp2k_finalize(root_section, para_env, globenv, wdir, q_finalize)
Writes final timings and banner for CP2K.
subroutine, public cp2k_read(root_section, para_env, globenv)
read part of cp2k_init
subroutine, public cp2k_init(para_env, output_unit, globenv, input_file_name, wdir)
Initializes a CP2K run (setting of the global environment variables)
subroutine, public cp2k_setup(root_section, para_env, globenv)
globenv initializations that need the input and error
interface to use cp2k as library
recursive subroutine, public destroy_force_env(env_id, ierr, q_finalize)
deallocates the force_env with the given id
subroutine, public f_env_add_defaults(f_env_id, f_env, handle)
adds the default environments of the f_env to the stack of the defaults, and returns a new error and ...
type(mp_para_env_type), pointer, save, public default_para_env
recursive subroutine, public create_force_env(new_env_id, input_declaration, input_path, output_path, mpi_comm, output_unit, owns_out_unit, input, ierr, work_dir, initial_variables)
creates a new force environment using the given input, and writing the output to the given output uni...
subroutine, public f_env_rm_defaults(f_env, ierr, handle)
removes the default environments of the f_env to the stack of the defaults, and sets ierr accordingly...
recursive subroutine, public calc_force(env_id, pos, n_el_pos, e_pot, force, n_el_force, ierr)
returns the energy of the configuration given by the positions passed as argument
subroutine, public farming_parse_input(farming_env, root_section, para_env)
...
integer, parameter, public do_nothing
integer, parameter, public do_wait
subroutine, public get_next_job(farming_env, start, end, current, todo)
...
integer, parameter, public do_deadlock
subroutine, public deallocate_farming_env(farming_env)
deallocates all associated fields of the farming_env type and the type itself
integer, parameter, public job_finished
integer, parameter, public job_running
subroutine, public init_farming_env(farming_env)
help poor compilers do their job i.e. provide a default initialization
Interface for the force calculations.
recursive subroutine, public force_env_calc_energy_force(force_env, calc_force, consistent_energies, skip_external_control, eval_energy_forces, require_consistent_energy_force, linres, calc_stress_tensor)
Interface routine for force and energy calculations.
Interface for the force calculations.
recursive subroutine, public force_env_get(force_env, in_use, fist_env, qs_env, meta_env, fp_env, subsys, para_env, potential_energy, additional_potential, kinetic_energy, harmonic_shell, kinetic_shell, cell, sub_force_env, qmmm_env, qmmmx_env, eip_env, pwdft_env, globenv, input, force_env_section, method_name_id, root_section, mixed_env, nnp_env, embed_env, ipi_env)
returns various attributes about the force environment
performs geometry optimization
Definition geo_opt.F:13
subroutine, public cp_geo_opt(force_env, globenv, eval_opt_geo, rm_restart_info)
Main driver to perform geometry optimization.
Definition geo_opt.F:58
Define type storing the global information of a run. Keep the amount of stored data small....
subroutine, public globenv_create(globenv)
Creates the global environment globenv.
subroutine, public globenv_release(globenv)
Releases the global environment globenv.
Fortran API for the grid package, which is written in C.
Definition grid_api.F:12
collects all constants needed in input so that they can be used without circular dependencies
integer, parameter, public driver_run
integer, parameter, public energy_run
integer, parameter, public do_farming
integer, parameter, public do_nnp
integer, parameter, public do_cp2k
integer, parameter, public linear_response_run
integer, parameter, public do_tamc
integer, parameter, public ehrenfest
integer, parameter, public do_opt_basis
integer, parameter, public debug_run
integer, parameter, public do_test
integer, parameter, public do_fist
integer, parameter, public do_qmmm
integer, parameter, public do_embed
integer, parameter, public do_sirius
integer, parameter, public do_band
integer, parameter, public do_tree_mc
integer, parameter, public bsse_run
integer, parameter, public energy_force_run
integer, parameter, public rtp_method_bse
integer, parameter, public do_optimize_input
integer, parameter, public do_atom
integer, parameter, public mon_car_run
integer, parameter, public do_tree_mc_ana
integer, parameter, public mol_dyn_run
integer, parameter, public cell_opt_run
integer, parameter, public pint_run
integer, parameter, public vib_anal
integer, parameter, public none_run
integer, parameter, public negf_run
integer, parameter, public do_qs
integer, parameter, public do_mixed
integer, parameter, public do_ipi
integer, parameter, public tree_mc_run
integer, parameter, public real_time_propagation
integer, parameter, public geo_opt_run
integer, parameter, public do_swarm
checks the input and perform some automatic "magic" on it
subroutine, public check_cp2k_input(input_declaration, input_file, para_env, output_unit)
performs further checks on an input that parsed successfully
builds the global input section for cp2k
subroutine, public create_global_section(section)
section to hold global settings for the whole program
parse cp2k input files
type(section_vals_type) function, pointer, public read_input(input_declaration, file_path, initial_variables, para_env)
reads the cp2k input from the given filepath and returns a section_vals containing the input
builds the input structure for cp2k
Definition input_cp2k.F:14
subroutine, public create_cp2k_root_section(root_section)
creates the input structure of the file used by cp2k
Definition input_cp2k.F:75
represents keywords in an input
subroutine, public keyword_release(keyword)
releases the given keyword (see doc/ReferenceCounting.html)
routines that parse the input
recursive subroutine, public section_vals_parse(section_vals, parser, default_units, root_section)
...
objects that represent the structure of input sections and the data contained in an input section
recursive subroutine, public write_section_xml(section, level, unit_number)
writes the values in the given section in xml
recursive subroutine, public section_vals_create(section_vals, section)
creates a object where to store the values of a section
subroutine, public section_vals_retain(section_vals)
retains the given section values (see doc/ReferenceCounting.html)
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
recursive subroutine, public section_release(section)
releases the given keyword list (see doc/ReferenceCounting.html)
recursive subroutine, public section_vals_write(section_vals, unit_nr, hide_root, hide_defaults)
writes the values in the given section in a way that is suitable to the automatic parsing
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
recursive subroutine, public section_vals_release(section_vals)
releases the given object
Driver mode - To communicate with i-PI Python wrapper.
Definition ipi_driver.F:14
subroutine, public run_driver(force_env, globenv)
...
Definition ipi_driver.F:76
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
integer, parameter, public default_string_length
Definition kinds.F:57
integer, parameter, public default_path_length
Definition kinds.F:58
Performance tests for basic tasks like matrix multiplies, copy, fft.
subroutine, public lib_test(root_section, para_env, globenv)
Master routine for tests.
Machine interface based on Fortran 2003 and POSIX.
Definition machine.F:17
integer, parameter, public default_output_unit
Definition machine.F:58
subroutine, public m_memory(mem)
Returns the total amount of memory [bytes] in use, if known, zero otherwise.
Definition machine.F:456
subroutine, public m_flush(lunit)
flushes units if the &GLOBAL flag is set accordingly
Definition machine.F:136
subroutine, public m_getcwd(curdir)
...
Definition machine.F:629
subroutine, public m_chdir(dir, ierror)
...
Definition machine.F:658
integer(kind=int_8), save, public m_memory_max
Definition machine.F:123
real(kind=dp) function, public m_walltime()
returns time from a real-time clock, protected against rolling early/easily
Definition machine.F:153
preps the system for a Monte Carlo run (sets up some environments, calls the routines to read in the ...
Definition mc_run.F:40
subroutine, public do_mon_car(force_env_1, globenv, input_declaration, input_file_name)
starts the Monte Carlo simulation and determines which ensemble we're running
Definition mc_run.F:103
Perform a molecular dynamics (MD) run using QUICKSTEP.
Definition md_run.F:14
subroutine, public qs_mol_dyn(force_env, globenv, averages, rm_restart_info, hmc_e_initial, hmc_e_final, mdctrl)
Main driver module for Molecular Dynamics.
Definition md_run.F:121
Interface to the message passing library MPI.
subroutine, public mp_para_env_release(para_env)
releases the para object (to be called when you don't want anymore the shared copy of this object)
integer, parameter, public mp_any_source
Subroutines to perform calculations on molecules from a bigger system. Useful to generate a high-qual...
subroutine, public loop_over_molecules(globenv, force_env)
Prepare data for calculations on isolated molecules.
logical function, public do_mol_loop(force_env)
Is the loop over molecules requested?
Module performing a Nudged Elastic Band Calculation.
Definition neb_methods.F:23
subroutine, public neb(input, input_declaration, para_env, globenv)
Real subroutine for NEB calculations.
Definition neb_methods.F:93
NEGF based quantum transport calculations.
subroutine, public do_negf(force_env)
Perform NEGF calculation.
Fortran API for the offload package, which is written in C.
Definition offload_api.F:12
integer function, public offload_get_device_count()
Returns the number of available devices.
subroutine, public offload_mempool_stats_print(mpi_comm, output_unit)
Print allocation statistics.
integer function, public offload_get_chosen_device()
Returns the chosen device.
subroutine, public run_optimize_basis(input_declaration, root_section, para_env)
main entry point for methods aimed at optimizing basis sets
subroutine, public run_optimize_input(input_declaration, root_section, para_env)
main entry point for methods aimed at optimizing parameters in a CP2K input file
Methods to performs a path integral run.
subroutine, public do_pint_run(para_env, input, input_declaration, globenv)
Perform a path integral simulation.
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, 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.
Contains the setup for the calculation of properties by linear response by the application of second ...
subroutine, public linres_calculation(force_env)
Driver for the linear response calculatios.
provides a uniform framework to add references to CP2K cite and output these
subroutine, public cite_reference(key)
marks a given reference as cited.
subroutine, public export_references_as_xml(unit)
Exports all references as XML.
Routines for the propagation via RT-BSE method.
Definition rt_bse.F:14
subroutine, public run_propagation_bse(qs_env, force_env)
Runs the electron-only real time BSE propagation.
Definition rt_bse.F:142
Routines for the real time propagation.
subroutine, public rt_prop_setup(force_env)
creates rtp_type, gets the initial state, either by reading MO's from file or calling SCF run
Swarm-framwork, provides a convenient master/worker architecture.
Definition swarm.F:12
subroutine, public run_swarm(input_declaration, root_section, para_env, globenv, input_path)
Central driver routine of the swarm framework, called by cp2k_runs.F.
Definition swarm.F:62
Perform a temperature accelarated hybrid monte carlo (TAHMC) run using QUICKSTEP.
Definition tamc_run.F:14
subroutine, public qs_tamc(force_env, globenv, averages)
Driver routine for TAHMC.
Definition tamc_run.F:147
Tree Monte Carlo entry point, set up, CPU redistribution and input reading.
Definition tmc_setup.F:16
subroutine, public do_analyze_files(input_declaration, root_section, para_env)
analyze TMC trajectory files
Definition tmc_setup.F:348
subroutine, public do_tmc(input_declaration, root_section, para_env, globenv)
tmc_entry point
Definition tmc_setup.F:98
Module performing a vibrational analysis.
subroutine, public vb_anal(input, input_declaration, para_env, globenv)
Module performing a vibrational analysis.
type of a logger, at the moment it contains just a print level starting at which level it should be l...
stores the default units to be used
Definition cp_units.F:149
wrapper to abstract the force evaluation of the various methods
contains the initially parsed file and the initial parallel environment
represent a section of the input file
stores all the informations relevant to an mpi environment