43 dbt_create, dbt_default_distvec, dbt_destroy, dbt_distribution_destroy, &
44 dbt_distribution_new, dbt_distribution_type, dbt_mp_dims_create, dbt_pgrid_create, &
45 dbt_pgrid_destroy, dbt_pgrid_type, dbt_type
91#include "./base/base_uses.f90"
113#define CACHE_SIZE 1024
114#define BITS_MAX_VAL 6
116 CHARACTER(len=*),
PARAMETER,
PRIVATE :: moduleN =
'hfx_types'
121 REAL(kind=
dp),
DIMENSION(0:10), &
122 PARAMETER,
PUBLIC ::
mul_fact = (/1.0_dp, &
141 REAL(
dp) :: omega = 0.0_dp
142 REAL(
dp) :: scale_coulomb = 0.0_dp
143 REAL(
dp) :: scale_longrange = 0.0_dp
144 REAL(
dp) :: scale_gaussian = 0.0_dp
145 REAL(
dp) :: cutoff_radius = 0.0_dp
146 CHARACTER(default_path_length) :: filename =
""
151 REAL(
dp) :: eps_schwarz = 0.0_dp
152 REAL(
dp) :: eps_schwarz_forces = 0.0_dp
153 LOGICAL :: do_p_screening_forces = .false.
154 LOGICAL :: do_initial_p_screening = .false.
159 INTEGER :: max_memory = 0
160 INTEGER(int_8) :: max_compression_counter = 0_int_8
161 INTEGER(int_8) :: final_comp_counter_energy = 0_int_8
162 LOGICAL :: do_all_on_the_fly = .false.
163 REAL(
dp) :: eps_storage_scaling = 0.0_dp
164 INTEGER :: cache_size = 0
165 INTEGER :: bits_max_val = 0
166 INTEGER :: actual_memory_usage = 0
167 INTEGER :: actual_memory_usage_disk = 0
168 INTEGER(int_8) :: max_compression_counter_disk = 0_int_8
169 LOGICAL :: do_disk_storage = .false.
170 CHARACTER(len=default_path_length) :: storage_location =
""
171 INTEGER(int_8) :: ram_counter = 0_int_8
172 INTEGER(int_8) :: ram_counter_forces = 0_int_8
173 INTEGER(int_8) :: size_p_screen = 0_int_8
174 LOGICAL :: treat_forces_in_core = .false.
175 LOGICAL :: recalc_forces = .false.
179 TYPE hfx_periodic_type
180 INTEGER :: number_of_shells = -1
181 LOGICAL :: do_periodic = .false.
182 INTEGER :: perd(3) = -1
184 REAL(
dp) :: r_max_stress = 0.0_dp
185 INTEGER :: number_of_shells_from_input = 0
191 INTEGER :: block_size = 0
192 INTEGER :: nblocks = 0
193 LOGICAL :: rtp_redistribute = .false.
194 LOGICAL :: blocks_initialized = .false.
195 LOGICAL :: do_randomize = .false.
200 REAL(
dp) :: fraction = 0.0_dp
201 LOGICAL :: treat_lsd_in_core = .false.
206 REAL(
dp) :: cell(3) = 0.0_dp
207 REAL(
dp) :: cell_r(3) = 0.0_dp
212 INTEGER(int_8) :: istart = 0_int_8
213 INTEGER(int_8) :: number_of_atom_quartets = 0_int_8
214 INTEGER(int_8) :: cost = 0_int_8
215 REAL(kind=
dp) :: time_first_scf = 0.0_dp
216 REAL(kind=
dp) :: time_other_scf = 0.0_dp
217 REAL(kind=
dp) :: time_forces = 0.0_dp
218 INTEGER(int_8) :: ram_counter = 0_int_8
223 INTEGER,
DIMENSION(2) :: pair = 0
224 INTEGER,
DIMENSION(2) :: set_bounds = 0
225 INTEGER,
DIMENSION(2) :: kind_pair = 0
226 REAL(kind=
dp) :: r1(3) = 0.0_dp, r2(3) = 0.0_dp
227 REAL(kind=
dp) :: dist2 = 0.0_dp
232 INTEGER,
DIMENSION(2) :: pair = 0
238 INTEGER :: n_element = 0
243 INTEGER(int_8),
DIMENSION(CACHE_SIZE) :: data = 0_int_8
244 INTEGER :: element_counter = 0
248 TYPE hfx_container_node
249 TYPE(hfx_container_node),
POINTER :: next => null(), prev => null()
250 INTEGER(int_8),
DIMENSION(CACHE_SIZE) :: data = 0_int_8
255 TYPE(hfx_container_node),
POINTER :: first => null(), current => null()
256 INTEGER :: element_counter = 0
257 INTEGER(int_8) :: file_counter = 0
258 CHARACTER(LEN=5) :: desc =
""
260 CHARACTER(default_path_length) :: filename =
""
265 INTEGER,
DIMENSION(:),
POINTER :: lmax => null()
266 INTEGER,
DIMENSION(:),
POINTER :: lmin => null()
267 INTEGER,
DIMENSION(:),
POINTER :: npgf => null()
269 REAL(
dp),
DIMENSION(:, :),
POINTER :: zet => null()
270 INTEGER,
DIMENSION(:),
POINTER :: nsgf => null()
271 INTEGER,
DIMENSION(:, :),
POINTER :: first_sgf => null()
272 REAL(
dp),
DIMENSION(:, :),
POINTER :: sphi => null()
273 INTEGER :: nsgf_total = 0
274 INTEGER,
DIMENSION(:, :),
POINTER :: nl => null()
275 INTEGER,
DIMENSION(:, :),
POINTER :: nsgfl => null()
276 INTEGER,
DIMENSION(:),
POINTER :: nshell => null()
277 REAL(
dp),
DIMENSION(:, :, :, :),
POINTER &
278 :: sphi_ext => null()
279 REAL(
dp),
DIMENSION(:),
POINTER :: set_radius => null()
280 REAL(
dp),
DIMENSION(:, :),
POINTER :: pgf_radius => null()
281 REAL(
dp) :: kind_radius = 0.0_dp
286 INTEGER :: max_set = 0
287 INTEGER :: max_sgf = 0
288 INTEGER :: max_am = 0
293 REAL(
dp) :: x(2) = 0.0_dp
298 REAL(
dp),
DIMENSION(:, :, :, :),
POINTER :: p_kind => null()
303 INTEGER,
DIMENSION(:),
POINTER :: iatom_list => null()
304 INTEGER,
DIMENSION(:),
POINTER :: jatom_list => null()
309 REAL(
dp) :: ra(3) = 0.0_dp, rb(3) = 0.0_dp
310 REAL(
dp) :: rab2 = 0.0_dp
311 REAL(
dp) :: s1234 = 0.0_dp
312 REAL(
dp) :: p(3) = 0.0_dp
313 REAL(
dp) :: r = 0.0_dp
314 REAL(
dp) :: pgf_max = 0.0_dp
315 REAL(
dp),
DIMENSION(3) :: bcell = 0.0_dp
320 TYPE(hfx_pgf_image),
DIMENSION(:),
POINTER &
321 :: image_list => null()
322 INTEGER :: nimages = 0
323 REAL(
dp) :: zetapzetb = 0.0_dp
324 REAL(
dp) :: zetainv = 0.0_dp
325 REAL(
dp) :: zeta = 0.0_dp, zetb = 0.0_dp
326 INTEGER :: ipgf = 0, jpgf = 0
331 REAL(
dp) :: ra(3) = 0.0_dp, rb(3) = 0.0_dp, rc(3) = 0.0_dp, rd(3) = 0.0_dp
332 REAL(
dp) :: zetapetainv = 0.0_dp
333 REAL(
dp) :: rho = 0.0_dp, rhoinv = 0.0_dp
334 REAL(
dp) :: p(3) = 0.0_dp, q(3) = 0.0_dp, w(3) = 0.0_dp
335 REAL(
dp) :: ab(3) = 0.0_dp, cd(3) = 0.0_dp
341 INTEGER :: istart = 0, iend = 0
342 INTEGER(int_8) :: cost = 0_int_8
347 INTEGER :: thread_id = 0
348 INTEGER :: bin_id = 0
349 INTEGER(int_8) :: cost = 0_int_8
354 POINTER :: maxval_container => null()
356 POINTER :: maxval_cache => null()
358 POINTER :: integral_containers => null()
360 POINTER :: integral_caches => null()
365 DIMENSION(:) :: integral_containers_disk => null()
369 INTEGER,
DIMENSION(:, :),
ALLOCATABLE :: ind
374 REAL(kind=
dp) :: filter_eps = 0.0_dp, filter_eps_2c = 0.0_dp, filter_eps_storage = 0.0_dp, filter_eps_mo = 0.0_dp, &
375 eps_lanczos = 0.0_dp, eps_pgf_orb = 0.0_dp, eps_eigval = 0.0_dp, kp_ri_range = 0.0_dp, &
376 kp_image_range = 0.0_dp, kp_bump_rad = 0.0_dp
377 INTEGER :: t2c_sqrt_order = 0, max_iter_lanczos = 0, flavor = 0, unit_nr_dbcsr = -1, unit_nr = -1, &
378 min_bsize = 0, max_bsize_mo = 0, t2c_method = 0, nelectron_total = 0, input_flavor = 0, &
379 ncell_ri = 0, nimg = 0, kp_stack_size = 0, nimg_nze = 0, kp_ngroups = 1
380 LOGICAL :: check_2c_inv = .false., calc_condnum = .false.
386 REAL(kind=
dp) :: eps_schwarz = 0.0_dp
387 REAL(kind=
dp) :: eps_schwarz_forces = 0.0_dp
389 LOGICAL :: same_op = .false.
392 TYPE(dbt_pgrid_type),
POINTER :: pgrid => null()
393 TYPE(dbt_pgrid_type),
POINTER :: pgrid_2d => null()
397 TYPE(dbt_distribution_type) :: dist
400 INTEGER,
DIMENSION(:),
ALLOCATABLE :: bsizes_ri, bsizes_ao, bsizes_ri_split, bsizes_ao_split, &
401 bsizes_ri_fit, bsizes_ao_fit
404 INTEGER,
DIMENSION(:),
ALLOCATABLE :: img_to_ri_cell, present_images, idx_to_img, img_to_idx, &
408 REAL(
dp),
DIMENSION(:, :, :),
ALLOCATABLE :: kp_cost
414 TYPE(dbt_type),
DIMENSION(:),
ALLOCATABLE :: kp_t_3c_int
420 TYPE(dbt_type),
DIMENSION(:, :),
ALLOCATABLE :: rho_ao_t, ks_t
423 TYPE(dbt_type),
DIMENSION(:, :),
ALLOCATABLE :: t_2c_inv
424 TYPE(dbt_type),
DIMENSION(:, :),
ALLOCATABLE :: t_2c_pot
427 TYPE(
dbcsr_type),
DIMENSION(:, :),
ALLOCATABLE :: kp_mat_2c_pot
430 TYPE(dbt_type),
DIMENSION(:, :),
ALLOCATABLE :: t_2c_int
433 TYPE(dbt_type),
DIMENSION(:, :),
ALLOCATABLE :: t_3c_int_ctr_1
435 TYPE(dbt_pgrid_type),
POINTER :: pgrid_1 => null()
438 TYPE(dbt_type),
DIMENSION(:, :),
ALLOCATABLE :: t_3c_int_ctr_2
439 TYPE(dbt_pgrid_type),
POINTER :: pgrid_2 => null()
442 TYPE(dbt_type),
DIMENSION(:, :),
ALLOCATABLE :: t_3c_int_ctr_3
445 TYPE(dbt_type),
DIMENSION(:, :, :),
ALLOCATABLE :: t_3c_int_mo
446 TYPE(dbt_type),
DIMENSION(:, :, :),
ALLOCATABLE :: t_3c_ctr_ri
447 TYPE(dbt_type),
DIMENSION(:, :, :),
ALLOCATABLE :: t_3c_ctr_ks
448 TYPE(dbt_type),
DIMENSION(:, :, :),
ALLOCATABLE :: t_3c_ctr_ks_copy
456 CHARACTER(len=default_string_length) :: orb_basis_type =
"", ri_basis_type =
""
459 INTEGER :: n_mem_input = 0, n_mem = 0, n_mem_ri = 0, n_mem_flavor_switch = 0
462 INTEGER,
DIMENSION(:),
ALLOCATABLE :: starts_array_mem_block, ends_array_mem_block
463 INTEGER,
DIMENSION(:),
ALLOCATABLE :: starts_array_mem, ends_array_mem
465 INTEGER,
DIMENSION(:),
ALLOCATABLE :: starts_array_ri_mem_block, ends_array_ri_mem_block
466 INTEGER,
DIMENSION(:),
ALLOCATABLE :: starts_array_ri_mem, ends_array_ri_mem
468 INTEGER(int_8) :: dbcsr_nflop = 0_int_8
469 REAL(
dp) :: dbcsr_time = 0.0_dp
470 INTEGER :: num_pe = 0
514 TYPE(hfx_periodic_type) :: periodic_parameter = hfx_periodic_type()
522 POINTER :: neighbor_cells => null()
524 POINTER :: distribution_energy => null()
526 POINTER :: distribution_forces => null()
527 INTEGER,
DIMENSION(:, :),
POINTER :: is_assoc_atomic_block => null()
528 INTEGER :: number_of_p_entries = 0
530 POINTER :: basis_parameter => null()
531 INTEGER :: n_rep_hf = 0
532 LOGICAL :: b_first_load_balance_energy = .false., &
533 b_first_load_balance_forces = .false.
534 REAL(
dp),
DIMENSION(:, :),
POINTER :: full_ks_alpha => null()
535 REAL(
dp),
DIMENSION(:, :),
POINTER :: full_ks_beta => null()
539 DIMENSION(:, :, :, :, :, :),
POINTER :: screen_funct_coeffs_pgf => null(), &
540 pair_dist_radii_pgf => null()
542 DIMENSION(:, :, :, :),
POINTER :: screen_funct_coeffs_set => null()
544 DIMENSION(:, :),
POINTER :: screen_funct_coeffs_kind => null()
545 LOGICAL :: screen_funct_is_initialized = .false.
546 TYPE(
hfx_p_kind),
DIMENSION(:),
POINTER :: initial_p => null()
547 TYPE(
hfx_p_kind),
DIMENSION(:),
POINTER :: initial_p_forces => null()
548 INTEGER,
DIMENSION(:),
POINTER :: map_atom_to_kind_atom => null()
549 TYPE(
hfx_2d_map),
DIMENSION(:),
POINTER :: map_atoms_to_cpus => null()
550 INTEGER,
DIMENSION(:, :),
POINTER :: atomic_block_offset => null()
551 INTEGER,
DIMENSION(:, :, :, :),
POINTER :: set_offset => null()
552 INTEGER,
DIMENSION(:),
POINTER :: block_offset => null()
554 POINTER :: blocks => null()
556 POINTER :: task_list => null()
557 REAL(
dp),
DIMENSION(:, :),
POINTER :: pmax_atom => null(), pmax_atom_forces => null()
559 REAL(
dp),
DIMENSION(:, :),
POINTER :: pmax_block => null()
560 LOGICAL,
DIMENSION(:, :),
POINTER :: atomic_pair_list => null()
561 LOGICAL,
DIMENSION(:, :),
POINTER :: atomic_pair_list_forces => null()
562 LOGICAL :: do_hfx_ri = .false.
592 SUBROUTINE hfx_create(x_data, para_env, hfx_section, atomic_kind_set, qs_kind_set, &
593 particle_set, dft_control, cell, orb_basis, ri_basis, &
594 nelectron_total, nkp_grid)
595 TYPE(
hfx_type),
DIMENSION(:, :),
POINTER :: x_data
599 TYPE(
qs_kind_type),
DIMENSION(:),
POINTER :: qs_kind_set
603 CHARACTER(LEN=*),
OPTIONAL :: orb_basis, ri_basis
604 INTEGER,
OPTIONAL :: nelectron_total
605 INTEGER,
DIMENSION(3),
OPTIONAL :: nkp_grid
607 CHARACTER(LEN=*),
PARAMETER :: routinen =
'hfx_create'
609 CHARACTER(LEN=512) :: error_msg
610 CHARACTER(LEN=default_path_length) :: char_val
611 CHARACTER(LEN=default_string_length) :: orb_basis_type, ri_basis_type
612 INTEGER :: handle, i, i_thread, iatom, ikind, int_val, irep, jkind, max_set, n_rep_hf, &
613 n_threads, natom, natom_a, natom_b, nkind, nseta, nsetb, pbc_shells, storage_id
614 INTEGER,
ALLOCATABLE,
DIMENSION(:) :: atom2kind, kind_of
615 LOGICAL :: do_ri, explicit, logic_val
617 TYPE(
hfx_type),
POINTER :: actual_x_data
621 CALL timeset(routinen, handle)
626 natom =
SIZE(particle_set)
634 IF (do_ri) n_threads = 1
636 IF (
PRESENT(orb_basis))
THEN
637 orb_basis_type = orb_basis
639 orb_basis_type =
"ORB"
641 IF (
PRESENT(ri_basis))
THEN
642 ri_basis_type = ri_basis
644 ri_basis_type =
"RI_HFX"
647 ALLOCATE (x_data(n_rep_hf, n_threads))
648 DO i_thread = 1, n_threads
649 DO irep = 1, n_rep_hf
650 actual_x_data => x_data(irep, i_thread)
655 actual_x_data%general_parameter%fraction = real_val
656 actual_x_data%n_rep_hf = n_rep_hf
658 NULLIFY (actual_x_data%map_atoms_to_cpus)
660 CALL section_vals_val_get(hfx_section,
"TREAT_LSD_IN_CORE", l_val=logic_val, i_rep_section=irep)
661 actual_x_data%general_parameter%treat_lsd_in_core = logic_val
664 CALL section_vals_val_get(hfx_ri_section,
"_SECTION_PARAMETERS_", l_val=actual_x_data%do_hfx_ri)
668 CALL parse_memory_section(actual_x_data%memory_parameter, hf_sub_section, storage_id, i_thread, &
669 n_threads, para_env, irep, skip_disk=.false., skip_in_core_forces=.false.)
674 actual_x_data%periodic_parameter%number_of_shells = int_val
675 actual_x_data%periodic_parameter%mode = int_val
676 CALL get_cell(cell=cell, periodic=actual_x_data%periodic_parameter%perd)
677 IF (sum(actual_x_data%periodic_parameter%perd) == 0)
THEN
678 actual_x_data%periodic_parameter%do_periodic = .false.
680 actual_x_data%periodic_parameter%do_periodic = .true.
686 actual_x_data%screening_parameter%eps_schwarz = real_val
687 CALL section_vals_val_get(hf_sub_section,
"EPS_SCHWARZ_FORCES", r_val=real_val, explicit=explicit)
689 actual_x_data%screening_parameter%eps_schwarz_forces = real_val
691 actual_x_data%screening_parameter%eps_schwarz_forces = &
692 100._dp*actual_x_data%screening_parameter%eps_schwarz
695 actual_x_data%screening_parameter%do_p_screening_forces = logic_val
697 actual_x_data%screening_parameter%do_initial_p_screening = logic_val
698 actual_x_data%screen_funct_is_initialized = .false.
703 actual_x_data%potential_parameter%potential_type = int_val
705 actual_x_data%potential_parameter%omega = real_val
707 actual_x_data%potential_parameter%scale_coulomb = real_val
709 actual_x_data%potential_parameter%scale_longrange = real_val
711 actual_x_data%potential_parameter%scale_gaussian = real_val
715 actual_x_data%potential_parameter%cutoff_radius = real_val
720 WRITE (error_msg,
'(A,A,A)')
"Truncated hfx calculation requested. The file containing "// &
721 "the data could not be found at ", trim(char_val),
" Please check T_C_G_DATA "// &
722 "in the INTERACTION_POTENTIAL section"
725 actual_x_data%potential_parameter%filename = char_val
729 CALL erfc_cutoff(actual_x_data%screening_parameter%eps_schwarz, &
730 actual_x_data%potential_parameter%omega, &
731 actual_x_data%potential_parameter%cutoff_radius)
733 IF (actual_x_data%potential_parameter%potential_type ==
do_potential_id)
THEN
734 actual_x_data%potential_parameter%cutoff_radius = 0.0_dp
740 actual_x_data%load_balance_parameter%nbins = max(1, int_val)
741 actual_x_data%load_balance_parameter%blocks_initialized = .false.
744 actual_x_data%load_balance_parameter%do_randomize = logic_val
746 actual_x_data%load_balance_parameter%rtp_redistribute = .false.
747 IF (
ASSOCIATED(dft_control%rtp_control)) &
748 actual_x_data%load_balance_parameter%rtp_redistribute = dft_control%rtp_control%hfx_redistribute
752 IF (int_val <= 0)
THEN
754 int_val = ceiling(0.1_dp*natom/ &
755 REAL(actual_x_data%load_balance_parameter%nbins*n_threads*para_env%num_pe, kind=
dp)**(0.25_dp))
758 actual_x_data%load_balance_parameter%block_size = min(
max_atom_block, max(1, int_val))
860 IF (actual_x_data%periodic_parameter%do_periodic)
THEN
863 actual_x_data%periodic_parameter%number_of_shells_from_input = pbc_shells
864 ALLOCATE (actual_x_data%neighbor_cells(1))
867 ALLOCATE (actual_x_data%neighbor_cells(1))
869 actual_x_data%periodic_parameter%R_max_stress = 1.0_dp
872 nkind =
SIZE(qs_kind_set, 1)
873 max_set = actual_x_data%basis_info%max_set
876 IF (i_thread == 1)
THEN
877 ALLOCATE (actual_x_data%is_assoc_atomic_block(natom, natom))
878 ALLOCATE (actual_x_data%atomic_block_offset(natom, natom))
879 ALLOCATE (actual_x_data%set_offset(max_set, max_set, nkind, nkind))
880 ALLOCATE (actual_x_data%block_offset(para_env%num_pe + 1))
883 ALLOCATE (actual_x_data%distribution_forces(1))
884 ALLOCATE (actual_x_data%distribution_energy(1))
886 actual_x_data%memory_parameter%size_p_screen = 0_int_8
887 IF (i_thread == 1)
THEN
888 ALLOCATE (actual_x_data%atomic_pair_list(natom, natom))
889 ALLOCATE (actual_x_data%atomic_pair_list_forces(natom, natom))
892 IF (actual_x_data%screening_parameter%do_initial_p_screening .OR. &
893 actual_x_data%screening_parameter%do_p_screening_forces)
THEN
895 IF (i_thread == 1)
THEN
896 ALLOCATE (actual_x_data%pmax_atom(natom, natom))
897 ALLOCATE (actual_x_data%initial_p(nkind*(nkind + 1)/2))
901 nseta = actual_x_data%basis_parameter(ikind)%nset
902 DO jkind = ikind, nkind
904 nsetb = actual_x_data%basis_parameter(jkind)%nset
905 ALLOCATE (actual_x_data%initial_p(i)%p_kind(nseta, nsetb, natom_a, natom_b))
906 actual_x_data%memory_parameter%size_p_screen = &
907 actual_x_data%memory_parameter%size_p_screen + nseta*nsetb*natom_a*natom_b
912 ALLOCATE (actual_x_data%pmax_atom_forces(natom, natom))
913 ALLOCATE (actual_x_data%initial_p_forces(nkind*(nkind + 1)/2))
917 nseta = actual_x_data%basis_parameter(ikind)%nset
918 DO jkind = ikind, nkind
920 nsetb = actual_x_data%basis_parameter(jkind)%nset
921 ALLOCATE (actual_x_data%initial_p_forces(i)%p_kind(nseta, nsetb, natom_a, natom_b))
922 actual_x_data%memory_parameter%size_p_screen = &
923 actual_x_data%memory_parameter%size_p_screen + nseta*nsetb*natom_a*natom_b
928 ALLOCATE (actual_x_data%map_atom_to_kind_atom(natom))
931 ALLOCATE (atom2kind(nkind))
934 ikind = kind_of(iatom)
935 atom2kind(ikind) = atom2kind(ikind) + 1
936 actual_x_data%map_atom_to_kind_atom(iatom) = atom2kind(ikind)
938 DEALLOCATE (kind_of, atom2kind)
951 actual_x_data%store_ints%maxval_cache_disk%element_counter = 1
952 ALLOCATE (actual_x_data%store_ints%maxval_container_disk)
953 ALLOCATE (actual_x_data%store_ints%maxval_container_disk%first)
954 actual_x_data%store_ints%maxval_container_disk%first%prev => null()
955 actual_x_data%store_ints%maxval_container_disk%first%next => null()
956 actual_x_data%store_ints%maxval_container_disk%current => actual_x_data%store_ints%maxval_container_disk%first
957 actual_x_data%store_ints%maxval_container_disk%current%data = 0
958 actual_x_data%store_ints%maxval_container_disk%element_counter = 1
959 actual_x_data%store_ints%maxval_container_disk%file_counter = 1
960 actual_x_data%store_ints%maxval_container_disk%desc =
'Max_'
961 actual_x_data%store_ints%maxval_container_disk%unit = -1
962 WRITE (actual_x_data%store_ints%maxval_container_disk%filename,
'(A,I0,A,A,A)') &
963 trim(actual_x_data%memory_parameter%storage_location), &
964 storage_id,
"_", actual_x_data%store_ints%maxval_container_disk%desc,
"6"
965 CALL compress(actual_x_data%store_ints%maxval_container_disk%filename, .true.)
966 ALLOCATE (actual_x_data%store_ints%integral_containers_disk(64))
968 actual_x_data%store_ints%integral_caches_disk(i)%element_counter = 1
969 actual_x_data%store_ints%integral_caches_disk(i)%data = 0
970 ALLOCATE (actual_x_data%store_ints%integral_containers_disk(i)%first)
971 actual_x_data%store_ints%integral_containers_disk(i)%first%prev => null()
972 actual_x_data%store_ints%integral_containers_disk(i)%first%next => null()
973 actual_x_data%store_ints%integral_containers_disk(i)%current => &
974 actual_x_data%store_ints%integral_containers_disk(i)%first
975 actual_x_data%store_ints%integral_containers_disk(i)%current%data = 0
976 actual_x_data%store_ints%integral_containers_disk(i)%element_counter = 1
977 actual_x_data%store_ints%integral_containers_disk(i)%file_counter = 1
978 actual_x_data%store_ints%integral_containers_disk(i)%desc =
'Int_'
979 actual_x_data%store_ints%integral_containers_disk(i)%unit = -1
980 WRITE (actual_x_data%store_ints%integral_containers_disk(i)%filename,
'(A,I0,A,A,I0)') &
981 trim(actual_x_data%memory_parameter%storage_location), &
982 storage_id,
"_", actual_x_data%store_ints%integral_containers_disk(i)%desc, i
983 CALL compress(actual_x_data%store_ints%integral_containers_disk(i)%filename, .true.)
986 actual_x_data%b_first_load_balance_energy = .true.
987 actual_x_data%b_first_load_balance_forces = .true.
990 IF (actual_x_data%do_hfx_ri)
THEN
991 cpassert(
PRESENT(nelectron_total))
992 ALLOCATE (actual_x_data%ri_data)
993 CALL hfx_ri_init_read_input_from_hfx(actual_x_data%ri_data, actual_x_data, hfx_section, &
994 hf_sub_section, qs_kind_set, &
995 particle_set, atomic_kind_set, dft_control, para_env, irep, &
996 nelectron_total, orb_basis_type, ri_basis_type)
1001 DO irep = 1, n_rep_hf
1002 actual_x_data => x_data(irep, 1)
1003 CALL hfx_print_info(actual_x_data, hfx_section, irep)
1006 CALL timestop(handle)
1026 SUBROUTINE hfx_ri_init_read_input_from_hfx(ri_data, x_data, hfx_section, ri_section, qs_kind_set, &
1027 particle_set, atomic_kind_set, dft_control, para_env, irep, &
1028 nelectron_total, orb_basis_type, ri_basis_type)
1030 TYPE(
hfx_type),
INTENT(INOUT) :: x_data
1032 TYPE(
qs_kind_type),
DIMENSION(:),
POINTER :: qs_kind_set
1037 INTEGER,
INTENT(IN) :: irep, nelectron_total
1038 CHARACTER(LEN=*) :: orb_basis_type, ri_basis_type
1040 CHARACTER(LEN=*),
PARAMETER :: routinen =
'hfx_ri_init_read_input_from_hfx'
1042 CHARACTER(LEN=512) :: error_msg
1043 CHARACTER(LEN=default_path_length) :: char_val, t_c_filename
1044 INTEGER :: handle, unit_nr, unit_nr_dbcsr
1048 CALL timeset(routinen, handle)
1050 NULLIFY (hf_sub_section)
1052 associate(hfx_pot => ri_data%hfx_pot)
1053 hfx_pot%potential_type = x_data%potential_parameter%potential_type
1054 hfx_pot%omega = x_data%potential_parameter%omega
1055 hfx_pot%cutoff_radius = x_data%potential_parameter%cutoff_radius
1056 hfx_pot%scale_coulomb = x_data%potential_parameter%scale_coulomb
1057 hfx_pot%scale_longrange = x_data%potential_parameter%scale_longrange
1059 ri_data%ri_section => ri_section
1060 ri_data%hfx_section => hfx_section
1061 ri_data%eps_schwarz = x_data%screening_parameter%eps_schwarz
1062 ri_data%eps_schwarz_forces = x_data%screening_parameter%eps_schwarz_forces
1066 extension=
".dbcsrLog")
1069 extension=
".scfLog")
1076 WRITE (error_msg,
'(A,A,A)')
"File not found. Please check T_C_G_DATA "// &
1077 "in the INTERACTION_POTENTIAL section"
1080 t_c_filename = char_val
1083 CALL hfx_ri_init_read_input(ri_data, ri_section, qs_kind_set, particle_set, atomic_kind_set, &
1084 orb_basis_type, ri_basis_type, para_env, unit_nr, unit_nr_dbcsr, &
1085 nelectron_total, t_c_filename=t_c_filename)
1087 IF (dft_control%smear .AND. ri_data%flavor ==
ri_mo)
THEN
1088 cpabort(
"RI_FLAVOR MO is not consistent with smearing. Please use RI_FLAVOR RHO.")
1091 CALL timestop(handle)
1093 END SUBROUTINE hfx_ri_init_read_input_from_hfx
1110 SUBROUTINE hfx_ri_init_read_input(ri_data, ri_section, qs_kind_set, &
1111 particle_set, atomic_kind_set, orb_basis_type, ri_basis_type, para_env, &
1112 unit_nr, unit_nr_dbcsr, nelectron_total, t_c_filename)
1114 TYPE(section_vals_type),
POINTER :: ri_section
1115 TYPE(qs_kind_type),
DIMENSION(:),
POINTER :: qs_kind_set
1116 TYPE(particle_type),
DIMENSION(:),
POINTER :: particle_set
1117 TYPE(atomic_kind_type),
DIMENSION(:),
POINTER :: atomic_kind_set
1118 CHARACTER(LEN=*),
INTENT(IN) :: orb_basis_type, ri_basis_type
1119 TYPE(mp_para_env_type) :: para_env
1120 INTEGER,
INTENT(IN) :: unit_nr, unit_nr_dbcsr, nelectron_total
1121 CHARACTER(len=*),
INTENT(IN),
OPTIONAL :: t_c_filename
1123 CHARACTER(LEN=*),
PARAMETER :: routinen =
'hfx_ri_init_read_input'
1127 REAL(dp) :: eps_storage_scaling
1129 CALL timeset(routinen, handle)
1131 CALL section_vals_val_get(ri_section,
"EPS_FILTER", r_val=ri_data%filter_eps)
1132 CALL section_vals_val_get(ri_section,
"EPS_FILTER_2C", r_val=ri_data%filter_eps_2c)
1133 CALL section_vals_val_get(ri_section,
"EPS_STORAGE_SCALING", r_val=eps_storage_scaling)
1134 ri_data%filter_eps_storage = ri_data%filter_eps*eps_storage_scaling
1135 CALL section_vals_val_get(ri_section,
"EPS_FILTER_MO", r_val=ri_data%filter_eps_mo)
1137 associate(ri_metric => ri_data%ri_metric, hfx_pot => ri_data%hfx_pot)
1138 CALL section_vals_val_get(ri_section,
"RI_METRIC", i_val=ri_metric%potential_type, explicit=explicit)
1139 IF (.NOT. explicit .OR. ri_metric%potential_type == 0)
THEN
1140 ri_metric%potential_type = hfx_pot%potential_type
1143 CALL section_vals_val_get(ri_section,
"OMEGA", r_val=ri_metric%omega, explicit=explicit)
1144 IF (.NOT. explicit)
THEN
1145 ri_metric%omega = hfx_pot%omega
1148 CALL section_vals_val_get(ri_section,
"CUTOFF_RADIUS", r_val=ri_metric%cutoff_radius, explicit=explicit)
1149 IF (.NOT. explicit)
THEN
1150 ri_metric%cutoff_radius = hfx_pot%cutoff_radius
1153 CALL section_vals_val_get(ri_section,
"SCALE_COULOMB", r_val=ri_metric%scale_coulomb, explicit=explicit)
1154 IF (.NOT. explicit)
THEN
1155 ri_metric%scale_coulomb = hfx_pot%scale_coulomb
1158 CALL section_vals_val_get(ri_section,
"SCALE_LONGRANGE", r_val=ri_metric%scale_longrange, explicit=explicit)
1159 IF (.NOT. explicit)
THEN
1160 ri_metric%scale_longrange = hfx_pot%scale_longrange
1163 IF (ri_metric%potential_type == do_potential_short) &
1164 CALL erfc_cutoff(ri_data%eps_schwarz, ri_metric%omega, ri_metric%cutoff_radius)
1165 IF (ri_metric%potential_type == do_potential_id) ri_metric%cutoff_radius = 0.0_dp
1168 CALL section_vals_val_get(ri_section,
"2C_MATRIX_FUNCTIONS", i_val=ri_data%t2c_method)
1169 CALL section_vals_val_get(ri_section,
"EPS_EIGVAL", r_val=ri_data%eps_eigval)
1170 CALL section_vals_val_get(ri_section,
"CHECK_2C_MATRIX", l_val=ri_data%check_2c_inv)
1171 CALL section_vals_val_get(ri_section,
"CALC_COND_NUM", l_val=ri_data%calc_condnum)
1172 CALL section_vals_val_get(ri_section,
"SQRT_ORDER", i_val=ri_data%t2c_sqrt_order)
1173 CALL section_vals_val_get(ri_section,
"EPS_LANCZOS", r_val=ri_data%eps_lanczos)
1174 CALL section_vals_val_get(ri_section,
"MAX_ITER_LANCZOS", i_val=ri_data%max_iter_lanczos)
1175 CALL section_vals_val_get(ri_section,
"RI_FLAVOR", i_val=ri_data%flavor)
1176 CALL section_vals_val_get(ri_section,
"EPS_PGF_ORB", r_val=ri_data%eps_pgf_orb)
1177 CALL section_vals_val_get(ri_section,
"MIN_BLOCK_SIZE", i_val=ri_data%min_bsize)
1178 CALL section_vals_val_get(ri_section,
"MAX_BLOCK_SIZE_MO", i_val=ri_data%max_bsize_MO)
1179 CALL section_vals_val_get(ri_section,
"MEMORY_CUT", i_val=ri_data%n_mem_input)
1180 CALL section_vals_val_get(ri_section,
"FLAVOR_SWITCH_MEMORY_CUT", i_val=ri_data%n_mem_flavor_switch)
1182 ri_data%orb_basis_type = orb_basis_type
1183 ri_data%ri_basis_type = ri_basis_type
1184 ri_data%nelectron_total = nelectron_total
1185 ri_data%input_flavor = ri_data%flavor
1187 IF (
PRESENT(t_c_filename))
THEN
1188 ri_data%ri_metric%filename = t_c_filename
1189 ri_data%hfx_pot%filename = t_c_filename
1192 ri_data%unit_nr_dbcsr = unit_nr_dbcsr
1193 ri_data%unit_nr = unit_nr
1194 ri_data%dbcsr_nflop = 0
1195 ri_data%dbcsr_time = 0.0_dp
1197 CALL hfx_ri_init(ri_data, qs_kind_set, particle_set, atomic_kind_set, para_env)
1199 CALL timestop(handle)
1211 SUBROUTINE hfx_ri_init(ri_data, qs_kind_set, particle_set, atomic_kind_set, para_env)
1213 TYPE(qs_kind_type),
DIMENSION(:),
POINTER :: qs_kind_set
1214 TYPE(particle_type),
DIMENSION(:),
POINTER :: particle_set
1215 TYPE(atomic_kind_type),
DIMENSION(:),
POINTER :: atomic_kind_set
1216 TYPE(mp_para_env_type) :: para_env
1218 CHARACTER(LEN=*),
PARAMETER :: routinen =
'hfx_ri_init'
1220 INTEGER :: handle, i_mem, j_mem, mo_dim, natom, &
1222 INTEGER,
ALLOCATABLE,
DIMENSION(:) :: bsizes_ao_store, bsizes_ri_store, dist1, &
1223 dist2, dist3, dist_ao_1, dist_ao_2, &
1225 INTEGER,
DIMENSION(2) :: pdims_2d
1226 INTEGER,
DIMENSION(3) :: pdims
1228 TYPE(distribution_3d_type) :: dist_3d
1229 TYPE(gto_basis_set_p_type),
ALLOCATABLE, &
1230 DIMENSION(:) :: basis_set_ao, basis_set_ri
1231 TYPE(mp_cart_type) :: mp_comm_3d
1233 CALL cite_reference(bussy2023)
1235 CALL timeset(routinen, handle)
1238 CALL cp_libint_static_init()
1240 natom =
SIZE(particle_set)
1241 nkind =
SIZE(qs_kind_set, 1)
1242 nproc = para_env%num_pe
1244 associate(ri_metric => ri_data%ri_metric, hfx_pot => ri_data%hfx_pot)
1245 IF (ri_metric%potential_type == do_potential_short)
THEN
1246 CALL erfc_cutoff(ri_data%eps_schwarz, ri_metric%omega, ri_metric%cutoff_radius)
1249 IF (hfx_pot%potential_type == do_potential_short)
THEN
1252 CALL erfc_cutoff(ri_data%filter_eps_2c, hfx_pot%omega, hfx_pot%cutoff_radius)
1255 same_op = compare_potential_types(ri_metric, hfx_pot)
1258 ri_data%same_op = same_op
1261 CALL mp_comm_3d%create(para_env, 3, pdims)
1263 ALLOCATE (ri_data%bsizes_RI(natom))
1264 ALLOCATE (ri_data%bsizes_AO(natom))
1265 ALLOCATE (basis_set_ri(nkind), basis_set_ao(nkind))
1266 CALL basis_set_list_setup(basis_set_ri, ri_data%ri_basis_type, qs_kind_set)
1267 CALL get_particle_set(particle_set, qs_kind_set, nsgf=ri_data%bsizes_RI, basis=basis_set_ri)
1268 CALL basis_set_list_setup(basis_set_ao, ri_data%orb_basis_type, qs_kind_set)
1269 CALL get_particle_set(particle_set, qs_kind_set, nsgf=ri_data%bsizes_AO, basis=basis_set_ao)
1271 ALLOCATE (dist_ri(natom))
1272 ALLOCATE (dist_ao_1(natom))
1273 ALLOCATE (dist_ao_2(natom))
1274 CALL dbt_default_distvec(natom, pdims(1), ri_data%bsizes_RI, dist_ri)
1275 CALL dbt_default_distvec(natom, pdims(2), ri_data%bsizes_AO, dist_ao_1)
1276 CALL dbt_default_distvec(natom, pdims(3), ri_data%bsizes_AO, dist_ao_2)
1277 CALL distribution_3d_create(dist_3d, dist_ri, dist_ao_1, dist_ao_2, nkind, particle_set, &
1278 mp_comm_3d, own_comm=.true.)
1280 ALLOCATE (ri_data%pgrid)
1281 CALL dbt_pgrid_create(para_env, pdims, ri_data%pgrid)
1283 ALLOCATE (ri_data%pgrid_2d)
1285 CALL dbt_pgrid_create(para_env, pdims_2d, ri_data%pgrid_2d)
1287 ri_data%dist_3d = dist_3d
1289 CALL dbt_distribution_new(ri_data%dist, ri_data%pgrid, &
1290 dist_ri, dist_ao_1, dist_ao_2)
1292 DEALLOCATE (dist_ao_1, dist_ao_2, dist_ri)
1294 ri_data%num_pe = para_env%num_pe
1297 CALL pgf_block_sizes(atomic_kind_set, basis_set_ao, ri_data%min_bsize, ri_data%bsizes_AO_split)
1298 CALL pgf_block_sizes(atomic_kind_set, basis_set_ri, ri_data%min_bsize, ri_data%bsizes_RI_split)
1300 CALL pgf_block_sizes(atomic_kind_set, basis_set_ao, 1, bsizes_ao_store)
1301 CALL pgf_block_sizes(atomic_kind_set, basis_set_ri, 1, bsizes_ri_store)
1303 CALL split_block_sizes([sum(ri_data%bsizes_AO)], ri_data%bsizes_AO_fit, default_block_size)
1304 CALL split_block_sizes([sum(ri_data%bsizes_RI)], ri_data%bsizes_RI_fit, default_block_size)
1306 IF (ri_data%flavor == ri_pmat)
THEN
1309 ri_data%n_mem = ri_data%n_mem_input
1310 ri_data%n_mem_RI = ri_data%n_mem_input
1312 CALL create_tensor_batches(ri_data%bsizes_AO_split, ri_data%n_mem, ri_data%starts_array_mem, &
1313 ri_data%ends_array_mem, ri_data%starts_array_mem_block, &
1314 ri_data%ends_array_mem_block)
1316 CALL create_tensor_batches(ri_data%bsizes_RI_split, ri_data%n_mem_RI, &
1317 ri_data%starts_array_RI_mem, ri_data%ends_array_RI_mem, &
1318 ri_data%starts_array_RI_mem_block, ri_data%ends_array_RI_mem_block)
1320 ALLOCATE (ri_data%pgrid_1)
1321 ALLOCATE (ri_data%pgrid_2)
1324 CALL dbt_mp_dims_create(nproc, pdims, [
SIZE(ri_data%bsizes_AO_split),
SIZE(ri_data%bsizes_RI_split), &
1325 SIZE(ri_data%bsizes_AO_split)])
1327 CALL dbt_pgrid_create(para_env, pdims, ri_data%pgrid_1)
1329 pdims = pdims([2, 1, 3])
1330 CALL dbt_pgrid_create(para_env, pdims, ri_data%pgrid_2)
1332 ALLOCATE (ri_data%t_3c_int_ctr_1(1, 1))
1333 CALL create_3c_tensor(ri_data%t_3c_int_ctr_1(1, 1), dist1, dist2, dist3, &
1334 ri_data%pgrid_1, ri_data%bsizes_AO_split, ri_data%bsizes_RI_split, &
1335 ri_data%bsizes_AO_split, [1, 2], [3], name=
"(AO RI | AO)")
1336 DEALLOCATE (dist1, dist2, dist3)
1338 ALLOCATE (ri_data%blk_indices(ri_data%n_mem, ri_data%n_mem_RI))
1339 ALLOCATE (ri_data%store_3c(ri_data%n_mem, ri_data%n_mem_RI))
1340 DO i_mem = 1, ri_data%n_mem
1341 DO j_mem = 1, ri_data%n_mem_RI
1346 ALLOCATE (ri_data%t_3c_int_ctr_2(1, 1))
1347 CALL create_3c_tensor(ri_data%t_3c_int_ctr_2(1, 1), dist1, dist2, dist3, &
1348 ri_data%pgrid_1, ri_data%bsizes_AO_split, ri_data%bsizes_RI_split, &
1349 ri_data%bsizes_AO_split, [1, 2], [3], name=
"(AO RI | AO)")
1350 DEALLOCATE (dist1, dist2, dist3)
1352 ALLOCATE (ri_data%t_3c_int_ctr_3(1, 1))
1353 CALL create_3c_tensor(ri_data%t_3c_int_ctr_3(1, 1), dist1, dist2, dist3, &
1354 ri_data%pgrid_2, ri_data%bsizes_RI_split, ri_data%bsizes_AO_split, &
1355 ri_data%bsizes_AO_split, [1], [2, 3], name=
"(RI | AO AO)")
1356 DEALLOCATE (dist1, dist2, dist3)
1358 ALLOCATE (ri_data%t_2c_int(1, 1))
1359 CALL create_2c_tensor(ri_data%t_2c_int(1, 1), dist1, dist2, ri_data%pgrid_2d, &
1360 ri_data%bsizes_RI_split, ri_data%bsizes_RI_split, &
1362 DEALLOCATE (dist1, dist2)
1365 ALLOCATE (ri_data%rho_ao_t(2, 1))
1366 CALL create_2c_tensor(ri_data%rho_ao_t(1, 1), dist1, dist2, ri_data%pgrid_2d, &
1367 ri_data%bsizes_AO_split, ri_data%bsizes_AO_split, &
1369 DEALLOCATE (dist1, dist2)
1370 CALL dbt_create(ri_data%rho_ao_t(1, 1), ri_data%rho_ao_t(2, 1))
1372 ALLOCATE (ri_data%ks_t(2, 1))
1373 CALL create_2c_tensor(ri_data%ks_t(1, 1), dist1, dist2, ri_data%pgrid_2d, &
1374 ri_data%bsizes_AO_split, ri_data%bsizes_AO_split, &
1376 DEALLOCATE (dist1, dist2)
1377 CALL dbt_create(ri_data%ks_t(1, 1), ri_data%ks_t(2, 1))
1379 ELSEIF (ri_data%flavor == ri_mo)
THEN
1380 ALLOCATE (ri_data%t_2c_int(2, 1))
1382 CALL create_2c_tensor(ri_data%t_2c_int(1, 1), dist1, dist2, ri_data%pgrid_2d, &
1383 ri_data%bsizes_RI_fit, ri_data%bsizes_RI_fit, &
1385 CALL dbt_create(ri_data%t_2c_int(1, 1), ri_data%t_2c_int(2, 1))
1387 DEALLOCATE (dist1, dist2)
1389 ALLOCATE (ri_data%t_3c_int_ctr_1(1, 1))
1391 ALLOCATE (ri_data%pgrid_1)
1392 ALLOCATE (ri_data%pgrid_2)
1395 ri_data%n_mem = ri_data%n_mem_input**2
1396 IF (ri_data%n_mem > ri_data%nelectron_total/2) ri_data%n_mem = max(ri_data%nelectron_total/2, 1)
1401 mo_dim = max((ri_data%nelectron_total/2 - 1)/ri_data%n_mem + 1, 1)
1402 mo_dim = (mo_dim - 1)/ri_data%max_bsize_MO + 1
1405 CALL dbt_mp_dims_create(nproc, pdims, [
SIZE(ri_data%bsizes_AO_split),
SIZE(ri_data%bsizes_RI_split), mo_dim])
1407 CALL dbt_pgrid_create(para_env, pdims, ri_data%pgrid_1)
1409 pdims = pdims([3, 2, 1])
1410 CALL dbt_pgrid_create(para_env, pdims, ri_data%pgrid_2)
1412 CALL create_3c_tensor(ri_data%t_3c_int_ctr_1(1, 1), dist1, dist2, dist3, &
1413 ri_data%pgrid_1, ri_data%bsizes_AO_split, ri_data%bsizes_RI_split, ri_data%bsizes_AO_split, &
1414 [1, 2], [3], name=
"(AO RI | AO)")
1415 DEALLOCATE (dist1, dist2, dist3)
1417 ALLOCATE (ri_data%t_3c_int_ctr_2(1, 1))
1418 CALL create_3c_tensor(ri_data%t_3c_int_ctr_2(1, 1), dist1, dist2, dist3, &
1419 ri_data%pgrid_2, ri_data%bsizes_AO_split, ri_data%bsizes_RI_split, ri_data%bsizes_AO_split, &
1420 [1], [2, 3], name=
"(AO | RI AO)")
1421 DEALLOCATE (dist1, dist2, dist3)
1426 ALLOCATE (ri_data%t_2c_inv(1, 1))
1427 CALL create_2c_tensor(ri_data%t_2c_inv(1, 1), dist1, dist2, ri_data%pgrid_2d, &
1428 ri_data%bsizes_RI_split, ri_data%bsizes_RI_split, &
1430 DEALLOCATE (dist1, dist2)
1432 ALLOCATE (ri_data%t_2c_pot(1, 1))
1433 CALL create_2c_tensor(ri_data%t_2c_pot(1, 1), dist1, dist2, ri_data%pgrid_2d, &
1434 ri_data%bsizes_RI_split, ri_data%bsizes_RI_split, &
1436 DEALLOCATE (dist1, dist2)
1438 CALL timestop(handle)
1446 SUBROUTINE hfx_ri_write_stats(ri_data)
1449 REAL(dp) :: my_flop_rate
1451 associate(unit_nr => ri_data%unit_nr, dbcsr_nflop => ri_data%dbcsr_nflop, &
1452 dbcsr_time => ri_data%dbcsr_time, num_pe => ri_data%num_pe)
1453 my_flop_rate = real(dbcsr_nflop, dp)/(1.0e09_dp*ri_data%dbcsr_time)
1454 IF (unit_nr > 0)
WRITE (unit=unit_nr, fmt=
"(/T2,A,T73,ES8.2)") &
1455 "RI-HFX PERFORMANCE| DBT total number of flops:", real(dbcsr_nflop*num_pe, dp)
1456 IF (unit_nr > 0)
WRITE (unit=unit_nr, fmt=
"(T2,A,T66,F15.2)") &
1457 "RI-HFX PERFORMANCE| DBT total execution time:", dbcsr_time
1458 IF (unit_nr > 0)
WRITE (unit=unit_nr, fmt=
"(T2,A,T66,F15.2)") &
1459 "RI-HFX PERFORMANCE| DBT flop rate (Gflops / MPI rank):", my_flop_rate
1470 LOGICAL,
OPTIONAL :: write_stats
1472 CHARACTER(LEN=*),
PARAMETER :: routinen =
'hfx_ri_release'
1474 INTEGER :: handle, i, i_mem, ispin, j, j_mem, unused
1475 LOGICAL :: my_write_stats
1477 CALL timeset(routinen, handle)
1480 CALL cp_libint_static_cleanup()
1482 my_write_stats = .true.
1483 IF (
PRESENT(write_stats)) my_write_stats = write_stats
1484 IF (my_write_stats)
CALL hfx_ri_write_stats(ri_data)
1486 IF (
ASSOCIATED(ri_data%pgrid))
THEN
1487 CALL dbt_pgrid_destroy(ri_data%pgrid)
1488 DEALLOCATE (ri_data%pgrid)
1490 IF (
ASSOCIATED(ri_data%pgrid_1))
THEN
1491 CALL dbt_pgrid_destroy(ri_data%pgrid_1)
1492 DEALLOCATE (ri_data%pgrid_1)
1494 IF (
ASSOCIATED(ri_data%pgrid_2))
THEN
1495 CALL dbt_pgrid_destroy(ri_data%pgrid_2)
1496 DEALLOCATE (ri_data%pgrid_2)
1498 IF (
ASSOCIATED(ri_data%pgrid_2d))
THEN
1499 CALL dbt_pgrid_destroy(ri_data%pgrid_2d)
1500 DEALLOCATE (ri_data%pgrid_2d)
1503 CALL distribution_3d_destroy(ri_data%dist_3d)
1504 CALL dbt_distribution_destroy(ri_data%dist)
1506 DEALLOCATE (ri_data%bsizes_RI)
1507 DEALLOCATE (ri_data%bsizes_AO)
1508 DEALLOCATE (ri_data%bsizes_AO_split)
1509 DEALLOCATE (ri_data%bsizes_RI_split)
1510 DEALLOCATE (ri_data%bsizes_AO_fit)
1511 DEALLOCATE (ri_data%bsizes_RI_fit)
1513 IF (ri_data%flavor == ri_pmat)
THEN
1514 DO i_mem = 1, ri_data%n_mem
1515 DO j_mem = 1, ri_data%n_mem_RI
1520 DO j = 1,
SIZE(ri_data%t_3c_int_ctr_1, 2)
1521 DO i = 1,
SIZE(ri_data%t_3c_int_ctr_1, 1)
1522 CALL dbt_destroy(ri_data%t_3c_int_ctr_1(i, j))
1525 DEALLOCATE (ri_data%t_3c_int_ctr_1)
1527 DO j = 1,
SIZE(ri_data%t_3c_int_ctr_2, 2)
1528 DO i = 1,
SIZE(ri_data%t_3c_int_ctr_2, 1)
1529 CALL dbt_destroy(ri_data%t_3c_int_ctr_2(i, j))
1532 DEALLOCATE (ri_data%t_3c_int_ctr_2)
1534 DO j = 1,
SIZE(ri_data%t_3c_int_ctr_3, 2)
1535 DO i = 1,
SIZE(ri_data%t_3c_int_ctr_3, 1)
1536 CALL dbt_destroy(ri_data%t_3c_int_ctr_3(i, j))
1539 DEALLOCATE (ri_data%t_3c_int_ctr_3)
1541 DO j = 1,
SIZE(ri_data%t_2c_int, 2)
1542 DO i = 1,
SIZE(ri_data%t_2c_int, 1)
1543 CALL dbt_destroy(ri_data%t_2c_int(i, j))
1546 DEALLOCATE (ri_data%t_2c_int)
1548 DO j = 1,
SIZE(ri_data%rho_ao_t, 2)
1549 DO i = 1,
SIZE(ri_data%rho_ao_t, 1)
1550 CALL dbt_destroy(ri_data%rho_ao_t(i, j))
1553 DEALLOCATE (ri_data%rho_ao_t)
1555 DO j = 1,
SIZE(ri_data%ks_t, 2)
1556 DO i = 1,
SIZE(ri_data%ks_t, 1)
1557 CALL dbt_destroy(ri_data%ks_t(i, j))
1560 DEALLOCATE (ri_data%ks_t)
1562 DEALLOCATE (ri_data%starts_array_mem_block, ri_data%ends_array_mem_block, &
1563 ri_data%starts_array_mem, ri_data%ends_array_mem)
1564 DEALLOCATE (ri_data%starts_array_RI_mem_block, ri_data%ends_array_RI_mem_block, &
1565 ri_data%starts_array_RI_mem, ri_data%ends_array_RI_mem)
1567 DEALLOCATE (ri_data%blk_indices)
1568 DEALLOCATE (ri_data%store_3c)
1569 ELSEIF (ri_data%flavor == ri_mo)
THEN
1570 CALL dbt_destroy(ri_data%t_3c_int_ctr_1(1, 1))
1571 CALL dbt_destroy(ri_data%t_3c_int_ctr_2(1, 1))
1572 DEALLOCATE (ri_data%t_3c_int_ctr_1)
1573 DEALLOCATE (ri_data%t_3c_int_ctr_2)
1575 DO ispin = 1,
SIZE(ri_data%t_3c_int_mo, 1)
1576 CALL dbt_destroy(ri_data%t_3c_int_mo(ispin, 1, 1))
1577 CALL dbt_destroy(ri_data%t_3c_ctr_RI(ispin, 1, 1))
1578 CALL dbt_destroy(ri_data%t_3c_ctr_KS(ispin, 1, 1))
1579 CALL dbt_destroy(ri_data%t_3c_ctr_KS_copy(ispin, 1, 1))
1582 CALL dbt_destroy(ri_data%t_2c_int(ispin, 1))
1584 DEALLOCATE (ri_data%t_2c_int)
1585 DEALLOCATE (ri_data%t_3c_int_mo)
1586 DEALLOCATE (ri_data%t_3c_ctr_RI)
1587 DEALLOCATE (ri_data%t_3c_ctr_KS)
1588 DEALLOCATE (ri_data%t_3c_ctr_KS_copy)
1591 DO j = 1,
SIZE(ri_data%t_2c_inv, 2)
1592 DO i = 1,
SIZE(ri_data%t_2c_inv, 1)
1593 CALL dbt_destroy(ri_data%t_2c_inv(i, j))
1596 DEALLOCATE (ri_data%t_2c_inv)
1598 DO j = 1,
SIZE(ri_data%t_2c_pot, 2)
1599 DO i = 1,
SIZE(ri_data%t_2c_pot, 1)
1600 CALL dbt_destroy(ri_data%t_2c_pot(i, j))
1603 DEALLOCATE (ri_data%t_2c_pot)
1605 IF (
ALLOCATED(ri_data%kp_mat_2c_pot))
THEN
1606 DO j = 1,
SIZE(ri_data%kp_mat_2c_pot, 2)
1607 DO i = 1,
SIZE(ri_data%kp_mat_2c_pot, 1)
1608 CALL dbcsr_release(ri_data%kp_mat_2c_pot(i, j))
1611 DEALLOCATE (ri_data%kp_mat_2c_pot)
1614 IF (
ALLOCATED(ri_data%kp_t_3c_int))
THEN
1615 DO i = 1,
SIZE(ri_data%kp_t_3c_int)
1616 CALL dbt_destroy(ri_data%kp_t_3c_int(i))
1618 DEALLOCATE (ri_data%kp_t_3c_int)
1621 IF (
ALLOCATED(ri_data%rho_ao_t))
THEN
1622 DO j = 1,
SIZE(ri_data%rho_ao_t, 2)
1623 DO i = 1,
SIZE(ri_data%rho_ao_t, 1)
1624 CALL dbt_destroy(ri_data%rho_ao_t(i, j))
1627 DEALLOCATE (ri_data%rho_ao_t)
1630 IF (
ALLOCATED(ri_data%ks_t))
THEN
1631 DO j = 1,
SIZE(ri_data%ks_t, 2)
1632 DO i = 1,
SIZE(ri_data%ks_t, 1)
1633 CALL dbt_destroy(ri_data%ks_t(i, j))
1636 DEALLOCATE (ri_data%ks_t)
1639 IF (
ALLOCATED(ri_data%iatom_to_subgroup))
THEN
1640 DO i = 1,
SIZE(ri_data%iatom_to_subgroup)
1641 DEALLOCATE (ri_data%iatom_to_subgroup(i)%array)
1643 DEALLOCATE (ri_data%iatom_to_subgroup)
1646 CALL timestop(handle)
1662 TYPE(qs_kind_type),
DIMENSION(:),
POINTER :: qs_kind_set
1663 CHARACTER(LEN=*) :: basis_type
1665 CHARACTER(LEN=*),
PARAMETER :: routinen =
'hfx_create_basis_types'
1667 INTEGER :: co_counter, handle, i, ikind, ipgf, iset, j, k, la, max_am_kind, max_coeff, &
1668 max_nsgfl, max_pgf, max_pgf_kind, max_set, nkind, nl_count, nset, nseta, offset_a, &
1669 offset_a1, s_offset_nl_a, sgfa, so_counter
1670 INTEGER,
DIMENSION(:),
POINTER :: la_max, la_min, npgfa, nshell
1671 INTEGER,
DIMENSION(:, :),
POINTER :: first_sgfa, nl_a
1672 REAL(dp),
DIMENSION(:, :),
POINTER :: sphi_a
1673 TYPE(gto_basis_set_type),
POINTER :: orb_basis_a
1675 CALL timeset(routinen, handle)
1678 nkind =
SIZE(qs_kind_set, 1)
1680 ALLOCATE (basis_parameter(nkind))
1683 CALL get_qs_kind(qs_kind_set(ikind), basis_set=orb_basis_a, basis_type=basis_type)
1684 CALL get_qs_kind_set(qs_kind_set, &
1685 maxsgf=basis_info%max_sgf, &
1686 maxnset=basis_info%max_set, &
1687 maxlgto=basis_info%max_am, &
1688 basis_type=basis_type)
1689 IF (basis_info%max_set < max_set) cpabort(
"UNEXPECTED MAX_SET")
1690 max_set = max(max_set, basis_info%max_set)
1691 CALL get_gto_basis_set(gto_basis_set=orb_basis_a, &
1692 lmax=basis_parameter(ikind)%lmax, &
1693 lmin=basis_parameter(ikind)%lmin, &
1694 npgf=basis_parameter(ikind)%npgf, &
1695 nset=basis_parameter(ikind)%nset, &
1696 zet=basis_parameter(ikind)%zet, &
1697 nsgf_set=basis_parameter(ikind)%nsgf, &
1698 first_sgf=basis_parameter(ikind)%first_sgf, &
1699 sphi=basis_parameter(ikind)%sphi, &
1700 nsgf=basis_parameter(ikind)%nsgf_total, &
1701 l=basis_parameter(ikind)%nl, &
1702 nshell=basis_parameter(ikind)%nshell, &
1703 set_radius=basis_parameter(ikind)%set_radius, &
1704 pgf_radius=basis_parameter(ikind)%pgf_radius, &
1705 kind_radius=basis_parameter(ikind)%kind_radius)
1708 ALLOCATE (basis_parameter(ikind)%nsgfl(0:basis_info%max_am, max_set))
1709 basis_parameter(ikind)%nsgfl = 0
1710 nset = basis_parameter(ikind)%nset
1711 nshell => basis_parameter(ikind)%nshell
1713 DO i = 0, basis_info%max_am
1715 DO j = 1, nshell(iset)
1716 IF (basis_parameter(ikind)%nl(j, iset) == i) nl_count = nl_count + 1
1718 basis_parameter(ikind)%nsgfl(i, iset) = nl_count
1729 npgfa => basis_parameter(ikind)%npgf
1730 nseta = basis_parameter(ikind)%nset
1731 nl_a => basis_parameter(ikind)%nsgfl
1732 la_max => basis_parameter(ikind)%lmax
1733 la_min => basis_parameter(ikind)%lmin
1735 max_pgf_kind = max(max_pgf_kind, npgfa(iset))
1736 max_pgf = max(max_pgf, npgfa(iset))
1737 DO la = la_min(iset), la_max(iset)
1738 max_nsgfl = max(max_nsgfl, nl_a(la, iset))
1739 max_coeff = max(max_coeff, nso(la)*nl_a(la, iset)*nco(la))
1740 max_am_kind = max(max_am_kind, la)
1743 ALLOCATE (basis_parameter(ikind)%sphi_ext(max_coeff, 0:max_am_kind, max_pgf_kind, nseta))
1744 basis_parameter(ikind)%sphi_ext = 0.0_dp
1748 sphi_a => basis_parameter(ikind)%sphi
1749 nseta = basis_parameter(ikind)%nset
1750 la_max => basis_parameter(ikind)%lmax
1751 la_min => basis_parameter(ikind)%lmin
1752 npgfa => basis_parameter(ikind)%npgf
1753 first_sgfa => basis_parameter(ikind)%first_sgf
1754 nl_a => basis_parameter(ikind)%nsgfl
1756 sgfa = first_sgfa(1, iset)
1757 DO ipgf = 1, npgfa(iset)
1758 offset_a1 = (ipgf - 1)*
ncoset(la_max(iset))
1760 DO la = la_min(iset), la_max(iset)
1761 offset_a = offset_a1 +
ncoset(la - 1)
1763 co_counter = co_counter + 1
1765 DO k = sgfa + s_offset_nl_a, sgfa + s_offset_nl_a + nso(la)*nl_a(la, iset) - 1
1766 DO i = offset_a + 1, offset_a + nco(la)
1767 so_counter = so_counter + 1
1768 basis_parameter(ikind)%sphi_ext(so_counter, la, ipgf, iset) = sphi_a(i, k)
1771 s_offset_nl_a = s_offset_nl_a + nso(la)*(nl_a(la, iset))
1777 CALL timestop(handle)
1788 CHARACTER(LEN=*),
PARAMETER :: routinen =
'hfx_release_basis_types'
1790 INTEGER :: handle, i
1792 CALL timeset(routinen, handle)
1795 DO i = 1,
SIZE(basis_parameter)
1796 DEALLOCATE (basis_parameter(i)%nsgfl)
1797 DEALLOCATE (basis_parameter(i)%sphi_ext)
1799 DEALLOCATE (basis_parameter)
1800 CALL timestop(handle)
1817 i_thread, n_threads, para_env, irep, skip_disk, skip_in_core_forces)
1819 TYPE(section_vals_type),
POINTER :: hf_sub_section
1820 INTEGER,
INTENT(OUT),
OPTIONAL :: storage_id
1821 INTEGER,
INTENT(IN),
OPTIONAL :: i_thread, n_threads
1822 TYPE(mp_para_env_type),
OPTIONAL :: para_env
1823 INTEGER,
INTENT(IN),
OPTIONAL :: irep
1824 LOGICAL,
INTENT(IN) :: skip_disk, skip_in_core_forces
1826 CHARACTER(LEN=512) :: error_msg
1827 CHARACTER(LEN=default_path_length) :: char_val, filename, orig_wd
1828 INTEGER :: int_val, stat
1829 LOGICAL :: check, logic_val
1830 REAL(dp) :: real_val
1832 check = (
PRESENT(storage_id) .EQV.
PRESENT(i_thread)) .AND. &
1833 (
PRESENT(storage_id) .EQV.
PRESENT(n_threads)) .AND. &
1834 (
PRESENT(storage_id) .EQV.
PRESENT(para_env)) .AND. &
1835 (
PRESENT(storage_id) .EQV.
PRESENT(irep))
1839 CALL section_vals_val_get(hf_sub_section,
"MAX_MEMORY", i_val=int_val)
1840 memory_parameter%max_memory = int_val
1841 memory_parameter%max_compression_counter = int_val*1024_int_8*128_int_8
1842 CALL section_vals_val_get(hf_sub_section,
"EPS_STORAGE", r_val=real_val)
1843 memory_parameter%eps_storage_scaling = real_val
1844 IF (int_val == 0)
THEN
1845 memory_parameter%do_all_on_the_fly = .true.
1847 memory_parameter%do_all_on_the_fly = .false.
1849 memory_parameter%cache_size = cache_size
1850 memory_parameter%bits_max_val = bits_max_val
1851 memory_parameter%actual_memory_usage = 1
1852 IF (.NOT. skip_in_core_forces)
THEN
1853 CALL section_vals_val_get(hf_sub_section,
"TREAT_FORCES_IN_CORE", l_val=logic_val)
1854 memory_parameter%treat_forces_in_core = logic_val
1858 IF (memory_parameter%do_all_on_the_fly) memory_parameter%treat_forces_in_core = .false.
1861 IF (.NOT. skip_disk)
THEN
1862 memory_parameter%actual_memory_usage_disk = 1
1863 CALL section_vals_val_get(hf_sub_section,
"MAX_DISK_SPACE", i_val=int_val)
1864 memory_parameter%max_compression_counter_disk = int_val*1024_int_8*128_int_8
1865 IF (int_val == 0)
THEN
1866 memory_parameter%do_disk_storage = .false.
1868 memory_parameter%do_disk_storage = .true.
1870 CALL section_vals_val_get(hf_sub_section,
"STORAGE_LOCATION", c_val=char_val)
1871 CALL compress(char_val, .true.)
1874 IF (scan(char_val,
"/", .true.) /= len_trim(char_val))
THEN
1875 WRITE (filename,
'(A,A)') trim(char_val),
"/"
1876 CALL compress(filename)
1878 filename = trim(char_val)
1880 CALL compress(filename, .true.)
1883 CALL m_getcwd(orig_wd)
1884 CALL m_chdir(trim(filename), stat)
1886 WRITE (error_msg,
'(A,A,A)')
"Request for disk storage failed due to unknown error while writing to ", &
1887 trim(filename),
". Please check STORAGE_LOCATION"
1890 CALL m_chdir(orig_wd, stat)
1892 memory_parameter%storage_location = filename
1893 CALL compress(memory_parameter%storage_location, .true.)
1895 memory_parameter%do_disk_storage = .false.
1897 IF (
PRESENT(storage_id))
THEN
1898 storage_id = (irep - 1)*para_env%num_pe*n_threads + para_env%mepos*n_threads + i_thread - 1
1910 TYPE(
hfx_type),
DIMENSION(:, :),
POINTER :: x_data
1912 INTEGER :: i, i_thread, irep, n_rep_hf, n_threads
1913 TYPE(cp_logger_type),
POINTER :: logger
1914 TYPE(
hfx_type),
POINTER :: actual_x_data
1918 n_rep_hf = x_data(1, 1)%n_rep_hf
1919 n_threads =
SIZE(x_data, 2)
1921 IF (x_data(1, 1)%potential_parameter%potential_type == do_potential_truncated .OR. &
1922 x_data(1, 1)%potential_parameter%potential_type == do_potential_mix_cl_trunc)
THEN
1926 DO i_thread = 1, n_threads
1927 DO irep = 1, n_rep_hf
1928 actual_x_data => x_data(irep, i_thread)
1929 DEALLOCATE (actual_x_data%neighbor_cells)
1930 DEALLOCATE (actual_x_data%distribution_energy)
1931 DEALLOCATE (actual_x_data%distribution_forces)
1933 IF (actual_x_data%load_balance_parameter%blocks_initialized)
THEN
1934 DEALLOCATE (actual_x_data%blocks)
1935 IF (i_thread == 1)
THEN
1936 DEALLOCATE (actual_x_data%pmax_block)
1940 IF (i_thread == 1)
THEN
1941 DEALLOCATE (actual_x_data%atomic_pair_list)
1942 DEALLOCATE (actual_x_data%atomic_pair_list_forces)
1945 IF (actual_x_data%screening_parameter%do_initial_p_screening .OR. &
1946 actual_x_data%screening_parameter%do_p_screening_forces)
THEN
1947 IF (i_thread == 1)
THEN
1948 DEALLOCATE (actual_x_data%pmax_atom)
1949 DO i = 1,
SIZE(actual_x_data%initial_p)
1950 DEALLOCATE (actual_x_data%initial_p(i)%p_kind)
1952 DEALLOCATE (actual_x_data%initial_p)
1954 DEALLOCATE (actual_x_data%pmax_atom_forces)
1955 DO i = 1,
SIZE(actual_x_data%initial_p_forces)
1956 DEALLOCATE (actual_x_data%initial_p_forces(i)%p_kind)
1958 DEALLOCATE (actual_x_data%initial_p_forces)
1960 DEALLOCATE (actual_x_data%map_atom_to_kind_atom)
1962 IF (i_thread == 1)
THEN
1963 DEALLOCATE (actual_x_data%is_assoc_atomic_block)
1964 DEALLOCATE (actual_x_data%atomic_block_offset)
1965 DEALLOCATE (actual_x_data%set_offset)
1966 DEALLOCATE (actual_x_data%block_offset)
1973 CALL cp_libint_cleanup_eri(actual_x_data%lib)
1974 CALL cp_libint_cleanup_eri1(actual_x_data%lib_deriv)
1975 CALL cp_libint_static_cleanup()
1978 CALL dealloc_containers(actual_x_data%store_ints, actual_x_data%memory_parameter%actual_memory_usage)
1979 CALL dealloc_containers(actual_x_data%store_forces, actual_x_data%memory_parameter%actual_memory_usage)
1983 actual_x_data%memory_parameter%actual_memory_usage_disk, &
1985 IF (actual_x_data%memory_parameter%do_disk_storage)
THEN
1986 CALL close_file(unit_number=actual_x_data%store_ints%maxval_container_disk%unit, file_status=
"DELETE")
1988 DEALLOCATE (actual_x_data%store_ints%maxval_container_disk%first)
1989 DEALLOCATE (actual_x_data%store_ints%maxval_container_disk)
1993 actual_x_data%memory_parameter%actual_memory_usage_disk, &
1995 IF (actual_x_data%memory_parameter%do_disk_storage)
THEN
1996 CALL close_file(unit_number=actual_x_data%store_ints%integral_containers_disk(i)%unit, file_status=
"DELETE")
1998 DEALLOCATE (actual_x_data%store_ints%integral_containers_disk(i)%first)
2000 DEALLOCATE (actual_x_data%store_ints%integral_containers_disk)
2003 IF (actual_x_data%screen_funct_is_initialized)
THEN
2004 DEALLOCATE (actual_x_data%screen_funct_coeffs_set)
2005 DEALLOCATE (actual_x_data%screen_funct_coeffs_kind)
2006 DEALLOCATE (actual_x_data%pair_dist_radii_pgf)
2007 DEALLOCATE (actual_x_data%screen_funct_coeffs_pgf)
2008 actual_x_data%screen_funct_is_initialized = .false.
2012 IF (
ASSOCIATED(actual_x_data%map_atoms_to_cpus))
THEN
2013 DO i = 1,
SIZE(actual_x_data%map_atoms_to_cpus)
2014 DEALLOCATE (actual_x_data%map_atoms_to_cpus(i)%iatom_list)
2015 DEALLOCATE (actual_x_data%map_atoms_to_cpus(i)%jatom_list)
2017 DEALLOCATE (actual_x_data%map_atoms_to_cpus)
2020 IF (actual_x_data%do_hfx_ri)
THEN
2022 IF (
ASSOCIATED(actual_x_data%ri_data%ri_section))
THEN
2023 logger => cp_get_default_logger()
2024 CALL cp_print_key_finished_output(actual_x_data%ri_data%unit_nr_dbcsr, logger, actual_x_data%ri_data%ri_section, &
2027 IF (
ASSOCIATED(actual_x_data%ri_data%hfx_section))
THEN
2028 logger => cp_get_default_logger()
2029 CALL cp_print_key_finished_output(actual_x_data%ri_data%unit_nr, logger, actual_x_data%ri_data%hfx_section, &
2032 DEALLOCATE (actual_x_data%ri_data)
2055 INTEGER,
INTENT(INOUT) :: pbc_shells
2056 TYPE(cell_type),
POINTER :: cell
2057 INTEGER,
INTENT(IN) :: i_thread
2058 INTEGER,
DIMENSION(3),
OPTIONAL :: nkp_grid
2060 CHARACTER(LEN=512) :: error_msg
2061 CHARACTER(LEN=64) :: char_nshells
2062 INTEGER :: i,
idx, ikind, ipgf, iset, ishell, j, jkind, jpgf, jset, jshell, k, kshell, l, &
2063 m(3), max_shell, nkp(3), nseta, nsetb, perd(3), total_number_of_cells, ub, ub_max
2064 INTEGER,
DIMENSION(:),
POINTER :: la_max, lb_max, npgfa, npgfb
2065 LOGICAL :: do_kpoints, image_cell_found, &
2067 REAL(dp) :: cross_product(3), dist_min, distance(14), l_min, normal(3, 6), p(3, 14), &
2068 plane_vector(3, 2), point_in_plane(3), r(3), r1, r_max, r_max_stress, s(3), x, y, z, zeta1
2069 REAL(dp),
DIMENSION(:, :),
POINTER :: zeta, zetb
2070 TYPE(
hfx_cell_type),
ALLOCATABLE,
DIMENSION(:) :: tmp_neighbor_cells
2072 total_number_of_cells = 0
2075 IF (
PRESENT(nkp_grid)) nkp = nkp_grid
2076 do_kpoints = any(nkp > 1)
2079 IF (i_thread == 1)
THEN
2080 IF (x_data%potential_parameter%potential_type /= do_potential_truncated .AND. &
2081 x_data%potential_parameter%potential_type /= do_potential_short .AND. &
2082 x_data%potential_parameter%potential_type /= do_potential_mix_cl_trunc .AND. &
2083 x_data%potential_parameter%potential_type /= do_potential_id)
THEN
2084 CALL cp_warn(__location__, &
2085 "Periodic Hartree Fock calculation requested without use "// &
2086 "of a truncated or shortrange potential. This may lead to unphysical total energies. "// &
2087 "Use a truncated potential to avoid possible problems.")
2088 ELSE IF (x_data%potential_parameter%potential_type /= do_potential_id)
THEN
2090 l_min = min(real(nkp(1), dp)*plane_distance(1, 0, 0, cell), &
2091 REAL(nkp(2), dp)*plane_distance(0, 1, 0, cell), &
2092 REAL(nkp(3), dp)*plane_distance(0, 0, 1, cell))
2093 l_min = 0.5_dp*l_min
2094 IF (x_data%potential_parameter%cutoff_radius >= l_min)
THEN
2095 IF (.NOT. do_kpoints)
THEN
2096 CALL cp_warn(__location__, &
2097 "Periodic Hartree Fock calculation requested with the use "// &
2098 "of a truncated or shortrange potential. The cutoff radius is larger than half "// &
2099 "the minimal cell dimension. This may lead to unphysical "// &
2100 "total energies. Reduce the cutoff radius in order to avoid "// &
2101 "possible problems.")
2103 CALL cp_warn(__location__, &
2104 "K-point Hartree-Fock calculation requested with the use of a "// &
2105 "truncated or shortrange potential. The cutoff radius is larger than "// &
2106 "half the minimal Born-von Karman supercell dimension. This may lead "// &
2107 "to unphysical total energies. Reduce the cutoff radius or increase "// &
2108 "the number of K-points in order to avoid possible problems.")
2114 SELECT CASE (x_data%potential_parameter%potential_type)
2115 CASE (do_potential_truncated, do_potential_mix_cl_trunc, do_potential_short)
2117 DO ikind = 1,
SIZE(x_data%basis_parameter)
2118 la_max => x_data%basis_parameter(ikind)%lmax
2119 zeta => x_data%basis_parameter(ikind)%zet
2120 nseta = x_data%basis_parameter(ikind)%nset
2121 npgfa => x_data%basis_parameter(ikind)%npgf
2122 DO jkind = 1,
SIZE(x_data%basis_parameter)
2123 lb_max => x_data%basis_parameter(jkind)%lmax
2124 zetb => x_data%basis_parameter(jkind)%zet
2125 nsetb = x_data%basis_parameter(jkind)%nset
2126 npgfb => x_data%basis_parameter(jkind)%npgf
2129 DO ipgf = 1, npgfa(iset)
2130 DO jpgf = 1, npgfb(jset)
2131 zeta1 = zeta(ipgf, iset) + zetb(jpgf, jset)
2132 r1 = 1.0_dp/sqrt(zeta1)*
mul_fact(la_max(iset) + lb_max(jset))* &
2133 sqrt(-log(x_data%screening_parameter%eps_schwarz))
2134 r_max = max(r1, r_max)
2142 r_max = 2.0_dp*r_max + x_data%potential_parameter%cutoff_radius
2143 nothing_more_to_add = .false.
2145 total_number_of_cells = 0
2147 DEALLOCATE (x_data%neighbor_cells)
2148 ALLOCATE (x_data%neighbor_cells(1))
2149 x_data%neighbor_cells(1)%cell = 0.0_dp
2150 x_data%neighbor_cells(1)%cell_r = 0.0_dp
2187 DO WHILE (.NOT. nothing_more_to_add)
2189 image_cell_found = .false.
2190 ALLOCATE (tmp_neighbor_cells(1:ub))
2192 tmp_neighbor_cells(i) = x_data%neighbor_cells(i)
2194 ub_max = (2*max_shell + 1)**3
2195 DEALLOCATE (x_data%neighbor_cells)
2196 ALLOCATE (x_data%neighbor_cells(1:ub_max))
2198 x_data%neighbor_cells(i) = tmp_neighbor_cells(i)
2201 x_data%neighbor_cells(i)%cell = 0.0_dp
2202 x_data%neighbor_cells(i)%cell_r = 0.0_dp
2205 DEALLOCATE (tmp_neighbor_cells)
2207 perd(1:3) = x_data%periodic_parameter%perd(1:3)
2209 DO ishell = -max_shell*perd(1), max_shell*perd(1)
2210 DO jshell = -max_shell*perd(2), max_shell*perd(2)
2211 DO kshell = -max_shell*perd(3), max_shell*perd(3)
2212 IF (max(abs(ishell), abs(jshell), abs(kshell)) /= max_shell) cycle
2215 x = -1.0_dp/2.0_dp + j*1.0_dp
2217 y = -1.0_dp/2.0_dp + k*1.0_dp
2219 z = -1.0_dp/2.0_dp + l*1.0_dp
2221 p(1,
idx) = x + ishell
2222 p(2,
idx) = y + jshell
2223 p(3,
idx) = z + kshell
2224 CALL scaled_to_real(r, p(:,
idx), cell)
2225 distance(
idx) = sqrt(sum(r**2))
2234 plane_vector(:, 1) = p(:, 3) - p(:, 1)
2235 plane_vector(:, 2) = p(:, 2) - p(:, 1)
2236 cross_product(1) = plane_vector(2, 1)*plane_vector(3, 2) - plane_vector(3, 1)*plane_vector(2, 2)
2237 cross_product(2) = plane_vector(3, 1)*plane_vector(1, 2) - plane_vector(1, 1)*plane_vector(3, 2)
2238 cross_product(3) = plane_vector(1, 1)*plane_vector(2, 2) - plane_vector(2, 1)*plane_vector(1, 2)
2239 normal(:, 1) = cross_product/sqrt(sum(cross_product**2))
2240 point_in_plane = -normal(:, 1)*(normal(1, 1)*p(1, 1) + normal(2, 1)*p(2, 1) + normal(3, 1)*p(3, 1))
2242 IF (point_is_in_quadrilateral(p(:, 1), p(:, 3), p(:, 4), p(:, 2), point_in_plane))
THEN
2243 distance(
idx) = abs(normal(1, 1)*p(1, 1) + normal(2, 1)*p(2, 1) + normal(3, 1)*p(3, 1))
2245 distance(
idx) = huge(distance(
idx))
2250 plane_vector(:, 1) = p(:, 2) - p(:, 1)
2251 plane_vector(:, 2) = p(:, 5) - p(:, 1)
2252 cross_product(1) = plane_vector(2, 1)*plane_vector(3, 2) - plane_vector(3, 1)*plane_vector(2, 2)
2253 cross_product(2) = plane_vector(3, 1)*plane_vector(1, 2) - plane_vector(1, 1)*plane_vector(3, 2)
2254 cross_product(3) = plane_vector(1, 1)*plane_vector(2, 2) - plane_vector(2, 1)*plane_vector(1, 2)
2255 normal(:, 1) = cross_product/sqrt(sum(cross_product**2))
2256 point_in_plane = -normal(:, 1)*(normal(1, 1)*p(1, 1) + normal(2, 1)*p(2, 1) + normal(3, 1)*p(3, 1))
2258 IF (point_is_in_quadrilateral(p(:, 1), p(:, 5), p(:, 6), p(:, 2), point_in_plane))
THEN
2259 distance(
idx) = abs(normal(1, 1)*p(1, 1) + normal(2, 1)*p(2, 1) + normal(3, 1)*p(3, 1))
2261 distance(
idx) = huge(distance(
idx))
2266 plane_vector(:, 1) = p(:, 7) - p(:, 5)
2267 plane_vector(:, 2) = p(:, 6) - p(:, 5)
2268 cross_product(1) = plane_vector(2, 1)*plane_vector(3, 2) - plane_vector(3, 1)*plane_vector(2, 2)
2269 cross_product(2) = plane_vector(3, 1)*plane_vector(1, 2) - plane_vector(1, 1)*plane_vector(3, 2)
2270 cross_product(3) = plane_vector(1, 1)*plane_vector(2, 2) - plane_vector(2, 1)*plane_vector(1, 2)
2271 normal(:, 1) = cross_product/sqrt(sum(cross_product**2))
2272 point_in_plane = -normal(:, 1)*(normal(1, 1)*p(1, 5) + normal(2, 1)*p(2, 5) + normal(3, 1)*p(3, 5))
2274 IF (point_is_in_quadrilateral(p(:, 5), p(:, 7), p(:, 8), p(:, 6), point_in_plane))
THEN
2275 distance(
idx) = abs(normal(1, 1)*p(1, 5) + normal(2, 1)*p(2, 5) + normal(3, 1)*p(3, 5))
2277 distance(
idx) = huge(distance(
idx))
2282 plane_vector(:, 1) = p(:, 7) - p(:, 3)
2283 plane_vector(:, 2) = p(:, 4) - p(:, 3)
2284 cross_product(1) = plane_vector(2, 1)*plane_vector(3, 2) - plane_vector(3, 1)*plane_vector(2, 2)
2285 cross_product(2) = plane_vector(3, 1)*plane_vector(1, 2) - plane_vector(1, 1)*plane_vector(3, 2)
2286 cross_product(3) = plane_vector(1, 1)*plane_vector(2, 2) - plane_vector(2, 1)*plane_vector(1, 2)
2287 normal(:, 1) = cross_product/sqrt(sum(cross_product**2))
2288 point_in_plane = -normal(:, 1)*(normal(1, 1)*p(1, 3) + normal(2, 1)*p(2, 3) + normal(3, 1)*p(3, 3))
2290 IF (point_is_in_quadrilateral(p(:, 3), p(:, 7), p(:, 8), p(:, 4), point_in_plane))
THEN
2291 distance(
idx) = abs(normal(1, 1)*p(1, 3) + normal(2, 1)*p(2, 3) + normal(3, 1)*p(3, 3))
2293 distance(
idx) = huge(distance(
idx))
2298 plane_vector(:, 1) = p(:, 6) - p(:, 2)
2299 plane_vector(:, 2) = p(:, 4) - p(:, 2)
2300 cross_product(1) = plane_vector(2, 1)*plane_vector(3, 2) - plane_vector(3, 1)*plane_vector(2, 2)
2301 cross_product(2) = plane_vector(3, 1)*plane_vector(1, 2) - plane_vector(1, 1)*plane_vector(3, 2)
2302 cross_product(3) = plane_vector(1, 1)*plane_vector(2, 2) - plane_vector(2, 1)*plane_vector(1, 2)
2303 normal(:, 1) = cross_product/sqrt(sum(cross_product**2))
2304 point_in_plane = -normal(:, 1)*(normal(1, 1)*p(1, 2) + normal(2, 1)*p(2, 2) + normal(3, 1)*p(3, 2))
2306 IF (point_is_in_quadrilateral(p(:, 2), p(:, 6), p(:, 8), p(:, 4), point_in_plane))
THEN
2307 distance(
idx) = abs(normal(1, 1)*p(1, 2) + normal(2, 1)*p(2, 2) + normal(3, 1)*p(3, 2))
2309 distance(
idx) = huge(distance(
idx))
2314 plane_vector(:, 1) = p(:, 5) - p(:, 1)
2315 plane_vector(:, 2) = p(:, 3) - p(:, 1)
2316 cross_product(1) = plane_vector(2, 1)*plane_vector(3, 2) - plane_vector(3, 1)*plane_vector(2, 2)
2317 cross_product(2) = plane_vector(3, 1)*plane_vector(1, 2) - plane_vector(1, 1)*plane_vector(3, 2)
2318 cross_product(3) = plane_vector(1, 1)*plane_vector(2, 2) - plane_vector(2, 1)*plane_vector(1, 2)
2319 normal(:, 1) = cross_product/sqrt(sum(cross_product**2))
2320 point_in_plane = -normal(:, 1)*(normal(1, 1)*p(1, 1) + normal(2, 1)*p(2, 1) + normal(3, 1)*p(3, 1))
2322 IF (point_is_in_quadrilateral(p(:, 1), p(:, 5), p(:, 7), p(:, 3), point_in_plane))
THEN
2323 distance(
idx) = abs(normal(1, 1)*p(1, 1) + normal(2, 1)*p(2, 1) + normal(3, 1)*p(3, 1))
2325 distance(
idx) = huge(distance(
idx))
2328 dist_min = minval(distance)
2329 IF (max_shell == 0)
THEN
2330 image_cell_found = .true.
2332 IF (dist_min < r_max)
THEN
2333 total_number_of_cells = total_number_of_cells + 1
2334 x_data%neighbor_cells(ub)%cell = real((/ishell, jshell, kshell/), dp)
2336 image_cell_found = .true.
2342 IF (image_cell_found)
THEN
2343 max_shell = max_shell + 1
2345 nothing_more_to_add = .true.
2349 ALLOCATE (tmp_neighbor_cells(total_number_of_cells))
2351 tmp_neighbor_cells(i) = x_data%neighbor_cells(i)
2353 DEALLOCATE (x_data%neighbor_cells)
2355 IF (total_number_of_cells == 0)
THEN
2356 total_number_of_cells = 1
2357 ALLOCATE (x_data%neighbor_cells(total_number_of_cells))
2358 DO i = 1, total_number_of_cells
2359 x_data%neighbor_cells(i)%cell = 0.0_dp
2360 x_data%neighbor_cells(i)%cell_r = 0.0_dp
2363 ALLOCATE (x_data%neighbor_cells(total_number_of_cells))
2364 DO i = 1, total_number_of_cells
2365 x_data%neighbor_cells(i) = tmp_neighbor_cells(i)
2368 DEALLOCATE (tmp_neighbor_cells)
2370 IF (x_data%periodic_parameter%number_of_shells == do_hfx_auto_shells)
THEN
2373 total_number_of_cells = 0
2374 DO i = 0, x_data%periodic_parameter%number_of_shells
2375 total_number_of_cells = total_number_of_cells + count_cells_perd(i, x_data%periodic_parameter%perd)
2377 IF (total_number_of_cells <
SIZE(x_data%neighbor_cells))
THEN
2378 IF (i_thread == 1)
THEN
2379 WRITE (char_nshells,
'(I3)')
SIZE(x_data%neighbor_cells)
2380 WRITE (error_msg,
'(A,A,A)')
"Periodic Hartree Fock calculation requested with use "// &
2381 "of a truncated potential. The number of shells to be considered "// &
2382 "might be too small. CP2K conservatively estimates to need "//trim(char_nshells)//
" periodic images "// &
2383 "Please carefully check if you get converged results."
2387 total_number_of_cells = 0
2388 DO i = 0, x_data%periodic_parameter%number_of_shells
2389 total_number_of_cells = total_number_of_cells + count_cells_perd(i, x_data%periodic_parameter%perd)
2391 DEALLOCATE (x_data%neighbor_cells)
2393 ALLOCATE (x_data%neighbor_cells(total_number_of_cells))
2396 DO WHILE (sum(m**2) <= x_data%periodic_parameter%number_of_shells)
2397 x_data%neighbor_cells(i)%cell = real(m, dp)
2398 CALL next_image_cell_perd(m, x_data%periodic_parameter%perd)
2403 total_number_of_cells = 0
2404 IF (pbc_shells == -1) pbc_shells = 0
2405 DO i = 0, pbc_shells
2406 total_number_of_cells = total_number_of_cells + count_cells_perd(i, x_data%periodic_parameter%perd)
2408 DEALLOCATE (x_data%neighbor_cells)
2410 ALLOCATE (x_data%neighbor_cells(total_number_of_cells))
2414 DO WHILE (sum(m**2) <= pbc_shells)
2415 x_data%neighbor_cells(i)%cell = real(m, dp)
2416 CALL next_image_cell_perd(m, x_data%periodic_parameter%perd)
2422 DO i = 1,
SIZE(x_data%neighbor_cells)
2424 x_data%neighbor_cells(i)%cell_r(:) = 0.0_dp
2425 s = x_data%neighbor_cells(i)%cell(:)
2426 CALL scaled_to_real(x_data%neighbor_cells(i)%cell_r, s, cell)
2428 x_data%periodic_parameter%number_of_shells = pbc_shells
2430 r_max_stress = 0.0_dp
2431 DO i = 1,
SIZE(x_data%neighbor_cells)
2432 r_max_stress = max(r_max_stress, maxval(abs(x_data%neighbor_cells(i)%cell_r(:))))
2434 r_max_stress = r_max_stress + abs(maxval(cell%hmat(:, :)))
2435 x_data%periodic_parameter%R_max_stress = r_max_stress
2449 FUNCTION point_is_in_quadrilateral(A, B, C, D, P)
2450 REAL(dp) :: a(3), b(3), c(3), d(3), p(3)
2451 LOGICAL :: point_is_in_quadrilateral
2453 REAL(dp),
PARAMETER :: fuzzy = 1000.0_dp*epsilon(1.0_dp)
2455 REAL(dp) :: dot00, dot01, dot02, dot11, dot12, &
2456 invdenom, u, v, v0(3), v1(3), v2(3)
2458 point_is_in_quadrilateral = .false.
2477 dot00 = dot_product(v0, v0)
2478 dot01 = dot_product(v0, v1)
2479 dot02 = dot_product(v0, v2)
2480 dot11 = dot_product(v1, v1)
2481 dot12 = dot_product(v1, v2)
2484 invdenom = 1/(dot00*dot11 - dot01*dot01)
2485 u = (dot11*dot02 - dot01*dot12)*invdenom
2486 v = (dot00*dot12 - dot01*dot02)*invdenom
2488 IF ((u >= 0 - fuzzy) .AND. (v >= 0 - fuzzy) .AND. (u + v <= 1 + fuzzy))
THEN
2489 point_is_in_quadrilateral = .true.
2497 dot00 = dot_product(v0, v0)
2498 dot01 = dot_product(v0, v1)
2499 dot02 = dot_product(v0, v2)
2500 dot11 = dot_product(v1, v1)
2501 dot12 = dot_product(v1, v2)
2504 invdenom = 1/(dot00*dot11 - dot01*dot01)
2505 u = (dot11*dot02 - dot01*dot12)*invdenom
2506 v = (dot00*dot12 - dot01*dot02)*invdenom
2509 IF ((u >= 0 - fuzzy) .AND. (v >= 0 - fuzzy) .AND. (u + v <= 1 + fuzzy))
THEN
2510 point_is_in_quadrilateral = .true.
2514 END FUNCTION point_is_in_quadrilateral
2528 INTEGER :: memory_usage
2529 LOGICAL :: do_disk_storage
2531 TYPE(hfx_container_node),
POINTER :: current, next
2535 current => container%first
2536 DO WHILE (
ASSOCIATED(current))
2537 next => current%next
2538 DEALLOCATE (current)
2543 ALLOCATE (container%first)
2544 container%first%prev => null()
2545 container%first%next => null()
2546 container%current => container%first
2547 container%current%data = 0
2548 container%element_counter = 1
2551 IF (do_disk_storage)
THEN
2553 IF (container%unit /= -1)
THEN
2554 CALL close_file(unit_number=container%unit)
2556 CALL open_file(file_name=trim(container%filename), file_status=
"UNKNOWN", file_form=
"UNFORMATTED", file_action=
"WRITE", &
2557 unit_number=container%unit)
2575 DEALLOCATE (x_data%distribution_energy)
2577 ALLOCATE (x_data%distribution_energy(
SIZE(ptr_to_distr)))
2578 x_data%distribution_energy = ptr_to_distr
2595 DEALLOCATE (x_data%distribution_forces)
2597 ALLOCATE (x_data%distribution_forces(
SIZE(ptr_to_distr)))
2598 x_data%distribution_forces = ptr_to_distr
2615 INTEGER(int_8),
INTENT(IN) :: subtr_size_mb
2617 INTEGER(int_8) :: max_memory
2619 max_memory = memory_parameter%max_memory
2620 max_memory = max_memory - subtr_size_mb
2621 IF (max_memory <= 0)
THEN
2622 memory_parameter%do_all_on_the_fly = .true.
2623 memory_parameter%max_compression_counter = 0
2625 memory_parameter%do_all_on_the_fly = .false.
2626 memory_parameter%max_compression_counter = max_memory*1024_int_8*128_int_8
2638 SUBROUTINE hfx_print_std_info(x_data, hfx_section)
2640 TYPE(section_vals_type),
POINTER :: hfx_section
2643 TYPE(cp_logger_type),
POINTER :: logger
2646 logger => cp_get_default_logger()
2648 iw = cp_print_key_unit_nr(logger, hfx_section,
"HF_INFO", &
2649 extension=
".scfLog")
2652 WRITE (unit=iw, fmt=
"((T3,A,T73,ES8.1))") &
2653 "HFX_INFO| EPS_SCHWARZ: ", x_data%screening_parameter%eps_schwarz
2654 WRITE (unit=iw, fmt=
"((T3,A,T73,ES8.1))") &
2655 "HFX_INFO| EPS_SCHWARZ_FORCES ", x_data%screening_parameter%eps_schwarz_forces
2656 WRITE (unit=iw, fmt=
"((T3,A,T73,ES8.1))") &
2657 "HFX_INFO| EPS_STORAGE_SCALING: ", x_data%memory_parameter%eps_storage_scaling
2658 WRITE (unit=iw, fmt=
"((T3,A,T61,I20))") &
2659 "HFX_INFO| NBINS: ", x_data%load_balance_parameter%nbins
2660 WRITE (unit=iw, fmt=
"((T3,A,T61,I20))") &
2661 "HFX_INFO| BLOCK_SIZE: ", x_data%load_balance_parameter%block_size
2662 IF (x_data%periodic_parameter%do_periodic)
THEN
2663 IF (x_data%periodic_parameter%mode == -1)
THEN
2664 WRITE (unit=iw, fmt=
"((T3,A,T77,A))") &
2665 "HFX_INFO| NUMBER_OF_SHELLS: ",
"AUTO"
2667 WRITE (unit=iw, fmt=
"((T3,A,T61,I20))") &
2668 "HFX_INFO| NUMBER_OF_SHELLS: ", x_data%periodic_parameter%mode
2670 WRITE (unit=iw, fmt=
"((T3,A,T61,I20))") &
2671 "HFX_INFO| Number of periodic shells considered: ", x_data%periodic_parameter%number_of_shells
2672 WRITE (unit=iw, fmt=
"((T3,A,T61,I20),/)") &
2673 "HFX_INFO| Number of periodic cells considered: ",
SIZE(x_data%neighbor_cells)
2675 WRITE (unit=iw, fmt=
"((T3,A,T77,A))") &
2676 "HFX_INFO| Number of periodic shells considered: ",
"NONE"
2677 WRITE (unit=iw, fmt=
"((T3,A,T77,A),/)") &
2678 "HFX_INFO| Number of periodic cells considered: ",
"NONE"
2681 END SUBROUTINE hfx_print_std_info
2688 SUBROUTINE hfx_print_ri_info(ri_data, hfx_section)
2690 TYPE(section_vals_type),
POINTER :: hfx_section
2694 TYPE(cp_logger_type),
POINTER :: logger
2695 TYPE(section_vals_type),
POINTER :: ri_section
2697 NULLIFY (logger, ri_section)
2698 logger => cp_get_default_logger()
2700 ri_section => ri_data%ri_section
2702 iw = cp_print_key_unit_nr(logger, hfx_section,
"HF_INFO", &
2703 extension=
".scfLog")
2707 associate(ri_metric => ri_data%ri_metric, hfx_pot => ri_data%hfx_pot)
2708 SELECT CASE (ri_metric%potential_type)
2709 CASE (do_potential_coulomb)
2710 WRITE (unit=iw, fmt=
"(/T3,A,T74,A)") &
2711 "HFX_RI_INFO| RI metric: ",
"COULOMB"
2712 CASE (do_potential_short)
2713 WRITE (unit=iw, fmt=
"(T3,A,T71,A)") &
2714 "HFX_RI_INFO| RI metric: ",
"SHORTRANGE"
2715 WRITE (iw,
'(T3,A,T61,F20.10)') &
2716 "HFX_RI_INFO| Omega: ", ri_metric%omega
2717 rc_ang = cp_unit_from_cp2k(ri_metric%cutoff_radius,
"angstrom")
2718 WRITE (iw,
'(T3,A,T61,F20.10)') &
2719 "HFX_RI_INFO| Cutoff Radius [angstrom]: ", rc_ang
2720 CASE (do_potential_long)
2721 WRITE (unit=iw, fmt=
"(T3,A,T72,A)") &
2722 "HFX_RI_INFO| RI metric: ",
"LONGRANGE"
2723 WRITE (iw,
'(T3,A,T61,F20.10)') &
2724 "HFX_RI_INFO| Omega: ", ri_metric%omega
2725 CASE (do_potential_id)
2726 WRITE (unit=iw, fmt=
"(T3,A,T73,A)") &
2727 "HFX_RI_INFO| RI metric: ",
"OVERLAP"
2728 CASE (do_potential_truncated)
2729 WRITE (unit=iw, fmt=
"(T3,A,T72,A)") &
2730 "HFX_RI_INFO| RI metric: ",
"TRUNCATED COULOMB"
2731 rc_ang = cp_unit_from_cp2k(ri_metric%cutoff_radius,
"angstrom")
2732 WRITE (iw,
'(T3,A,T61,F20.10)') &
2733 "HFX_RI_INFO| Cutoff Radius [angstrom]: ", rc_ang
2737 SELECT CASE (ri_data%flavor)
2739 WRITE (unit=iw, fmt=
"(T3, A, T79, A)") &
2740 "HFX_RI_INFO| RI flavor: ",
"MO"
2742 WRITE (unit=iw, fmt=
"(T3, A, T78, A)") &
2743 "HFX_RI_INFO| RI flavor: ",
"RHO"
2745 SELECT CASE (ri_data%t2c_method)
2746 CASE (hfx_ri_do_2c_iter)
2747 WRITE (unit=iw, fmt=
"(T3, A, T69, A)") &
2748 "HFX_RI_INFO| Matrix SQRT/INV",
"DBCSR / iter"
2749 CASE (hfx_ri_do_2c_diag)
2750 WRITE (unit=iw, fmt=
"(T3, A, T65, A)") &
2751 "HFX_RI_INFO| Matrix SQRT/INV",
"Dense / diag"
2753 WRITE (unit=iw, fmt=
"(T3, A, T73, ES8.1)") &
2754 "HFX_RI_INFO| EPS_FILTER", ri_data%filter_eps
2755 WRITE (unit=iw, fmt=
"(T3, A, T73, ES8.1)") &
2756 "HFX_RI_INFO| EPS_FILTER 2-center", ri_data%filter_eps_2c
2757 WRITE (unit=iw, fmt=
"(T3, A, T73, ES8.1)") &
2758 "HFX_RI_INFO| EPS_FILTER storage", ri_data%filter_eps_storage
2759 WRITE (unit=iw, fmt=
"(T3, A, T73, ES8.1)") &
2760 "HFX_RI_INFO| EPS_FILTER MO", ri_data%filter_eps_mo
2761 WRITE (unit=iw, fmt=
"(T3, A, T73, ES8.1)") &
2762 "HFX_RI_INFO| EPS_PGF_ORB", ri_data%eps_pgf_orb
2763 WRITE (unit=iw, fmt=
"((T3, A, T73, ES8.1))") &
2764 "HFX_RI_INFO| EPS_SCHWARZ: ", ri_data%eps_schwarz
2765 WRITE (unit=iw, fmt=
"((T3, A, T73, ES8.1))") &
2766 "HFX_RI_INFO| EPS_SCHWARZ_FORCES: ", ri_data%eps_schwarz_forces
2767 WRITE (unit=iw, fmt=
"(T3, A, T78, I3)") &
2768 "HFX_RI_INFO| Minimum block size", ri_data%min_bsize
2769 WRITE (unit=iw, fmt=
"(T3, A, T78, I3)") &
2770 "HFX_RI_INFO| MO block size", ri_data%max_bsize_MO
2771 WRITE (unit=iw, fmt=
"(T3, A, T79, I2)") &
2772 "HFX_RI_INFO| Memory reduction factor", ri_data%n_mem_input
2783 SUBROUTINE hfx_print_info(x_data, hfx_section, i_rep)
2785 TYPE(section_vals_type),
POINTER :: hfx_section
2786 INTEGER,
INTENT(IN) :: i_rep
2790 TYPE(cp_logger_type),
POINTER :: logger
2793 logger => cp_get_default_logger()
2795 iw = cp_print_key_unit_nr(logger, hfx_section,
"HF_INFO", &
2796 extension=
".scfLog")
2799 WRITE (unit=iw, fmt=
"(/,(T3,A,T61,I20))") &
2800 "HFX_INFO| Replica ID: ", i_rep
2802 WRITE (iw,
'(T3,A,T61,F20.10)') &
2803 "HFX_INFO| FRACTION: ", x_data%general_parameter%fraction
2804 SELECT CASE (x_data%potential_parameter%potential_type)
2805 CASE (do_potential_coulomb)
2806 WRITE (unit=iw, fmt=
"((T3,A,T74,A))") &
2807 "HFX_INFO| Interaction Potential: ",
"COULOMB"
2808 CASE (do_potential_short)
2809 WRITE (unit=iw, fmt=
"((T3,A,T71,A))") &
2810 "HFX_INFO| Interaction Potential: ",
"SHORTRANGE"
2811 WRITE (iw,
'(T3,A,T61,F20.10)') &
2812 "HFX_INFO| Omega: ", x_data%potential_parameter%omega
2813 rc_ang = cp_unit_from_cp2k(x_data%potential_parameter%cutoff_radius,
"angstrom")
2814 WRITE (iw,
'(T3,A,T61,F20.10)') &
2815 "HFX_INFO| Cutoff Radius [angstrom]: ", rc_ang
2816 CASE (do_potential_long)
2817 WRITE (unit=iw, fmt=
"((T3,A,T72,A))") &
2818 "HFX_INFO| Interaction Potential: ",
"LONGRANGE"
2819 WRITE (iw,
'(T3,A,T61,F20.10)') &
2820 "HFX_INFO| Omega: ", x_data%potential_parameter%omega
2821 CASE (do_potential_mix_cl)
2822 WRITE (unit=iw, fmt=
"((T3,A,T75,A))") &
2823 "HFX_INFO| Interaction Potential: ",
"MIX_CL"
2824 WRITE (iw,
'(T3,A,T61,F20.10)') &
2825 "HFX_INFO| Omega: ", x_data%potential_parameter%omega
2826 WRITE (iw,
'(T3,A,T61,F20.10)') &
2827 "HFX_INFO| SCALE_COULOMB: ", x_data%potential_parameter%scale_coulomb
2828 WRITE (iw,
'(T3,A,T61,F20.10)') &
2829 "HFX_INFO| SCALE_LONGRANGE: ", x_data%potential_parameter%scale_longrange
2830 CASE (do_potential_gaussian)
2831 WRITE (unit=iw, fmt=
"((T3,A,T73,A))") &
2832 "HFX_INFO| Interaction Potential: ",
"GAUSSIAN"
2833 WRITE (iw,
'(T3,A,T61,F20.10)') &
2834 "HFX_INFO| Omega: ", x_data%potential_parameter%omega
2835 CASE (do_potential_mix_lg)
2836 WRITE (unit=iw, fmt=
"((T3,A,T75,A))") &
2837 "HFX_INFO| Interaction Potential: ",
"MIX_LG"
2838 WRITE (iw,
'(T3,A,T61,F20.10)') &
2839 "HFX_INFO| Omega: ", x_data%potential_parameter%omega
2840 WRITE (iw,
'(T3,A,T61,F20.10)') &
2841 "HFX_INFO| SCALE_LONGRANGE: ", x_data%potential_parameter%scale_longrange
2842 WRITE (iw,
'(T3,A,T61,F20.10)') &
2843 "HFX_INFO| SCALE_GAUSSIAN: ", x_data%potential_parameter%scale_gaussian
2844 CASE (do_potential_id)
2845 WRITE (unit=iw, fmt=
"((T3,A,T73,A))") &
2846 "HFX_INFO| Interaction Potential: ",
"IDENTITY"
2847 CASE (do_potential_truncated)
2848 WRITE (unit=iw, fmt=
"((T3,A,T72,A))") &
2849 "HFX_INFO| Interaction Potential: ",
"TRUNCATED"
2850 rc_ang = cp_unit_from_cp2k(x_data%potential_parameter%cutoff_radius,
"angstrom")
2851 WRITE (iw,
'(T3,A,T61,F20.10)') &
2852 "HFX_INFO| Cutoff Radius [angstrom]: ", rc_ang
2853 CASE (do_potential_mix_cl_trunc)
2854 WRITE (unit=iw, fmt=
"((T3,A,T65,A))") &
2855 "HFX_INFO| Interaction Potential: ",
"TRUNCATED MIX_CL"
2856 rc_ang = cp_unit_from_cp2k(x_data%potential_parameter%cutoff_radius,
"angstrom")
2857 WRITE (iw,
'(T3,A,T61,F20.10)') &
2858 "HFX_INFO| Cutoff Radius [angstrom]: ", rc_ang
2862 IF (x_data%do_hfx_ri)
THEN
2863 CALL hfx_print_ri_info(x_data%ri_data, hfx_section)
2865 CALL hfx_print_std_info(x_data, hfx_section)
2868 CALL cp_print_key_finished_output(iw, logger, hfx_section, &
2879 INTEGER :: memory_usage
2883 DO bin = 1,
SIZE(data%maxval_container)
2886 DEALLOCATE (data%maxval_container(bin)%first)
2888 DEALLOCATE (data%maxval_container)
2889 DEALLOCATE (data%maxval_cache)
2891 DO bin = 1,
SIZE(data%integral_containers, 2)
2895 DEALLOCATE (data%integral_containers(i, bin)%first)
2898 DEALLOCATE (data%integral_containers)
2900 DEALLOCATE (data%integral_caches)
2911 INTEGER,
INTENT(IN) :: bin_size
2915 ALLOCATE (data%maxval_cache(bin_size))
2916 DO bin = 1, bin_size
2917 data%maxval_cache(bin)%element_counter = 1
2919 ALLOCATE (data%maxval_container(bin_size))
2920 DO bin = 1, bin_size
2921 ALLOCATE (data%maxval_container(bin)%first)
2922 data%maxval_container(bin)%first%prev => null()
2923 data%maxval_container(bin)%first%next => null()
2924 data%maxval_container(bin)%current => data%maxval_container(bin)%first
2925 data%maxval_container(bin)%current%data = 0
2926 data%maxval_container(bin)%element_counter = 1
2929 ALLOCATE (data%integral_containers(64, bin_size))
2930 ALLOCATE (data%integral_caches(64, bin_size))
2932 DO bin = 1, bin_size
2934 data%integral_caches(i, bin)%element_counter = 1
2935 data%integral_caches(i, bin)%data = 0
2936 ALLOCATE (data%integral_containers(i, bin)%first)
2937 data%integral_containers(i, bin)%first%prev => null()
2938 data%integral_containers(i, bin)%first%next => null()
2939 data%integral_containers(i, bin)%current => data%integral_containers(i, bin)%first
2940 data%integral_containers(i, bin)%current%data = 0
2941 data%integral_containers(i, bin)%element_counter = 1
2958 TYPE(section_vals_type),
POINTER :: hfx_section1, hfx_section2
2959 LOGICAL,
INTENT(OUT) :: is_identical
2960 LOGICAL,
INTENT(OUT),
OPTIONAL :: same_except_frac
2962 CHARACTER(LEN=default_path_length) :: cval1, cval2
2963 INTEGER :: irep, ival1, ival2, n_rep_hf1, n_rep_hf2
2964 LOGICAL :: lval1, lval2
2965 REAL(dp) :: rval1, rval2
2966 TYPE(section_vals_type),
POINTER :: hfx_sub_section1, hfx_sub_section2
2968 is_identical = .true.
2969 IF (
PRESENT(same_except_frac)) same_except_frac = .false.
2971 CALL section_vals_get(hfx_section1, n_repetition=n_rep_hf1)
2972 CALL section_vals_get(hfx_section2, n_repetition=n_rep_hf2)
2973 is_identical = n_rep_hf1 == n_rep_hf2
2974 IF (.NOT. is_identical)
RETURN
2976 DO irep = 1, n_rep_hf1
2977 CALL section_vals_val_get(hfx_section1,
"PW_HFX", l_val=lval1, i_rep_section=irep)
2978 CALL section_vals_val_get(hfx_section2,
"PW_HFX", l_val=lval2, i_rep_section=irep)
2979 IF (lval1 .NEQV. lval2) is_identical = .false.
2981 CALL section_vals_val_get(hfx_section1,
"PW_HFX_BLOCKSIZE", i_val=ival1, i_rep_section=irep)
2982 CALL section_vals_val_get(hfx_section2,
"PW_HFX_BLOCKSIZE", i_val=ival2, i_rep_section=irep)
2983 IF (ival1 .NE. ival2) is_identical = .false.
2985 CALL section_vals_val_get(hfx_section1,
"TREAT_LSD_IN_CORE", l_val=lval1, i_rep_section=irep)
2986 CALL section_vals_val_get(hfx_section2,
"TREAT_LSD_IN_CORE", l_val=lval2, i_rep_section=irep)
2987 IF (lval1 .NEQV. lval2) is_identical = .false.
2989 hfx_sub_section1 => section_vals_get_subs_vals(hfx_section1,
"INTERACTION_POTENTIAL", i_rep_section=irep)
2990 hfx_sub_section2 => section_vals_get_subs_vals(hfx_section2,
"INTERACTION_POTENTIAL", i_rep_section=irep)
2992 CALL section_vals_val_get(hfx_sub_section1,
"OMEGA", r_val=rval1, i_rep_section=irep)
2993 CALL section_vals_val_get(hfx_sub_section2,
"OMEGA", r_val=rval2, i_rep_section=irep)
2994 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
2996 CALL section_vals_val_get(hfx_sub_section1,
"POTENTIAL_TYPE", i_val=ival1, i_rep_section=irep)
2997 CALL section_vals_val_get(hfx_sub_section2,
"POTENTIAL_TYPE", i_val=ival2, i_rep_section=irep)
2998 IF (ival1 .NE. ival2) is_identical = .false.
2999 IF (.NOT. is_identical)
RETURN
3001 IF (ival1 == do_potential_truncated .OR. ival1 == do_potential_mix_cl_trunc)
THEN
3002 CALL section_vals_val_get(hfx_sub_section1,
"CUTOFF_RADIUS", r_val=rval1, i_rep_section=irep)
3003 CALL section_vals_val_get(hfx_sub_section2,
"CUTOFF_RADIUS", r_val=rval2, i_rep_section=irep)
3004 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3006 CALL section_vals_val_get(hfx_sub_section1,
"T_C_G_DATA", c_val=cval1, i_rep_section=irep)
3007 CALL section_vals_val_get(hfx_sub_section2,
"T_C_G_DATA", c_val=cval2, i_rep_section=irep)
3008 IF (cval1 .NE. cval2) is_identical = .false.
3011 CALL section_vals_val_get(hfx_sub_section1,
"SCALE_COULOMB", r_val=rval1, i_rep_section=irep)
3012 CALL section_vals_val_get(hfx_sub_section2,
"SCALE_COULOMB", r_val=rval2, i_rep_section=irep)
3013 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3015 CALL section_vals_val_get(hfx_sub_section1,
"SCALE_GAUSSIAN", r_val=rval1, i_rep_section=irep)
3016 CALL section_vals_val_get(hfx_sub_section2,
"SCALE_GAUSSIAN", r_val=rval2, i_rep_section=irep)
3017 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3019 CALL section_vals_val_get(hfx_sub_section1,
"SCALE_LONGRANGE", r_val=rval1, i_rep_section=irep)
3020 CALL section_vals_val_get(hfx_sub_section2,
"SCALE_LONGRANGE", r_val=rval2, i_rep_section=irep)
3021 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3023 hfx_sub_section1 => section_vals_get_subs_vals(hfx_section1,
"PERIODIC", i_rep_section=irep)
3024 hfx_sub_section2 => section_vals_get_subs_vals(hfx_section2,
"PERIODIC", i_rep_section=irep)
3026 CALL section_vals_val_get(hfx_sub_section1,
"NUMBER_OF_SHELLS", i_val=ival1, i_rep_section=irep)
3027 CALL section_vals_val_get(hfx_sub_section2,
"NUMBER_OF_SHELLS", i_val=ival2, i_rep_section=irep)
3028 IF (ival1 .NE. ival2) is_identical = .false.
3030 hfx_sub_section1 => section_vals_get_subs_vals(hfx_section1,
"RI", i_rep_section=irep)
3031 hfx_sub_section2 => section_vals_get_subs_vals(hfx_section2,
"RI", i_rep_section=irep)
3033 CALL section_vals_val_get(hfx_sub_section1,
"_SECTION_PARAMETERS_", l_val=lval1, i_rep_section=irep)
3034 CALL section_vals_val_get(hfx_sub_section2,
"_SECTION_PARAMETERS_", l_val=lval2, i_rep_section=irep)
3035 IF (lval1 .NEQV. lval2) is_identical = .false.
3037 CALL section_vals_val_get(hfx_sub_section1,
"CUTOFF_RADIUS", r_val=rval1, i_rep_section=irep)
3038 CALL section_vals_val_get(hfx_sub_section2,
"CUTOFF_RADIUS", r_val=rval2, i_rep_section=irep)
3039 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3041 CALL section_vals_val_get(hfx_sub_section1,
"EPS_EIGVAL", r_val=rval1, i_rep_section=irep)
3042 CALL section_vals_val_get(hfx_sub_section2,
"EPS_EIGVAL", r_val=rval2, i_rep_section=irep)
3043 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3045 CALL section_vals_val_get(hfx_sub_section1,
"EPS_FILTER", r_val=rval1, i_rep_section=irep)
3046 CALL section_vals_val_get(hfx_sub_section2,
"EPS_FILTER", r_val=rval2, i_rep_section=irep)
3047 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3049 CALL section_vals_val_get(hfx_sub_section1,
"EPS_FILTER_2C", r_val=rval1, i_rep_section=irep)
3050 CALL section_vals_val_get(hfx_sub_section2,
"EPS_FILTER_2C", r_val=rval2, i_rep_section=irep)
3051 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3053 CALL section_vals_val_get(hfx_sub_section1,
"EPS_FILTER_MO", r_val=rval1, i_rep_section=irep)
3054 CALL section_vals_val_get(hfx_sub_section2,
"EPS_FILTER_MO", r_val=rval2, i_rep_section=irep)
3055 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3057 CALL section_vals_val_get(hfx_sub_section1,
"EPS_PGF_ORB", r_val=rval1, i_rep_section=irep)
3058 CALL section_vals_val_get(hfx_sub_section2,
"EPS_PGF_ORB", r_val=rval2, i_rep_section=irep)
3059 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3061 CALL section_vals_val_get(hfx_sub_section1,
"MAX_BLOCK_SIZE_MO", i_val=ival1, i_rep_section=irep)
3062 CALL section_vals_val_get(hfx_sub_section2,
"MAX_BLOCK_SIZE_MO", i_val=ival2, i_rep_section=irep)
3063 IF (ival1 .NE. ival2) is_identical = .false.
3065 CALL section_vals_val_get(hfx_sub_section1,
"MIN_BLOCK_SIZE", i_val=ival1, i_rep_section=irep)
3066 CALL section_vals_val_get(hfx_sub_section2,
"MIN_BLOCK_SIZE", i_val=ival2, i_rep_section=irep)
3067 IF (ival1 .NE. ival2) is_identical = .false.
3069 CALL section_vals_val_get(hfx_sub_section1,
"OMEGA", r_val=rval1, i_rep_section=irep)
3070 CALL section_vals_val_get(hfx_sub_section2,
"OMEGA", r_val=rval2, i_rep_section=irep)
3071 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3073 CALL section_vals_val_get(hfx_sub_section1,
"RI_FLAVOR", i_val=ival1, i_rep_section=irep)
3074 CALL section_vals_val_get(hfx_sub_section2,
"RI_FLAVOR", i_val=ival2, i_rep_section=irep)
3075 IF (ival1 .NE. ival2) is_identical = .false.
3077 CALL section_vals_val_get(hfx_sub_section1,
"RI_METRIC", i_val=ival1, i_rep_section=irep)
3078 CALL section_vals_val_get(hfx_sub_section2,
"RI_METRIC", i_val=ival2, i_rep_section=irep)
3079 IF (ival1 .NE. ival2) is_identical = .false.
3081 hfx_sub_section1 => section_vals_get_subs_vals(hfx_section1,
"SCREENING", i_rep_section=irep)
3082 hfx_sub_section2 => section_vals_get_subs_vals(hfx_section2,
"SCREENING", i_rep_section=irep)
3084 CALL section_vals_val_get(hfx_sub_section1,
"EPS_SCHWARZ", r_val=rval1, i_rep_section=irep)
3085 CALL section_vals_val_get(hfx_sub_section2,
"EPS_SCHWARZ", r_val=rval2, i_rep_section=irep)
3086 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3088 CALL section_vals_val_get(hfx_sub_section1,
"EPS_SCHWARZ_FORCES", r_val=rval1, i_rep_section=irep)
3089 CALL section_vals_val_get(hfx_sub_section2,
"EPS_SCHWARZ_FORCES", r_val=rval2, i_rep_section=irep)
3090 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3092 CALL section_vals_val_get(hfx_sub_section1,
"P_SCREEN_CORRECTION_FACTOR", r_val=rval1, i_rep_section=irep)
3093 CALL section_vals_val_get(hfx_sub_section2,
"P_SCREEN_CORRECTION_FACTOR", r_val=rval2, i_rep_section=irep)
3094 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3096 CALL section_vals_val_get(hfx_sub_section1,
"SCREEN_ON_INITIAL_P", l_val=lval1, i_rep_section=irep)
3097 CALL section_vals_val_get(hfx_sub_section2,
"SCREEN_ON_INITIAL_P", l_val=lval2, i_rep_section=irep)
3098 IF (lval1 .NEQV. lval2) is_identical = .false.
3100 CALL section_vals_val_get(hfx_sub_section1,
"SCREEN_P_FORCES", l_val=lval1, i_rep_section=irep)
3101 CALL section_vals_val_get(hfx_sub_section2,
"SCREEN_P_FORCES", l_val=lval2, i_rep_section=irep)
3102 IF (lval1 .NEQV. lval2) is_identical = .false.
3107 IF (is_identical)
THEN
3108 DO irep = 1, n_rep_hf1
3109 CALL section_vals_val_get(hfx_section1,
"FRACTION", r_val=rval1, i_rep_section=irep)
3110 CALL section_vals_val_get(hfx_section2,
"FRACTION", r_val=rval2, i_rep_section=irep)
3111 IF (abs(rval1 - rval2) > epsilon(1.0_dp)) is_identical = .false.
3114 IF (
PRESENT(same_except_frac))
THEN
3115 IF (.NOT. is_identical) same_except_frac = .true.
static GRID_HOST_DEVICE int ncoset(const int l)
Number of Cartesian orbitals up to given angular momentum quantum.
static GRID_HOST_DEVICE int idx(const orbital a)
Return coset index of given orbital angular momentum.
Define the atomic kind types and their sub types.
subroutine, public get_atomic_kind_set(atomic_kind_set, atom_of_kind, kind_of, natom_of_kind, maxatom, natom, nshell, fist_potential_present, shell_present, shell_adiabatic, shell_check_distance, damping_present)
Get attributes of an atomic kind set.
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.
subroutine, public get_gto_basis_set(gto_basis_set, name, aliases, norm_type, kind_radius, ncgf, nset, nsgf, cgf_symbol, sgf_symbol, norm_cgf, set_radius, lmax, lmin, lx, ly, lz, m, ncgf_set, npgf, nsgf_set, nshell, cphi, pgf_radius, sphi, scon, zet, first_cgf, first_sgf, l, last_cgf, last_sgf, n, gcc, maxco, maxl, maxpgf, maxsgf_set, maxshell, maxso, nco_sum, npgf_sum, nshell_sum, maxder, short_kind_radius, npgf_seg_sum)
...
collects all references to literature in CP2K as new algorithms / method are included from literature...
integer, save, public guidon2008
integer, save, public guidon2009
integer, save, public bussy2023
Handles all functions related to the CELL.
subroutine, public scaled_to_real(r, s, cell)
Transform scaled cell coordinates real coordinates. r=h*s.
subroutine, public get_cell(cell, alpha, beta, gamma, deth, orthorhombic, abc, periodic, h, h_inv, symmetry_id, tag)
Get informations about a simulation cell.
real(kind=dp) function, public plane_distance(h, k, l, cell)
Calculate the distance between two lattice planes as defined by a triple of Miller indices (hkl).
various utilities that regard array of different kinds: output, allocation,... maybe it is not a good...
Defines control structures, which contain the parameters and the settings for the DFT-based calculati...
subroutine, public dbcsr_release(matrix)
...
Utility routines to open and close files. Tracking of preconnections.
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.
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.
logical function, public file_exists(file_name)
Checks if file exists, considering also the file discovery mechanism.
various routines to log and control the output. The idea is that decisions about where to log should ...
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,...
real(kind=dp) function, public cp_unit_from_cp2k(value, unit_str, defaults, power)
converts from the internal cp2k units to the given unit
This is the start of a dbt_api, all publically needed functions are exported here....
Some auxiliary functions and subroutines needed for HFX calculations.
integer function, public count_cells_perd(shell, perd)
Auxiliary function for creating periodic neighbor cells
subroutine, public next_image_cell_perd(m, perd)
Auxiliary function for creating periodic neighbor cells
Types and set/get functions for HFX.
subroutine, public hfx_create(x_data, para_env, hfx_section, atomic_kind_set, qs_kind_set, particle_set, dft_control, cell, orb_basis, ri_basis, nelectron_total, nkp_grid)
This routine allocates and initializes all types in hfx_data
subroutine, public hfx_init_container(container, memory_usage, do_disk_storage)
This routine deletes all list entries in a container in order to deallocate the memory.
subroutine, public hfx_set_distr_energy(ptr_to_distr, x_data)
This routine stores the data obtained from the load balance routine for the energy
subroutine, public hfx_set_distr_forces(ptr_to_distr, x_data)
This routine stores the data obtained from the load balance routine for the forces
integer, parameter, public max_atom_block
subroutine, public parse_memory_section(memory_parameter, hf_sub_section, storage_id, i_thread, n_threads, para_env, irep, skip_disk, skip_in_core_forces)
Parses the memory section
subroutine, public hfx_release_basis_types(basis_parameter)
...
integer, save, public init_t_c_g0_lmax
real(dp), parameter, public log_zero
integer, parameter, public max_images
subroutine, public hfx_release(x_data)
This routine deallocates all data structures
subroutine, public alloc_containers(data, bin_size)
...
subroutine, public hfx_create_neighbor_cells(x_data, pbc_shells, cell, i_thread, nkp_grid)
This routine computes the neighbor cells that are taken into account in periodic runs
subroutine, public dealloc_containers(data, memory_usage)
...
subroutine, public hfx_create_basis_types(basis_parameter, basis_info, qs_kind_set, basis_type)
This routine allocates and initializes the basis_info and basis_parameter types
subroutine, public hfx_ri_init(ri_data, qs_kind_set, particle_set, atomic_kind_set, para_env)
...
subroutine, public compare_hfx_sections(hfx_section1, hfx_section2, is_identical, same_except_frac)
Compares the non-technical parts of two HFX input section and check whether they are the same Ignore ...
real(kind=dp), dimension(0:10), parameter, public mul_fact
real(dp), parameter, public powell_min_log
subroutine, public hfx_reset_memory_usage_counter(memory_parameter, subtr_size_mb)
resets the maximum memory usage for a HFX calculation subtracting all relevant buffers from the input...
subroutine, public hfx_ri_release(ri_data, write_stats)
...
Defines the basic variable types.
integer, parameter, public int_8
integer, parameter, public dp
integer, parameter, public default_string_length
integer, parameter, public default_path_length
2- and 3-center electron repulsion integral routines based on libint2 Currently available operators: ...
pure logical function, public compare_potential_types(potential1, potential2)
Helper function to compare libint_potential_types.
Interface to the Libint-Library or a c++ wrapper.
subroutine, public cp_libint_init_eri1(lib, max_am)
integer, parameter, public prim_data_f_size
subroutine, public cp_libint_cleanup_eri1(lib)
subroutine, public cp_libint_static_cleanup()
subroutine, public cp_libint_init_eri(lib, max_am)
subroutine, public cp_libint_static_init()
subroutine, public cp_libint_cleanup_eri(lib)
subroutine, public cp_libint_set_contrdepth(lib, contrdepth)
Machine interface based on Fortran 2003 and POSIX.
subroutine, public m_getcwd(curdir)
...
subroutine, public m_chdir(dir, ierror)
...
Collection of simple mathematical functions and subroutines.
subroutine, public erfc_cutoff(eps, omg, r_cutoff)
compute a truncation radius for the shortrange operator
Interface to the message passing library MPI.
Provides Cartesian and spherical orbital pointers and indices.
integer, dimension(:), allocatable, public nco
integer, dimension(:), allocatable, public ncoset
integer, dimension(:), allocatable, public nso
Define methods related to particle_type.
subroutine, public get_particle_set(particle_set, qs_kind_set, first_sgf, last_sgf, nsgf, nmao, basis)
Get the components of a particle set.
Define the data structure for the particle information.
Some utility functions for the calculation of integrals.
subroutine, public basis_set_list_setup(basis_set_list, basis_type, qs_kind_set)
Set up an easy accessible list of the basis sets for all kinds.
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, 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, floating, name, element_symbol, pao_basis_size, pao_model_file, pao_potentials, pao_descriptors, nelec)
Get attributes of an atomic kind.
subroutine, public get_qs_kind_set(qs_kind_set, all_potential_present, tnadd_potential_present, gth_potential_present, sgp_potential_present, paw_atom_present, dft_plus_u_atom_present, maxcgf, maxsgf, maxco, maxco_proj, maxgtops, maxlgto, maxlprj, maxnset, maxsgf_set, ncgf, npgf, nset, nsgf, nshell, maxpol, maxlppl, maxlppnl, maxppnl, nelectron, maxder, max_ngrid_rad, max_sph_harm, maxg_iso_not0, lmax_rho0, basis_rcut, basis_type, total_zeff_corr, npgf_seg)
Get attributes of an atomic kind set.
Utility methods to build 3-center integral tensors of various types.
subroutine, public distribution_3d_create(dist_3d, dist1, dist2, dist3, nkind, particle_set, mp_comm_3d, own_comm)
Create a 3d distribution.
integer, parameter, public default_block_size
subroutine, public create_2c_tensor(t2c, dist_1, dist_2, pgrid, sizes_1, sizes_2, order, name)
...
subroutine, public split_block_sizes(blk_sizes, blk_sizes_split, max_size)
...
subroutine, public pgf_block_sizes(atomic_kind_set, basis, min_blk_size, pgf_blk_sizes)
...
subroutine, public distribution_3d_destroy(dist)
Destroy a 3d distribution.
subroutine, public create_tensor_batches(sizes, nbatches, starts_array, ends_array, starts_array_block, ends_array_block)
...
subroutine, public create_3c_tensor(t3c, dist_1, dist_2, dist_3, pgrid, sizes_1, sizes_2, sizes_3, map1, map2, name)
...
Utilities for string manipulations.
subroutine, public compress(string, full)
Eliminate multiple space characters in a string. If full is .TRUE., then all spaces are eliminated.
This module computes the basic integrals for the truncated coulomb operator.
subroutine, public free_c0()
...
Provides all information about an atomic kind.
Type defining parameters related to the simulation cell.
represent a pointer to a 1d array
type of a logger, at the moment it contains just a print level starting at which level it should be l...
stores some data used in construction of Kohn-Sham matrix
stores all the informations relevant to an mpi environment
Provides all information about a quickstep kind.