Line data Source code
1 : !--------------------------------------------------------------------------------------------------!
2 : ! CP2K: A general program to perform molecular dynamics simulations !
3 : ! Copyright 2000-2025 CP2K developers group <https://cp2k.org> !
4 : ! !
5 : ! SPDX-License-Identifier: GPL-2.0-or-later !
6 : !--------------------------------------------------------------------------------------------------!
7 :
8 : ! **************************************************************************************************
9 : !> \brief Does all kind of post scf calculations for GPW/GAPW
10 : !> \par History
11 : !> Started as a copy from the relevant part of qs_scf
12 : !> Start to adapt for k-points [07.2015, JGH]
13 : !> \author Joost VandeVondele (10.2003)
14 : ! **************************************************************************************************
15 : MODULE qs_scf_post_gpw
16 : USE admm_types, ONLY: admm_type
17 : USE admm_utils, ONLY: admm_correct_for_eigenvalues,&
18 : admm_uncorrect_for_eigenvalues
19 : USE ai_onecenter, ONLY: sg_overlap
20 : USE atom_kind_orbitals, ONLY: calculate_atomic_density
21 : USE atomic_kind_types, ONLY: atomic_kind_type,&
22 : get_atomic_kind
23 : USE basis_set_types, ONLY: gto_basis_set_p_type,&
24 : gto_basis_set_type
25 : USE cell_types, ONLY: cell_type
26 : USE cp_array_utils, ONLY: cp_1d_r_p_type
27 : USE cp_blacs_env, ONLY: cp_blacs_env_type
28 : USE cp_control_types, ONLY: dft_control_type
29 : USE cp_dbcsr_api, ONLY: dbcsr_add,&
30 : dbcsr_p_type,&
31 : dbcsr_type
32 : USE cp_dbcsr_operations, ONLY: copy_dbcsr_to_fm,&
33 : dbcsr_deallocate_matrix_set
34 : USE cp_dbcsr_output, ONLY: cp_dbcsr_write_sparse_matrix
35 : USE cp_ddapc_util, ONLY: get_ddapc
36 : USE cp_fm_diag, ONLY: choose_eigv_solver
37 : USE cp_fm_struct, ONLY: cp_fm_struct_create,&
38 : cp_fm_struct_release,&
39 : cp_fm_struct_type
40 : USE cp_fm_types, ONLY: cp_fm_create,&
41 : cp_fm_get_info,&
42 : cp_fm_init_random,&
43 : cp_fm_release,&
44 : cp_fm_to_fm,&
45 : cp_fm_type
46 : USE cp_log_handling, ONLY: cp_get_default_logger,&
47 : cp_logger_get_default_io_unit,&
48 : cp_logger_type,&
49 : cp_to_string
50 : USE cp_output_handling, ONLY: cp_p_file,&
51 : cp_print_key_finished_output,&
52 : cp_print_key_should_output,&
53 : cp_print_key_unit_nr
54 : USE cp_realspace_grid_cube, ONLY: cp_pw_to_cube
55 : USE dct, ONLY: pw_shrink
56 : USE ed_analysis, ONLY: edmf_analysis
57 : USE eeq_method, ONLY: eeq_print
58 : USE et_coupling_types, ONLY: set_et_coupling_type
59 : USE hfx_ri, ONLY: print_ri_hfx
60 : USE hirshfeld_methods, ONLY: comp_hirshfeld_charges,&
61 : comp_hirshfeld_i_charges,&
62 : create_shape_function,&
63 : save_hirshfeld_charges,&
64 : write_hirshfeld_charges
65 : USE hirshfeld_types, ONLY: create_hirshfeld_type,&
66 : hirshfeld_type,&
67 : release_hirshfeld_type,&
68 : set_hirshfeld_info
69 : USE iao_analysis, ONLY: iao_wfn_analysis
70 : USE iao_types, ONLY: iao_env_type,&
71 : iao_read_input
72 : USE input_constants, ONLY: &
73 : do_loc_both, do_loc_homo, do_loc_jacobi, do_loc_lumo, do_loc_mixed, do_loc_none, &
74 : ot_precond_full_all, radius_covalent, radius_user, ref_charge_atomic, ref_charge_mulliken
75 : USE input_section_types, ONLY: section_get_ival,&
76 : section_get_ivals,&
77 : section_get_lval,&
78 : section_get_rval,&
79 : section_vals_get,&
80 : section_vals_get_subs_vals,&
81 : section_vals_type,&
82 : section_vals_val_get
83 : USE kinds, ONLY: default_path_length,&
84 : default_string_length,&
85 : dp
86 : USE kpoint_types, ONLY: kpoint_type
87 : USE mao_wfn_analysis, ONLY: mao_analysis
88 : USE mathconstants, ONLY: pi
89 : USE memory_utilities, ONLY: reallocate
90 : USE message_passing, ONLY: mp_para_env_type
91 : USE minbas_wfn_analysis, ONLY: minbas_analysis
92 : USE molden_utils, ONLY: write_mos_molden
93 : USE molecule_types, ONLY: molecule_type
94 : USE mulliken, ONLY: mulliken_charges
95 : USE orbital_pointers, ONLY: indso
96 : USE particle_list_types, ONLY: particle_list_type
97 : USE particle_types, ONLY: particle_type
98 : USE physcon, ONLY: angstrom,&
99 : evolt
100 : USE population_analyses, ONLY: lowdin_population_analysis,&
101 : mulliken_population_analysis
102 : USE preconditioner_types, ONLY: preconditioner_type
103 : USE ps_implicit_types, ONLY: MIXED_BC,&
104 : MIXED_PERIODIC_BC,&
105 : NEUMANN_BC,&
106 : PERIODIC_BC
107 : USE pw_env_types, ONLY: pw_env_get,&
108 : pw_env_type
109 : USE pw_grids, ONLY: get_pw_grid_info
110 : USE pw_methods, ONLY: pw_axpy,&
111 : pw_copy,&
112 : pw_derive,&
113 : pw_integrate_function,&
114 : pw_scale,&
115 : pw_transfer,&
116 : pw_zero
117 : USE pw_poisson_methods, ONLY: pw_poisson_solve
118 : USE pw_poisson_types, ONLY: pw_poisson_implicit,&
119 : pw_poisson_type
120 : USE pw_pool_types, ONLY: pw_pool_p_type,&
121 : pw_pool_type
122 : USE pw_types, ONLY: pw_c1d_gs_type,&
123 : pw_r3d_rs_type
124 : USE qs_chargemol, ONLY: write_wfx
125 : USE qs_collocate_density, ONLY: calculate_rho_resp_all,&
126 : calculate_wavefunction
127 : USE qs_commutators, ONLY: build_com_hr_matrix
128 : USE qs_core_energies, ONLY: calculate_ptrace
129 : USE qs_dos, ONLY: calculate_dos,&
130 : calculate_dos_kp
131 : USE qs_electric_field_gradient, ONLY: qs_efg_calc
132 : USE qs_elf_methods, ONLY: qs_elf_calc
133 : USE qs_energy_types, ONLY: qs_energy_type
134 : USE qs_energy_window, ONLY: energy_windows
135 : USE qs_environment_types, ONLY: get_qs_env,&
136 : qs_environment_type,&
137 : set_qs_env
138 : USE qs_epr_hyp, ONLY: qs_epr_hyp_calc
139 : USE qs_grid_atom, ONLY: grid_atom_type
140 : USE qs_integral_utils, ONLY: basis_set_list_setup
141 : USE qs_kind_types, ONLY: get_qs_kind,&
142 : qs_kind_type
143 : USE qs_ks_methods, ONLY: calc_rho_tot_gspace,&
144 : qs_ks_update_qs_env
145 : USE qs_ks_types, ONLY: qs_ks_did_change
146 : USE qs_loc_dipole, ONLY: loc_dipole
147 : USE qs_loc_states, ONLY: get_localization_info
148 : USE qs_loc_types, ONLY: qs_loc_env_create,&
149 : qs_loc_env_release,&
150 : qs_loc_env_type
151 : USE qs_loc_utils, ONLY: loc_write_restart,&
152 : qs_loc_control_init,&
153 : qs_loc_env_init,&
154 : qs_loc_init,&
155 : retain_history
156 : USE qs_local_properties, ONLY: qs_local_energy,&
157 : qs_local_stress
158 : USE qs_mo_io, ONLY: write_dm_binary_restart
159 : USE qs_mo_methods, ONLY: calculate_subspace_eigenvalues,&
160 : make_mo_eig
161 : USE qs_mo_occupation, ONLY: set_mo_occupation
162 : USE qs_mo_types, ONLY: get_mo_set,&
163 : mo_set_type
164 : USE qs_moments, ONLY: qs_moment_berry_phase,&
165 : qs_moment_locop
166 : USE qs_neighbor_list_types, ONLY: get_iterator_info,&
167 : get_neighbor_list_set_p,&
168 : neighbor_list_iterate,&
169 : neighbor_list_iterator_create,&
170 : neighbor_list_iterator_p_type,&
171 : neighbor_list_iterator_release,&
172 : neighbor_list_set_p_type
173 : USE qs_ot_eigensolver, ONLY: ot_eigensolver
174 : USE qs_pdos, ONLY: calculate_projected_dos
175 : USE qs_resp, ONLY: resp_fit
176 : USE qs_rho0_types, ONLY: get_rho0_mpole,&
177 : mpole_rho_atom,&
178 : rho0_mpole_type
179 : USE qs_rho_atom_types, ONLY: rho_atom_type
180 : USE qs_rho_methods, ONLY: qs_rho_update_rho
181 : USE qs_rho_types, ONLY: qs_rho_get,&
182 : qs_rho_type
183 : USE qs_scf_csr_write, ONLY: write_ks_matrix_csr,&
184 : write_s_matrix_csr
185 : USE qs_scf_output, ONLY: qs_scf_write_mos
186 : USE qs_scf_types, ONLY: ot_method_nr,&
187 : qs_scf_env_type
188 : USE qs_scf_wfn_mix, ONLY: wfn_mix
189 : USE qs_subsys_types, ONLY: qs_subsys_get,&
190 : qs_subsys_type
191 : USE qs_wannier90, ONLY: wannier90_interface
192 : USE s_square_methods, ONLY: compute_s_square
193 : USE scf_control_types, ONLY: scf_control_type
194 : USE stm_images, ONLY: th_stm_image
195 : USE transport, ONLY: qs_scf_post_transport
196 : USE trexio_utils, ONLY: write_trexio
197 : USE virial_types, ONLY: virial_type
198 : USE voronoi_interface, ONLY: entry_voronoi_or_bqb
199 : USE xray_diffraction, ONLY: calculate_rhotot_elec_gspace,&
200 : xray_diffraction_spectrum
201 : #include "./base/base_uses.f90"
202 :
203 : IMPLICIT NONE
204 : PRIVATE
205 :
206 : ! Global parameters
207 : CHARACTER(len=*), PARAMETER, PRIVATE :: moduleN = 'qs_scf_post_gpw'
208 : PUBLIC :: scf_post_calculation_gpw, &
209 : qs_scf_post_moments, &
210 : write_mo_dependent_results, &
211 : write_mo_free_results
212 :
213 : PUBLIC :: make_lumo_gpw
214 :
215 : ! **************************************************************************************************
216 :
217 : CONTAINS
218 :
219 : ! **************************************************************************************************
220 : !> \brief collects possible post - scf calculations and prints info / computes properties.
221 : !> \param qs_env the qs_env in which the qs_env lives
222 : !> \param wf_type ...
223 : !> \param do_mp2 ...
224 : !> \par History
225 : !> 02.2003 created [fawzi]
226 : !> 10.2004 moved here from qs_scf [Joost VandeVondele]
227 : !> started splitting out different subroutines
228 : !> 10.2015 added header for wave-function correlated methods [Vladimir Rybkin]
229 : !> \author fawzi
230 : !> \note
231 : !> this function changes mo_eigenvectors and mo_eigenvalues, depending on the print keys.
232 : !> In particular, MO_CUBES causes the MOs to be rotated to make them eigenstates of the KS
233 : !> matrix, and mo_eigenvalues is updated accordingly. This can, for unconverged wavefunctions,
234 : !> change afterwards slightly the forces (hence small numerical differences between MD
235 : !> with and without the debug print level). Ideally this should not happen...
236 : ! **************************************************************************************************
237 10051 : SUBROUTINE scf_post_calculation_gpw(qs_env, wf_type, do_mp2)
238 :
239 : TYPE(qs_environment_type), POINTER :: qs_env
240 : CHARACTER(6), OPTIONAL :: wf_type
241 : LOGICAL, OPTIONAL :: do_mp2
242 :
243 : CHARACTER(len=*), PARAMETER :: routineN = 'scf_post_calculation_gpw'
244 :
245 : INTEGER :: handle, homo, ispin, min_lumos, n_rep, &
246 : nchk_nmoloc, nhomo, nlumo, nlumo_stm, &
247 : nlumos, nmo, nspins, output_unit, &
248 : unit_nr
249 10051 : INTEGER, DIMENSION(:, :, :), POINTER :: marked_states
250 : LOGICAL :: check_write, compute_lumos, do_homo, do_kpoints, do_mixed, do_mo_cubes, do_stm, &
251 : do_wannier_cubes, has_homo, has_lumo, loc_explicit, loc_print_explicit, my_do_mp2, &
252 : my_localized_wfn, p_loc, p_loc_homo, p_loc_lumo, p_loc_mixed
253 : REAL(dp) :: e_kin
254 : REAL(KIND=dp) :: gap, homo_lumo(2, 2), total_zeff_corr
255 10051 : REAL(KIND=dp), DIMENSION(:), POINTER :: mo_eigenvalues
256 : TYPE(admm_type), POINTER :: admm_env
257 10051 : TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
258 10051 : TYPE(cp_1d_r_p_type), DIMENSION(:), POINTER :: mixed_evals, occupied_evals, &
259 10051 : unoccupied_evals, unoccupied_evals_stm
260 10051 : TYPE(cp_fm_type), ALLOCATABLE, DIMENSION(:) :: mixed_orbs, occupied_orbs
261 : TYPE(cp_fm_type), ALLOCATABLE, DIMENSION(:), &
262 10051 : TARGET :: homo_localized, lumo_localized, &
263 10051 : mixed_localized
264 10051 : TYPE(cp_fm_type), DIMENSION(:), POINTER :: lumo_ptr, mo_loc_history, &
265 10051 : unoccupied_orbs, unoccupied_orbs_stm
266 : TYPE(cp_fm_type), POINTER :: mo_coeff
267 : TYPE(cp_logger_type), POINTER :: logger
268 10051 : TYPE(dbcsr_p_type), DIMENSION(:), POINTER :: ks_rmpv, matrix_p_mp2, matrix_s, &
269 10051 : mo_derivs
270 10051 : TYPE(dbcsr_p_type), DIMENSION(:, :), POINTER :: kinetic_m, rho_ao
271 : TYPE(dft_control_type), POINTER :: dft_control
272 10051 : TYPE(mo_set_type), DIMENSION(:), POINTER :: mos
273 10051 : TYPE(molecule_type), POINTER :: molecule_set(:)
274 : TYPE(mp_para_env_type), POINTER :: para_env
275 : TYPE(particle_list_type), POINTER :: particles
276 10051 : TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
277 : TYPE(pw_c1d_gs_type) :: wf_g
278 : TYPE(pw_env_type), POINTER :: pw_env
279 10051 : TYPE(pw_pool_p_type), DIMENSION(:), POINTER :: pw_pools
280 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
281 : TYPE(pw_r3d_rs_type) :: wf_r
282 10051 : TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
283 : TYPE(qs_loc_env_type), POINTER :: qs_loc_env_homo, qs_loc_env_lumo, &
284 : qs_loc_env_mixed
285 : TYPE(qs_rho_type), POINTER :: rho
286 : TYPE(qs_scf_env_type), POINTER :: scf_env
287 : TYPE(qs_subsys_type), POINTER :: subsys
288 : TYPE(scf_control_type), POINTER :: scf_control
289 : TYPE(section_vals_type), POINTER :: dft_section, input, loc_print_section, &
290 : localize_section, print_key, &
291 : stm_section
292 :
293 10051 : CALL timeset(routineN, handle)
294 :
295 10051 : logger => cp_get_default_logger()
296 10051 : output_unit = cp_logger_get_default_io_unit(logger)
297 :
298 : ! Print out the type of wavefunction to distinguish between SCF and post-SCF
299 10051 : my_do_mp2 = .FALSE.
300 10051 : IF (PRESENT(do_mp2)) my_do_mp2 = do_mp2
301 10051 : IF (PRESENT(wf_type)) THEN
302 322 : IF (output_unit > 0) THEN
303 161 : WRITE (UNIT=output_unit, FMT='(/,(T1,A))') REPEAT("-", 40)
304 161 : WRITE (UNIT=output_unit, FMT='(/,(T3,A,T19,A,T25,A))') "Properties from ", wf_type, " density"
305 161 : WRITE (UNIT=output_unit, FMT='(/,(T1,A))') REPEAT("-", 40)
306 : END IF
307 : END IF
308 :
309 : ! Writes the data that is already available in qs_env
310 10051 : CALL get_qs_env(qs_env, scf_env=scf_env)
311 :
312 10051 : my_localized_wfn = .FALSE.
313 10051 : NULLIFY (admm_env, dft_control, pw_env, auxbas_pw_pool, pw_pools, mos, rho, &
314 10051 : mo_coeff, ks_rmpv, matrix_s, qs_loc_env_homo, qs_loc_env_lumo, scf_control, &
315 10051 : unoccupied_orbs, mo_eigenvalues, unoccupied_evals, &
316 10051 : unoccupied_evals_stm, molecule_set, mo_derivs, &
317 10051 : subsys, particles, input, print_key, kinetic_m, marked_states, &
318 10051 : mixed_evals, qs_loc_env_mixed)
319 10051 : NULLIFY (lumo_ptr, rho_ao)
320 :
321 10051 : has_homo = .FALSE.
322 10051 : has_lumo = .FALSE.
323 10051 : p_loc = .FALSE.
324 10051 : p_loc_homo = .FALSE.
325 10051 : p_loc_lumo = .FALSE.
326 10051 : p_loc_mixed = .FALSE.
327 :
328 10051 : CPASSERT(ASSOCIATED(scf_env))
329 10051 : CPASSERT(ASSOCIATED(qs_env))
330 : ! Here we start with data that needs a postprocessing...
331 : CALL get_qs_env(qs_env, &
332 : dft_control=dft_control, &
333 : molecule_set=molecule_set, &
334 : scf_control=scf_control, &
335 : do_kpoints=do_kpoints, &
336 : input=input, &
337 : subsys=subsys, &
338 : rho=rho, &
339 : pw_env=pw_env, &
340 : particle_set=particle_set, &
341 : atomic_kind_set=atomic_kind_set, &
342 10051 : qs_kind_set=qs_kind_set)
343 10051 : CALL qs_subsys_get(subsys, particles=particles)
344 :
345 10051 : CALL qs_rho_get(rho, rho_ao_kp=rho_ao)
346 :
347 10051 : IF (my_do_mp2) THEN
348 : ! Get the HF+MP2 density
349 322 : CALL get_qs_env(qs_env, matrix_p_mp2=matrix_p_mp2)
350 742 : DO ispin = 1, dft_control%nspins
351 742 : CALL dbcsr_add(rho_ao(ispin, 1)%matrix, matrix_p_mp2(ispin)%matrix, 1.0_dp, 1.0_dp)
352 : END DO
353 322 : CALL qs_rho_update_rho(rho, qs_env=qs_env)
354 322 : CALL qs_ks_did_change(qs_env%ks_env, rho_changed=.TRUE.)
355 : ! In MP2 case update the Hartree potential
356 322 : CALL update_hartree_with_mp2(rho, qs_env)
357 : END IF
358 :
359 10051 : CALL write_available_results(qs_env, scf_env)
360 :
361 : ! **** the kinetic energy
362 10051 : IF (cp_print_key_should_output(logger%iter_info, input, &
363 : "DFT%PRINT%KINETIC_ENERGY") /= 0) THEN
364 80 : CALL get_qs_env(qs_env, kinetic_kp=kinetic_m)
365 80 : CPASSERT(ASSOCIATED(kinetic_m))
366 80 : CPASSERT(ASSOCIATED(kinetic_m(1, 1)%matrix))
367 80 : CALL calculate_ptrace(kinetic_m, rho_ao, e_kin, dft_control%nspins)
368 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%KINETIC_ENERGY", &
369 80 : extension=".Log")
370 80 : IF (unit_nr > 0) THEN
371 40 : WRITE (unit_nr, '(T3,A,T55,F25.14)') "Electronic kinetic energy:", e_kin
372 : END IF
373 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
374 80 : "DFT%PRINT%KINETIC_ENERGY")
375 : END IF
376 :
377 : ! Atomic Charges that require further computation
378 10051 : CALL qs_scf_post_charges(input, logger, qs_env)
379 :
380 : ! Moments of charge distribution
381 10051 : CALL qs_scf_post_moments(input, logger, qs_env, output_unit)
382 :
383 : ! Determine if we need to computer properties using the localized centers
384 10051 : dft_section => section_vals_get_subs_vals(input, "DFT")
385 10051 : localize_section => section_vals_get_subs_vals(dft_section, "LOCALIZE")
386 10051 : loc_print_section => section_vals_get_subs_vals(localize_section, "PRINT")
387 10051 : CALL section_vals_get(localize_section, explicit=loc_explicit)
388 10051 : CALL section_vals_get(loc_print_section, explicit=loc_print_explicit)
389 :
390 : ! Print_keys controlled by localization
391 10051 : IF (loc_print_explicit) THEN
392 96 : print_key => section_vals_get_subs_vals(loc_print_section, "MOLECULAR_DIPOLES")
393 96 : p_loc = BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
394 96 : print_key => section_vals_get_subs_vals(loc_print_section, "TOTAL_DIPOLE")
395 96 : p_loc = p_loc .OR. BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
396 96 : print_key => section_vals_get_subs_vals(loc_print_section, "WANNIER_CENTERS")
397 96 : p_loc = p_loc .OR. BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
398 96 : print_key => section_vals_get_subs_vals(loc_print_section, "WANNIER_SPREADS")
399 96 : p_loc = p_loc .OR. BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
400 96 : print_key => section_vals_get_subs_vals(loc_print_section, "WANNIER_CUBES")
401 96 : p_loc = p_loc .OR. BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
402 96 : print_key => section_vals_get_subs_vals(loc_print_section, "MOLECULAR_STATES")
403 96 : p_loc = p_loc .OR. BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
404 96 : print_key => section_vals_get_subs_vals(loc_print_section, "MOLECULAR_MOMENTS")
405 96 : p_loc = p_loc .OR. BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
406 96 : print_key => section_vals_get_subs_vals(loc_print_section, "WANNIER_STATES")
407 96 : p_loc = p_loc .OR. BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)
408 : ELSE
409 : p_loc = .FALSE.
410 : END IF
411 10051 : IF (loc_explicit) THEN
412 : p_loc_homo = (section_get_ival(localize_section, "STATES") == do_loc_homo .OR. &
413 96 : section_get_ival(localize_section, "STATES") == do_loc_both) .AND. p_loc
414 : p_loc_lumo = (section_get_ival(localize_section, "STATES") == do_loc_lumo .OR. &
415 96 : section_get_ival(localize_section, "STATES") == do_loc_both) .AND. p_loc
416 96 : p_loc_mixed = (section_get_ival(localize_section, "STATES") == do_loc_mixed) .AND. p_loc
417 96 : CALL section_vals_val_get(localize_section, "LIST_UNOCCUPIED", n_rep_val=n_rep)
418 : ELSE
419 9955 : p_loc_homo = .FALSE.
420 9955 : p_loc_lumo = .FALSE.
421 9955 : p_loc_mixed = .FALSE.
422 9955 : n_rep = 0
423 : END IF
424 :
425 10051 : IF (n_rep == 0 .AND. p_loc_lumo) THEN
426 : CALL cp_abort(__LOCATION__, "No LIST_UNOCCUPIED was specified, "// &
427 0 : "therefore localization of unoccupied states will be skipped!")
428 0 : p_loc_lumo = .FALSE.
429 : END IF
430 :
431 : ! Control for STM
432 10051 : stm_section => section_vals_get_subs_vals(input, "DFT%PRINT%STM")
433 10051 : CALL section_vals_get(stm_section, explicit=do_stm)
434 10051 : nlumo_stm = 0
435 10051 : IF (do_stm) nlumo_stm = section_get_ival(stm_section, "NLUMO")
436 :
437 : ! check for CUBES (MOs and WANNIERS)
438 : do_mo_cubes = BTEST(cp_print_key_should_output(logger%iter_info, dft_section, "PRINT%MO_CUBES") &
439 10051 : , cp_p_file)
440 10051 : IF (loc_print_explicit) THEN
441 : do_wannier_cubes = BTEST(cp_print_key_should_output(logger%iter_info, loc_print_section, &
442 96 : "WANNIER_CUBES"), cp_p_file)
443 : ELSE
444 : do_wannier_cubes = .FALSE.
445 : END IF
446 10051 : nlumo = section_get_ival(dft_section, "PRINT%MO_CUBES%NLUMO")
447 10051 : nhomo = section_get_ival(dft_section, "PRINT%MO_CUBES%NHOMO")
448 :
449 : ! Setup the grids needed to compute a wavefunction given a vector..
450 10051 : IF (((do_mo_cubes .OR. do_wannier_cubes) .AND. (nlumo /= 0 .OR. nhomo /= 0)) .OR. p_loc) THEN
451 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool, &
452 208 : pw_pools=pw_pools)
453 208 : CALL auxbas_pw_pool%create_pw(wf_r)
454 208 : CALL auxbas_pw_pool%create_pw(wf_g)
455 : END IF
456 :
457 10051 : IF (dft_control%restricted) THEN
458 : !For ROKS usefull only first term
459 74 : nspins = 1
460 : ELSE
461 9977 : nspins = dft_control%nspins
462 : END IF
463 : !Some info about ROKS
464 10051 : IF (dft_control%restricted .AND. (do_mo_cubes .OR. p_loc_homo)) THEN
465 0 : CALL cp_abort(__LOCATION__, "Unclear how we define MOs / localization in the restricted case ... ")
466 : ! It is possible to obtain Wannier centers for ROKS without rotations for SINGLE OCCUPIED ORBITALS
467 : END IF
468 : ! Makes the MOs eigenstates, computes eigenvalues, write cubes
469 10051 : IF (do_kpoints) THEN
470 220 : CPWARN_IF(do_mo_cubes, "Print MO cubes not implemented for k-point calculations")
471 : ELSE
472 : CALL get_qs_env(qs_env, &
473 : mos=mos, &
474 9831 : matrix_ks=ks_rmpv)
475 9831 : IF ((do_mo_cubes .AND. nhomo /= 0) .OR. do_stm) THEN
476 132 : CALL get_qs_env(qs_env, mo_derivs=mo_derivs)
477 132 : IF (dft_control%do_admm) THEN
478 0 : CALL get_qs_env(qs_env, admm_env=admm_env)
479 0 : CALL make_mo_eig(mos, nspins, ks_rmpv, scf_control, mo_derivs, admm_env=admm_env)
480 : ELSE
481 132 : IF (dft_control%hairy_probes) THEN
482 0 : scf_control%smear%do_smear = .FALSE.
483 : CALL make_mo_eig(mos, dft_control%nspins, ks_rmpv, scf_control, mo_derivs, &
484 : hairy_probes=dft_control%hairy_probes, &
485 0 : probe=dft_control%probe)
486 : ELSE
487 132 : CALL make_mo_eig(mos, dft_control%nspins, ks_rmpv, scf_control, mo_derivs)
488 : END IF
489 : END IF
490 282 : DO ispin = 1, dft_control%nspins
491 150 : CALL get_mo_set(mo_set=mos(ispin), eigenvalues=mo_eigenvalues, homo=homo)
492 282 : homo_lumo(ispin, 1) = mo_eigenvalues(homo)
493 : END DO
494 : has_homo = .TRUE.
495 : END IF
496 9831 : IF (do_mo_cubes .AND. nhomo /= 0) THEN
497 268 : DO ispin = 1, nspins
498 : ! Prints the cube files of OCCUPIED ORBITALS
499 : CALL get_mo_set(mo_set=mos(ispin), mo_coeff=mo_coeff, &
500 142 : eigenvalues=mo_eigenvalues, homo=homo, nmo=nmo)
501 : CALL qs_scf_post_occ_cubes(input, dft_section, dft_control, logger, qs_env, &
502 268 : mo_coeff, wf_g, wf_r, particles, homo, ispin)
503 : END DO
504 : END IF
505 : END IF
506 :
507 : ! Initialize the localization environment, needed e.g. for wannier functions and molecular states
508 : ! Gets localization info for the occupied orbs
509 : ! - Possibly gets wannier functions
510 : ! - Possibly gets molecular states
511 10051 : IF (p_loc_homo) THEN
512 90 : IF (do_kpoints) THEN
513 0 : CPWARN("Localization not implemented for k-point calculations!")
514 : ELSEIF (dft_control%restricted &
515 : .AND. (section_get_ival(localize_section, "METHOD") /= do_loc_none) &
516 90 : .AND. (section_get_ival(localize_section, "METHOD") /= do_loc_jacobi)) THEN
517 0 : CPABORT("ROKS works only with LOCALIZE METHOD NONE or JACOBI")
518 : ELSE
519 376 : ALLOCATE (occupied_orbs(dft_control%nspins))
520 376 : ALLOCATE (occupied_evals(dft_control%nspins))
521 376 : ALLOCATE (homo_localized(dft_control%nspins))
522 196 : DO ispin = 1, dft_control%nspins
523 : CALL get_mo_set(mo_set=mos(ispin), mo_coeff=mo_coeff, &
524 106 : eigenvalues=mo_eigenvalues)
525 106 : occupied_orbs(ispin) = mo_coeff
526 106 : occupied_evals(ispin)%array => mo_eigenvalues
527 106 : CALL cp_fm_create(homo_localized(ispin), occupied_orbs(ispin)%matrix_struct)
528 196 : CALL cp_fm_to_fm(occupied_orbs(ispin), homo_localized(ispin))
529 : END DO
530 :
531 90 : CALL get_qs_env(qs_env, mo_loc_history=mo_loc_history)
532 90 : do_homo = .TRUE.
533 :
534 720 : ALLOCATE (qs_loc_env_homo)
535 90 : CALL qs_loc_env_create(qs_loc_env_homo)
536 90 : CALL qs_loc_control_init(qs_loc_env_homo, localize_section, do_homo=do_homo)
537 : CALL qs_loc_init(qs_env, qs_loc_env_homo, localize_section, homo_localized, do_homo, &
538 90 : do_mo_cubes, mo_loc_history=mo_loc_history)
539 : CALL get_localization_info(qs_env, qs_loc_env_homo, localize_section, homo_localized, &
540 90 : wf_r, wf_g, particles, occupied_orbs, occupied_evals, marked_states)
541 :
542 : !retain the homo_localized for future use
543 90 : IF (qs_loc_env_homo%localized_wfn_control%use_history) THEN
544 10 : CALL retain_history(mo_loc_history, homo_localized)
545 10 : CALL set_qs_env(qs_env, mo_loc_history=mo_loc_history)
546 : END IF
547 :
548 : !write restart for localization of occupied orbitals
549 : CALL loc_write_restart(qs_loc_env_homo, loc_print_section, mos, &
550 90 : homo_localized, do_homo)
551 90 : CALL cp_fm_release(homo_localized)
552 90 : DEALLOCATE (occupied_orbs)
553 90 : DEALLOCATE (occupied_evals)
554 : ! Print Total Dipole if the localization has been performed
555 180 : IF (qs_loc_env_homo%do_localize) THEN
556 74 : CALL loc_dipole(input, dft_control, qs_loc_env_homo, logger, qs_env)
557 : END IF
558 : END IF
559 : END IF
560 :
561 : ! Gets the lumos, and eigenvalues for the lumos, and localize them if requested
562 10051 : IF (do_kpoints) THEN
563 220 : IF (do_mo_cubes .OR. p_loc_lumo) THEN
564 : ! nothing at the moment, not implemented
565 2 : CPWARN("Localization and MO related output not implemented for k-point calculations!")
566 : END IF
567 : ELSE
568 9831 : compute_lumos = do_mo_cubes .AND. nlumo /= 0
569 9831 : compute_lumos = compute_lumos .OR. p_loc_lumo
570 :
571 21552 : DO ispin = 1, dft_control%nspins
572 11721 : CALL get_mo_set(mo_set=mos(ispin), homo=homo, nmo=nmo)
573 33225 : compute_lumos = compute_lumos .AND. homo == nmo
574 : END DO
575 :
576 9831 : IF (do_mo_cubes .AND. .NOT. compute_lumos) THEN
577 :
578 94 : nlumo = section_get_ival(dft_section, "PRINT%MO_CUBES%NLUMO")
579 188 : DO ispin = 1, dft_control%nspins
580 :
581 94 : CALL get_mo_set(mo_set=mos(ispin), homo=homo, nmo=nmo, eigenvalues=mo_eigenvalues)
582 188 : IF (nlumo > nmo - homo) THEN
583 : ! this case not yet implemented
584 : ELSE
585 94 : IF (nlumo == -1) THEN
586 0 : nlumo = nmo - homo
587 : END IF
588 94 : IF (output_unit > 0) WRITE (output_unit, *) " "
589 94 : IF (output_unit > 0) WRITE (output_unit, *) " Lowest eigenvalues of the unoccupied subspace spin ", ispin
590 94 : IF (output_unit > 0) WRITE (output_unit, *) "---------------------------------------------"
591 94 : IF (output_unit > 0) WRITE (output_unit, '(4(1X,1F16.8))') mo_eigenvalues(homo + 1:homo + nlumo)
592 :
593 : ! Prints the cube files of UNOCCUPIED ORBITALS
594 94 : CALL get_mo_set(mo_set=mos(ispin), mo_coeff=mo_coeff)
595 : CALL qs_scf_post_unocc_cubes(input, dft_section, dft_control, logger, qs_env, &
596 94 : mo_coeff, wf_g, wf_r, particles, nlumo, homo, ispin, lumo=homo + 1)
597 : END IF
598 : END DO
599 :
600 : END IF
601 :
602 9799 : IF (compute_lumos) THEN
603 32 : check_write = .TRUE.
604 32 : min_lumos = nlumo
605 32 : IF (nlumo == 0) check_write = .FALSE.
606 32 : IF (p_loc_lumo) THEN
607 6 : do_homo = .FALSE.
608 48 : ALLOCATE (qs_loc_env_lumo)
609 6 : CALL qs_loc_env_create(qs_loc_env_lumo)
610 6 : CALL qs_loc_control_init(qs_loc_env_lumo, localize_section, do_homo=do_homo)
611 98 : min_lumos = MAX(MAXVAL(qs_loc_env_lumo%localized_wfn_control%loc_states(:, :)), nlumo)
612 : END IF
613 :
614 144 : ALLOCATE (unoccupied_orbs(dft_control%nspins))
615 144 : ALLOCATE (unoccupied_evals(dft_control%nspins))
616 32 : CALL make_lumo_gpw(qs_env, scf_env, unoccupied_orbs, unoccupied_evals, min_lumos, nlumos)
617 32 : lumo_ptr => unoccupied_orbs
618 80 : DO ispin = 1, dft_control%nspins
619 48 : has_lumo = .TRUE.
620 48 : homo_lumo(ispin, 2) = unoccupied_evals(ispin)%array(1)
621 48 : CALL get_mo_set(mo_set=mos(ispin), homo=homo)
622 80 : IF (check_write) THEN
623 48 : IF (p_loc_lumo .AND. nlumo /= -1) nlumos = MIN(nlumo, nlumos)
624 : ! Prints the cube files of UNOCCUPIED ORBITALS
625 : CALL qs_scf_post_unocc_cubes(input, dft_section, dft_control, logger, qs_env, &
626 48 : unoccupied_orbs(ispin), wf_g, wf_r, particles, nlumos, homo, ispin)
627 : END IF
628 : END DO
629 :
630 64 : IF (p_loc_lumo) THEN
631 30 : ALLOCATE (lumo_localized(dft_control%nspins))
632 18 : DO ispin = 1, dft_control%nspins
633 12 : CALL cp_fm_create(lumo_localized(ispin), unoccupied_orbs(ispin)%matrix_struct)
634 18 : CALL cp_fm_to_fm(unoccupied_orbs(ispin), lumo_localized(ispin))
635 : END DO
636 : CALL qs_loc_init(qs_env, qs_loc_env_lumo, localize_section, lumo_localized, do_homo, do_mo_cubes, &
637 6 : evals=unoccupied_evals)
638 : CALL qs_loc_env_init(qs_loc_env_lumo, qs_loc_env_lumo%localized_wfn_control, qs_env, &
639 6 : loc_coeff=unoccupied_orbs)
640 : CALL get_localization_info(qs_env, qs_loc_env_lumo, localize_section, &
641 : lumo_localized, wf_r, wf_g, particles, &
642 6 : unoccupied_orbs, unoccupied_evals, marked_states)
643 : CALL loc_write_restart(qs_loc_env_lumo, loc_print_section, mos, homo_localized, do_homo, &
644 6 : evals=unoccupied_evals)
645 6 : lumo_ptr => lumo_localized
646 : END IF
647 : END IF
648 :
649 9831 : IF (has_homo .AND. has_lumo) THEN
650 32 : IF (output_unit > 0) WRITE (output_unit, *) " "
651 80 : DO ispin = 1, dft_control%nspins
652 80 : IF (.NOT. scf_control%smear%do_smear) THEN
653 48 : gap = homo_lumo(ispin, 2) - homo_lumo(ispin, 1)
654 48 : IF (output_unit > 0) WRITE (output_unit, '(T2,A,F12.6)') &
655 24 : "HOMO - LUMO gap [eV] :", gap*evolt
656 : END IF
657 : END DO
658 : END IF
659 : END IF
660 :
661 10051 : IF (p_loc_mixed) THEN
662 2 : IF (do_kpoints) THEN
663 0 : CPWARN("Localization not implemented for k-point calculations!")
664 2 : ELSEIF (dft_control%restricted) THEN
665 0 : IF (output_unit > 0) WRITE (output_unit, *) &
666 0 : " Unclear how we define MOs / localization in the restricted case... skipping"
667 : ELSE
668 :
669 8 : ALLOCATE (mixed_orbs(dft_control%nspins))
670 8 : ALLOCATE (mixed_evals(dft_control%nspins))
671 8 : ALLOCATE (mixed_localized(dft_control%nspins))
672 4 : DO ispin = 1, dft_control%nspins
673 : CALL get_mo_set(mo_set=mos(ispin), mo_coeff=mo_coeff, &
674 2 : eigenvalues=mo_eigenvalues)
675 2 : mixed_orbs(ispin) = mo_coeff
676 2 : mixed_evals(ispin)%array => mo_eigenvalues
677 2 : CALL cp_fm_create(mixed_localized(ispin), mixed_orbs(ispin)%matrix_struct)
678 4 : CALL cp_fm_to_fm(mixed_orbs(ispin), mixed_localized(ispin))
679 : END DO
680 :
681 2 : CALL get_qs_env(qs_env, mo_loc_history=mo_loc_history)
682 2 : do_homo = .FALSE.
683 2 : do_mixed = .TRUE.
684 2 : total_zeff_corr = scf_env%sum_zeff_corr
685 16 : ALLOCATE (qs_loc_env_mixed)
686 2 : CALL qs_loc_env_create(qs_loc_env_mixed)
687 2 : CALL qs_loc_control_init(qs_loc_env_mixed, localize_section, do_homo=do_homo, do_mixed=do_mixed)
688 : CALL qs_loc_init(qs_env, qs_loc_env_mixed, localize_section, mixed_localized, do_homo, &
689 : do_mo_cubes, mo_loc_history=mo_loc_history, tot_zeff_corr=total_zeff_corr, &
690 2 : do_mixed=do_mixed)
691 :
692 4 : DO ispin = 1, dft_control%nspins
693 4 : CALL cp_fm_get_info(mixed_localized(ispin), ncol_global=nchk_nmoloc)
694 : END DO
695 :
696 : CALL get_localization_info(qs_env, qs_loc_env_mixed, localize_section, mixed_localized, &
697 2 : wf_r, wf_g, particles, mixed_orbs, mixed_evals, marked_states)
698 :
699 : !retain the homo_localized for future use
700 2 : IF (qs_loc_env_mixed%localized_wfn_control%use_history) THEN
701 0 : CALL retain_history(mo_loc_history, mixed_localized)
702 0 : CALL set_qs_env(qs_env, mo_loc_history=mo_loc_history)
703 : END IF
704 :
705 : !write restart for localization of occupied orbitals
706 : CALL loc_write_restart(qs_loc_env_mixed, loc_print_section, mos, &
707 2 : mixed_localized, do_homo, do_mixed=do_mixed)
708 2 : CALL cp_fm_release(mixed_localized)
709 2 : DEALLOCATE (mixed_orbs)
710 4 : DEALLOCATE (mixed_evals)
711 : ! Print Total Dipole if the localization has been performed
712 : ! Revisit the formalism later
713 : !IF (qs_loc_env_mixed%do_localize) THEN
714 : ! CALL loc_dipole(input, dft_control, qs_loc_env_mixed, logger, qs_env)
715 : !END IF
716 : END IF
717 : END IF
718 :
719 : ! Deallocate grids needed to compute wavefunctions
720 10051 : IF (((do_mo_cubes .OR. do_wannier_cubes) .AND. (nlumo /= 0 .OR. nhomo /= 0)) .OR. p_loc) THEN
721 208 : CALL auxbas_pw_pool%give_back_pw(wf_r)
722 208 : CALL auxbas_pw_pool%give_back_pw(wf_g)
723 : END IF
724 :
725 : ! Destroy the localization environment
726 10051 : IF (.NOT. do_kpoints) THEN
727 9831 : IF (p_loc_homo) THEN
728 90 : CALL qs_loc_env_release(qs_loc_env_homo)
729 90 : DEALLOCATE (qs_loc_env_homo)
730 : END IF
731 9831 : IF (p_loc_lumo) THEN
732 6 : CALL qs_loc_env_release(qs_loc_env_lumo)
733 6 : DEALLOCATE (qs_loc_env_lumo)
734 : END IF
735 9831 : IF (p_loc_mixed) THEN
736 2 : CALL qs_loc_env_release(qs_loc_env_mixed)
737 2 : DEALLOCATE (qs_loc_env_mixed)
738 : END IF
739 : END IF
740 :
741 : ! generate a mix of wfns, and write to a restart
742 10051 : IF (do_kpoints) THEN
743 : ! nothing at the moment, not implemented
744 : ELSE
745 9831 : CALL get_qs_env(qs_env, matrix_s=matrix_s, para_env=para_env)
746 : CALL wfn_mix(mos, particle_set, dft_section, qs_kind_set, para_env, &
747 : output_unit, unoccupied_orbs=lumo_ptr, scf_env=scf_env, &
748 9831 : matrix_s=matrix_s, marked_states=marked_states)
749 :
750 9831 : IF (p_loc_lumo) CALL cp_fm_release(lumo_localized)
751 : END IF
752 10051 : IF (ASSOCIATED(marked_states)) THEN
753 16 : DEALLOCATE (marked_states)
754 : END IF
755 :
756 : ! This is just a deallocation for printing MO_CUBES or TDDFPT
757 10051 : IF (.NOT. do_kpoints) THEN
758 9831 : IF (compute_lumos) THEN
759 80 : DO ispin = 1, dft_control%nspins
760 48 : DEALLOCATE (unoccupied_evals(ispin)%array)
761 80 : CALL cp_fm_release(unoccupied_orbs(ispin))
762 : END DO
763 32 : DEALLOCATE (unoccupied_evals)
764 32 : DEALLOCATE (unoccupied_orbs)
765 : END IF
766 : END IF
767 :
768 : !stm images
769 10051 : IF (do_stm) THEN
770 6 : IF (do_kpoints) THEN
771 0 : CPWARN("STM not implemented for k-point calculations!")
772 : ELSE
773 6 : NULLIFY (unoccupied_orbs_stm, unoccupied_evals_stm)
774 6 : IF (nlumo_stm > 0) THEN
775 8 : ALLOCATE (unoccupied_orbs_stm(dft_control%nspins))
776 8 : ALLOCATE (unoccupied_evals_stm(dft_control%nspins))
777 : CALL make_lumo_gpw(qs_env, scf_env, unoccupied_orbs_stm, unoccupied_evals_stm, &
778 2 : nlumo_stm, nlumos)
779 : END IF
780 :
781 : CALL th_stm_image(qs_env, stm_section, particles, unoccupied_orbs_stm, &
782 6 : unoccupied_evals_stm)
783 :
784 6 : IF (nlumo_stm > 0) THEN
785 4 : DO ispin = 1, dft_control%nspins
786 4 : DEALLOCATE (unoccupied_evals_stm(ispin)%array)
787 : END DO
788 2 : DEALLOCATE (unoccupied_evals_stm)
789 2 : CALL cp_fm_release(unoccupied_orbs_stm)
790 : END IF
791 : END IF
792 : END IF
793 :
794 : ! Print coherent X-ray diffraction spectrum
795 10051 : CALL qs_scf_post_xray(input, dft_section, logger, qs_env, output_unit)
796 :
797 : ! Calculation of Electric Field Gradients
798 10051 : CALL qs_scf_post_efg(input, logger, qs_env)
799 :
800 : ! Calculation of ET
801 10051 : CALL qs_scf_post_et(input, qs_env, dft_control)
802 :
803 : ! Calculation of EPR Hyperfine Coupling Tensors
804 10051 : CALL qs_scf_post_epr(input, logger, qs_env)
805 :
806 : ! Calculation of properties needed for BASIS_MOLOPT optimizations
807 10051 : CALL qs_scf_post_molopt(input, logger, qs_env)
808 :
809 : ! Calculate ELF
810 10051 : CALL qs_scf_post_elf(input, logger, qs_env)
811 :
812 : ! Use Wannier90 interface
813 10051 : CALL wannier90_interface(input, logger, qs_env)
814 :
815 10051 : IF (my_do_mp2) THEN
816 : ! Get everything back
817 742 : DO ispin = 1, dft_control%nspins
818 742 : CALL dbcsr_add(rho_ao(ispin, 1)%matrix, matrix_p_mp2(ispin)%matrix, 1.0_dp, -1.0_dp)
819 : END DO
820 322 : CALL qs_rho_update_rho(rho, qs_env=qs_env)
821 322 : CALL qs_ks_did_change(qs_env%ks_env, rho_changed=.TRUE.)
822 : END IF
823 :
824 10051 : CALL timestop(handle)
825 :
826 20102 : END SUBROUTINE scf_post_calculation_gpw
827 :
828 : ! **************************************************************************************************
829 : !> \brief Gets the lumos, and eigenvalues for the lumos
830 : !> \param qs_env ...
831 : !> \param scf_env ...
832 : !> \param unoccupied_orbs ...
833 : !> \param unoccupied_evals ...
834 : !> \param nlumo ...
835 : !> \param nlumos ...
836 : ! **************************************************************************************************
837 34 : SUBROUTINE make_lumo_gpw(qs_env, scf_env, unoccupied_orbs, unoccupied_evals, nlumo, nlumos)
838 :
839 : TYPE(qs_environment_type), POINTER :: qs_env
840 : TYPE(qs_scf_env_type), POINTER :: scf_env
841 : TYPE(cp_fm_type), DIMENSION(:), INTENT(INOUT) :: unoccupied_orbs
842 : TYPE(cp_1d_r_p_type), DIMENSION(:), POINTER :: unoccupied_evals
843 : INTEGER, INTENT(IN) :: nlumo
844 : INTEGER, INTENT(OUT) :: nlumos
845 :
846 : CHARACTER(len=*), PARAMETER :: routineN = 'make_lumo_gpw'
847 :
848 : INTEGER :: handle, homo, ispin, n, nao, nmo, &
849 : output_unit
850 : TYPE(admm_type), POINTER :: admm_env
851 : TYPE(cp_blacs_env_type), POINTER :: blacs_env
852 : TYPE(cp_fm_struct_type), POINTER :: fm_struct_tmp
853 : TYPE(cp_fm_type), POINTER :: mo_coeff
854 : TYPE(cp_logger_type), POINTER :: logger
855 34 : TYPE(dbcsr_p_type), DIMENSION(:), POINTER :: ks_rmpv, matrix_s
856 : TYPE(dft_control_type), POINTER :: dft_control
857 34 : TYPE(mo_set_type), DIMENSION(:), POINTER :: mos
858 : TYPE(mp_para_env_type), POINTER :: para_env
859 : TYPE(preconditioner_type), POINTER :: local_preconditioner
860 : TYPE(scf_control_type), POINTER :: scf_control
861 :
862 34 : CALL timeset(routineN, handle)
863 :
864 34 : NULLIFY (mos, ks_rmpv, scf_control, dft_control, admm_env, para_env, blacs_env)
865 : CALL get_qs_env(qs_env, &
866 : mos=mos, &
867 : matrix_ks=ks_rmpv, &
868 : scf_control=scf_control, &
869 : dft_control=dft_control, &
870 : matrix_s=matrix_s, &
871 : admm_env=admm_env, &
872 : para_env=para_env, &
873 34 : blacs_env=blacs_env)
874 :
875 34 : logger => cp_get_default_logger()
876 34 : output_unit = cp_logger_get_default_io_unit(logger)
877 :
878 84 : DO ispin = 1, dft_control%nspins
879 50 : NULLIFY (unoccupied_evals(ispin)%array)
880 : ! Always write eigenvalues
881 50 : IF (output_unit > 0) WRITE (output_unit, *) " "
882 50 : IF (output_unit > 0) WRITE (output_unit, *) " Lowest Eigenvalues of the unoccupied subspace spin ", ispin
883 50 : IF (output_unit > 0) WRITE (output_unit, FMT='(1X,A)') "-----------------------------------------------------"
884 50 : CALL get_mo_set(mo_set=mos(ispin), mo_coeff=mo_coeff, homo=homo, nao=nao, nmo=nmo)
885 50 : CALL cp_fm_get_info(mo_coeff, nrow_global=n)
886 50 : nlumos = MAX(1, MIN(nlumo, nao - nmo))
887 50 : IF (nlumo == -1) nlumos = nao - nmo
888 150 : ALLOCATE (unoccupied_evals(ispin)%array(nlumos))
889 : CALL cp_fm_struct_create(fm_struct_tmp, para_env=para_env, context=blacs_env, &
890 50 : nrow_global=n, ncol_global=nlumos)
891 50 : CALL cp_fm_create(unoccupied_orbs(ispin), fm_struct_tmp, name="lumos")
892 50 : CALL cp_fm_struct_release(fm_struct_tmp)
893 50 : CALL cp_fm_init_random(unoccupied_orbs(ispin), nlumos)
894 :
895 : ! the full_all preconditioner makes not much sense for lumos search
896 50 : NULLIFY (local_preconditioner)
897 50 : IF (ASSOCIATED(scf_env%ot_preconditioner)) THEN
898 26 : local_preconditioner => scf_env%ot_preconditioner(1)%preconditioner
899 : ! this one can for sure not be right (as it has to match a given C0)
900 26 : IF (local_preconditioner%in_use == ot_precond_full_all) THEN
901 4 : NULLIFY (local_preconditioner)
902 : END IF
903 : END IF
904 :
905 : ! If we do ADMM, we add have to modify the Kohn-Sham matrix
906 50 : IF (dft_control%do_admm) THEN
907 0 : CALL admm_correct_for_eigenvalues(ispin, admm_env, ks_rmpv(ispin)%matrix)
908 : END IF
909 :
910 : CALL ot_eigensolver(matrix_h=ks_rmpv(ispin)%matrix, matrix_s=matrix_s(1)%matrix, &
911 : matrix_c_fm=unoccupied_orbs(ispin), &
912 : matrix_orthogonal_space_fm=mo_coeff, &
913 : eps_gradient=scf_control%eps_lumos, &
914 : preconditioner=local_preconditioner, &
915 : iter_max=scf_control%max_iter_lumos, &
916 50 : size_ortho_space=nmo)
917 :
918 : CALL calculate_subspace_eigenvalues(unoccupied_orbs(ispin), ks_rmpv(ispin)%matrix, &
919 : unoccupied_evals(ispin)%array, scr=output_unit, &
920 50 : ionode=output_unit > 0)
921 :
922 : ! If we do ADMM, we restore the original Kohn-Sham matrix
923 134 : IF (dft_control%do_admm) THEN
924 0 : CALL admm_uncorrect_for_eigenvalues(ispin, admm_env, ks_rmpv(ispin)%matrix)
925 : END IF
926 :
927 : END DO
928 :
929 34 : CALL timestop(handle)
930 :
931 34 : END SUBROUTINE make_lumo_gpw
932 : ! **************************************************************************************************
933 : !> \brief Computes and Prints Atomic Charges with several methods
934 : !> \param input ...
935 : !> \param logger ...
936 : !> \param qs_env the qs_env in which the qs_env lives
937 : ! **************************************************************************************************
938 10051 : SUBROUTINE qs_scf_post_charges(input, logger, qs_env)
939 : TYPE(section_vals_type), POINTER :: input
940 : TYPE(cp_logger_type), POINTER :: logger
941 : TYPE(qs_environment_type), POINTER :: qs_env
942 :
943 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_charges'
944 :
945 : INTEGER :: handle, print_level, unit_nr
946 : LOGICAL :: do_kpoints, print_it
947 : TYPE(section_vals_type), POINTER :: density_fit_section, print_key
948 :
949 10051 : CALL timeset(routineN, handle)
950 :
951 10051 : CALL get_qs_env(qs_env=qs_env, do_kpoints=do_kpoints)
952 :
953 : ! Mulliken charges require no further computation and are printed from write_mo_free_results
954 :
955 : ! Compute the Lowdin charges
956 10051 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%LOWDIN")
957 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
958 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%LOWDIN", extension=".lowdin", &
959 82 : log_filename=.FALSE.)
960 82 : print_level = 1
961 82 : CALL section_vals_val_get(print_key, "PRINT_GOP", l_val=print_it)
962 82 : IF (print_it) print_level = 2
963 82 : CALL section_vals_val_get(print_key, "PRINT_ALL", l_val=print_it)
964 82 : IF (print_it) print_level = 3
965 82 : IF (do_kpoints) THEN
966 2 : CPWARN("Lowdin charges not implemented for k-point calculations!")
967 : ELSE
968 80 : CALL lowdin_population_analysis(qs_env, unit_nr, print_level)
969 : END IF
970 82 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%LOWDIN")
971 : END IF
972 :
973 : ! Compute the RESP charges
974 10051 : CALL resp_fit(qs_env)
975 :
976 : ! Compute the Density Derived Atomic Point charges with the Bloechl scheme
977 10051 : print_key => section_vals_get_subs_vals(input, "PROPERTIES%FIT_CHARGE")
978 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
979 : unit_nr = cp_print_key_unit_nr(logger, input, "PROPERTIES%FIT_CHARGE", extension=".Fitcharge", &
980 102 : log_filename=.FALSE.)
981 102 : density_fit_section => section_vals_get_subs_vals(input, "DFT%DENSITY_FITTING")
982 102 : CALL get_ddapc(qs_env, .FALSE., density_fit_section, iwc=unit_nr)
983 102 : CALL cp_print_key_finished_output(unit_nr, logger, input, "PROPERTIES%FIT_CHARGE")
984 : END IF
985 :
986 10051 : CALL timestop(handle)
987 :
988 10051 : END SUBROUTINE qs_scf_post_charges
989 :
990 : ! **************************************************************************************************
991 : !> \brief Computes and prints the Cube Files for MO
992 : !> \param input ...
993 : !> \param dft_section ...
994 : !> \param dft_control ...
995 : !> \param logger ...
996 : !> \param qs_env the qs_env in which the qs_env lives
997 : !> \param mo_coeff ...
998 : !> \param wf_g ...
999 : !> \param wf_r ...
1000 : !> \param particles ...
1001 : !> \param homo ...
1002 : !> \param ispin ...
1003 : ! **************************************************************************************************
1004 142 : SUBROUTINE qs_scf_post_occ_cubes(input, dft_section, dft_control, logger, qs_env, &
1005 : mo_coeff, wf_g, wf_r, particles, homo, ispin)
1006 : TYPE(section_vals_type), POINTER :: input, dft_section
1007 : TYPE(dft_control_type), POINTER :: dft_control
1008 : TYPE(cp_logger_type), POINTER :: logger
1009 : TYPE(qs_environment_type), POINTER :: qs_env
1010 : TYPE(cp_fm_type), INTENT(IN) :: mo_coeff
1011 : TYPE(pw_c1d_gs_type), INTENT(INOUT) :: wf_g
1012 : TYPE(pw_r3d_rs_type), INTENT(INOUT) :: wf_r
1013 : TYPE(particle_list_type), POINTER :: particles
1014 : INTEGER, INTENT(IN) :: homo, ispin
1015 :
1016 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_occ_cubes'
1017 :
1018 : CHARACTER(LEN=default_path_length) :: filename, my_pos_cube, title
1019 : INTEGER :: handle, i, ir, ivector, n_rep, nhomo, &
1020 : nlist, unit_nr
1021 142 : INTEGER, DIMENSION(:), POINTER :: list, list_index
1022 : LOGICAL :: append_cube, mpi_io
1023 142 : TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
1024 : TYPE(cell_type), POINTER :: cell
1025 142 : TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
1026 : TYPE(pw_env_type), POINTER :: pw_env
1027 142 : TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
1028 :
1029 142 : CALL timeset(routineN, handle)
1030 :
1031 142 : NULLIFY (list_index)
1032 :
1033 : IF (BTEST(cp_print_key_should_output(logger%iter_info, dft_section, "PRINT%MO_CUBES") &
1034 142 : , cp_p_file) .AND. section_get_lval(dft_section, "PRINT%MO_CUBES%WRITE_CUBE")) THEN
1035 104 : nhomo = section_get_ival(dft_section, "PRINT%MO_CUBES%NHOMO")
1036 104 : append_cube = section_get_lval(dft_section, "PRINT%MO_CUBES%APPEND")
1037 104 : my_pos_cube = "REWIND"
1038 104 : IF (append_cube) THEN
1039 0 : my_pos_cube = "APPEND"
1040 : END IF
1041 104 : CALL section_vals_val_get(dft_section, "PRINT%MO_CUBES%HOMO_LIST", n_rep_val=n_rep)
1042 104 : IF (n_rep > 0) THEN ! write the cubes of the list
1043 0 : nlist = 0
1044 0 : DO ir = 1, n_rep
1045 0 : NULLIFY (list)
1046 : CALL section_vals_val_get(dft_section, "PRINT%MO_CUBES%HOMO_LIST", i_rep_val=ir, &
1047 0 : i_vals=list)
1048 0 : IF (ASSOCIATED(list)) THEN
1049 0 : CALL reallocate(list_index, 1, nlist + SIZE(list))
1050 0 : DO i = 1, SIZE(list)
1051 0 : list_index(i + nlist) = list(i)
1052 : END DO
1053 0 : nlist = nlist + SIZE(list)
1054 : END IF
1055 : END DO
1056 : ELSE
1057 :
1058 104 : IF (nhomo == -1) nhomo = homo
1059 104 : nlist = homo - MAX(1, homo - nhomo + 1) + 1
1060 312 : ALLOCATE (list_index(nlist))
1061 212 : DO i = 1, nlist
1062 212 : list_index(i) = MAX(1, homo - nhomo + 1) + i - 1
1063 : END DO
1064 : END IF
1065 212 : DO i = 1, nlist
1066 108 : ivector = list_index(i)
1067 : CALL get_qs_env(qs_env=qs_env, &
1068 : atomic_kind_set=atomic_kind_set, &
1069 : qs_kind_set=qs_kind_set, &
1070 : cell=cell, &
1071 : particle_set=particle_set, &
1072 108 : pw_env=pw_env)
1073 : CALL calculate_wavefunction(mo_coeff, ivector, wf_r, wf_g, atomic_kind_set, qs_kind_set, &
1074 108 : cell, dft_control, particle_set, pw_env)
1075 108 : WRITE (filename, '(a4,I5.5,a1,I1.1)') "WFN_", ivector, "_", ispin
1076 108 : mpi_io = .TRUE.
1077 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%MO_CUBES", extension=".cube", &
1078 : middle_name=TRIM(filename), file_position=my_pos_cube, log_filename=.FALSE., &
1079 108 : mpi_io=mpi_io)
1080 108 : WRITE (title, *) "WAVEFUNCTION ", ivector, " spin ", ispin, " i.e. HOMO - ", ivector - homo
1081 : CALL cp_pw_to_cube(wf_r, unit_nr, title, particles=particles, &
1082 108 : stride=section_get_ivals(dft_section, "PRINT%MO_CUBES%STRIDE"), mpi_io=mpi_io)
1083 212 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%MO_CUBES", mpi_io=mpi_io)
1084 : END DO
1085 104 : IF (ASSOCIATED(list_index)) DEALLOCATE (list_index)
1086 : END IF
1087 :
1088 142 : CALL timestop(handle)
1089 :
1090 142 : END SUBROUTINE qs_scf_post_occ_cubes
1091 :
1092 : ! **************************************************************************************************
1093 : !> \brief Computes and prints the Cube Files for MO
1094 : !> \param input ...
1095 : !> \param dft_section ...
1096 : !> \param dft_control ...
1097 : !> \param logger ...
1098 : !> \param qs_env the qs_env in which the qs_env lives
1099 : !> \param unoccupied_orbs ...
1100 : !> \param wf_g ...
1101 : !> \param wf_r ...
1102 : !> \param particles ...
1103 : !> \param nlumos ...
1104 : !> \param homo ...
1105 : !> \param ispin ...
1106 : !> \param lumo ...
1107 : ! **************************************************************************************************
1108 142 : SUBROUTINE qs_scf_post_unocc_cubes(input, dft_section, dft_control, logger, qs_env, &
1109 : unoccupied_orbs, wf_g, wf_r, particles, nlumos, homo, ispin, lumo)
1110 :
1111 : TYPE(section_vals_type), POINTER :: input, dft_section
1112 : TYPE(dft_control_type), POINTER :: dft_control
1113 : TYPE(cp_logger_type), POINTER :: logger
1114 : TYPE(qs_environment_type), POINTER :: qs_env
1115 : TYPE(cp_fm_type), INTENT(IN) :: unoccupied_orbs
1116 : TYPE(pw_c1d_gs_type), INTENT(INOUT) :: wf_g
1117 : TYPE(pw_r3d_rs_type), INTENT(INOUT) :: wf_r
1118 : TYPE(particle_list_type), POINTER :: particles
1119 : INTEGER, INTENT(IN) :: nlumos, homo, ispin
1120 : INTEGER, INTENT(IN), OPTIONAL :: lumo
1121 :
1122 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_unocc_cubes'
1123 :
1124 : CHARACTER(LEN=default_path_length) :: filename, my_pos_cube, title
1125 : INTEGER :: handle, ifirst, index_mo, ivector, &
1126 : unit_nr
1127 : LOGICAL :: append_cube, mpi_io
1128 142 : TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
1129 : TYPE(cell_type), POINTER :: cell
1130 142 : TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
1131 : TYPE(pw_env_type), POINTER :: pw_env
1132 142 : TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
1133 :
1134 142 : CALL timeset(routineN, handle)
1135 :
1136 : IF (BTEST(cp_print_key_should_output(logger%iter_info, dft_section, "PRINT%MO_CUBES"), cp_p_file) &
1137 142 : .AND. section_get_lval(dft_section, "PRINT%MO_CUBES%WRITE_CUBE")) THEN
1138 104 : NULLIFY (qs_kind_set, particle_set, pw_env, cell)
1139 104 : append_cube = section_get_lval(dft_section, "PRINT%MO_CUBES%APPEND")
1140 104 : my_pos_cube = "REWIND"
1141 104 : IF (append_cube) THEN
1142 0 : my_pos_cube = "APPEND"
1143 : END IF
1144 104 : ifirst = 1
1145 104 : IF (PRESENT(lumo)) ifirst = lumo
1146 242 : DO ivector = ifirst, ifirst + nlumos - 1
1147 : CALL get_qs_env(qs_env=qs_env, &
1148 : atomic_kind_set=atomic_kind_set, &
1149 : qs_kind_set=qs_kind_set, &
1150 : cell=cell, &
1151 : particle_set=particle_set, &
1152 138 : pw_env=pw_env)
1153 : CALL calculate_wavefunction(unoccupied_orbs, ivector, wf_r, wf_g, atomic_kind_set, &
1154 138 : qs_kind_set, cell, dft_control, particle_set, pw_env)
1155 :
1156 138 : IF (ifirst == 1) THEN
1157 130 : index_mo = homo + ivector
1158 : ELSE
1159 8 : index_mo = ivector
1160 : END IF
1161 138 : WRITE (filename, '(a4,I5.5,a1,I1.1)') "WFN_", index_mo, "_", ispin
1162 138 : mpi_io = .TRUE.
1163 :
1164 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%MO_CUBES", extension=".cube", &
1165 : middle_name=TRIM(filename), file_position=my_pos_cube, log_filename=.FALSE., &
1166 138 : mpi_io=mpi_io)
1167 138 : WRITE (title, *) "WAVEFUNCTION ", index_mo, " spin ", ispin, " i.e. LUMO + ", ifirst + ivector - 2
1168 : CALL cp_pw_to_cube(wf_r, unit_nr, title, particles=particles, &
1169 138 : stride=section_get_ivals(dft_section, "PRINT%MO_CUBES%STRIDE"), mpi_io=mpi_io)
1170 242 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%MO_CUBES", mpi_io=mpi_io)
1171 : END DO
1172 : END IF
1173 :
1174 142 : CALL timestop(handle)
1175 :
1176 142 : END SUBROUTINE qs_scf_post_unocc_cubes
1177 :
1178 : ! **************************************************************************************************
1179 : !> \brief Computes and prints electric moments
1180 : !> \param input ...
1181 : !> \param logger ...
1182 : !> \param qs_env the qs_env in which the qs_env lives
1183 : !> \param output_unit ...
1184 : ! **************************************************************************************************
1185 11237 : SUBROUTINE qs_scf_post_moments(input, logger, qs_env, output_unit)
1186 : TYPE(section_vals_type), POINTER :: input
1187 : TYPE(cp_logger_type), POINTER :: logger
1188 : TYPE(qs_environment_type), POINTER :: qs_env
1189 : INTEGER, INTENT(IN) :: output_unit
1190 :
1191 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_moments'
1192 :
1193 : CHARACTER(LEN=default_path_length) :: filename
1194 : INTEGER :: handle, maxmom, reference, unit_nr
1195 : LOGICAL :: com_nl, do_kpoints, magnetic, periodic, &
1196 : second_ref_point, vel_reprs
1197 11237 : REAL(KIND=dp), DIMENSION(:), POINTER :: ref_point
1198 : TYPE(section_vals_type), POINTER :: print_key
1199 :
1200 11237 : CALL timeset(routineN, handle)
1201 :
1202 : print_key => section_vals_get_subs_vals(section_vals=input, &
1203 11237 : subsection_name="DFT%PRINT%MOMENTS")
1204 :
1205 11237 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
1206 :
1207 : maxmom = section_get_ival(section_vals=input, &
1208 1270 : keyword_name="DFT%PRINT%MOMENTS%MAX_MOMENT")
1209 : periodic = section_get_lval(section_vals=input, &
1210 1270 : keyword_name="DFT%PRINT%MOMENTS%PERIODIC")
1211 : reference = section_get_ival(section_vals=input, &
1212 1270 : keyword_name="DFT%PRINT%MOMENTS%REFERENCE")
1213 : magnetic = section_get_lval(section_vals=input, &
1214 1270 : keyword_name="DFT%PRINT%MOMENTS%MAGNETIC")
1215 : vel_reprs = section_get_lval(section_vals=input, &
1216 1270 : keyword_name="DFT%PRINT%MOMENTS%VEL_REPRS")
1217 : com_nl = section_get_lval(section_vals=input, &
1218 1270 : keyword_name="DFT%PRINT%MOMENTS%COM_NL")
1219 : second_ref_point = section_get_lval(section_vals=input, &
1220 1270 : keyword_name="DFT%PRINT%MOMENTS%SECOND_REFERENCE_POINT")
1221 :
1222 1270 : NULLIFY (ref_point)
1223 1270 : CALL section_vals_val_get(input, "DFT%PRINT%MOMENTS%REF_POINT", r_vals=ref_point)
1224 : unit_nr = cp_print_key_unit_nr(logger=logger, basis_section=input, &
1225 : print_key_path="DFT%PRINT%MOMENTS", extension=".dat", &
1226 1270 : middle_name="moments", log_filename=.FALSE.)
1227 :
1228 1270 : IF (output_unit > 0) THEN
1229 645 : IF (unit_nr /= output_unit) THEN
1230 33 : INQUIRE (UNIT=unit_nr, NAME=filename)
1231 : WRITE (UNIT=output_unit, FMT="(/,T2,A,2(/,T3,A),/)") &
1232 33 : "MOMENTS", "The electric/magnetic moments are written to file:", &
1233 66 : TRIM(filename)
1234 : ELSE
1235 612 : WRITE (UNIT=output_unit, FMT="(/,T2,A)") "ELECTRIC/MAGNETIC MOMENTS"
1236 : END IF
1237 : END IF
1238 :
1239 1270 : CALL get_qs_env(qs_env, do_kpoints=do_kpoints)
1240 :
1241 1270 : IF (do_kpoints) THEN
1242 2 : CPWARN("Moments not implemented for k-point calculations!")
1243 : ELSE
1244 1268 : IF (periodic) THEN
1245 472 : CALL qs_moment_berry_phase(qs_env, magnetic, maxmom, reference, ref_point, unit_nr)
1246 : ELSE
1247 796 : CALL qs_moment_locop(qs_env, magnetic, maxmom, reference, ref_point, unit_nr, vel_reprs, com_nl)
1248 : END IF
1249 : END IF
1250 :
1251 : CALL cp_print_key_finished_output(unit_nr=unit_nr, logger=logger, &
1252 1270 : basis_section=input, print_key_path="DFT%PRINT%MOMENTS")
1253 :
1254 1270 : IF (second_ref_point) THEN
1255 : reference = section_get_ival(section_vals=input, &
1256 0 : keyword_name="DFT%PRINT%MOMENTS%REFERENCE_2")
1257 :
1258 0 : NULLIFY (ref_point)
1259 0 : CALL section_vals_val_get(input, "DFT%PRINT%MOMENTS%REF_POINT_2", r_vals=ref_point)
1260 : unit_nr = cp_print_key_unit_nr(logger=logger, basis_section=input, &
1261 : print_key_path="DFT%PRINT%MOMENTS", extension=".dat", &
1262 0 : middle_name="moments_refpoint_2", log_filename=.FALSE.)
1263 :
1264 0 : IF (output_unit > 0) THEN
1265 0 : IF (unit_nr /= output_unit) THEN
1266 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
1267 : WRITE (UNIT=output_unit, FMT="(/,T2,A,2(/,T3,A),/)") &
1268 0 : "MOMENTS", "The electric/magnetic moments for the second reference point are written to file:", &
1269 0 : TRIM(filename)
1270 : ELSE
1271 0 : WRITE (UNIT=output_unit, FMT="(/,T2,A)") "ELECTRIC/MAGNETIC MOMENTS"
1272 : END IF
1273 : END IF
1274 0 : IF (do_kpoints) THEN
1275 0 : CPWARN("Moments not implemented for k-point calculations!")
1276 : ELSE
1277 0 : IF (periodic) THEN
1278 0 : CALL qs_moment_berry_phase(qs_env, magnetic, maxmom, reference, ref_point, unit_nr)
1279 : ELSE
1280 0 : CALL qs_moment_locop(qs_env, magnetic, maxmom, reference, ref_point, unit_nr, vel_reprs, com_nl)
1281 : END IF
1282 : END IF
1283 : CALL cp_print_key_finished_output(unit_nr=unit_nr, logger=logger, &
1284 0 : basis_section=input, print_key_path="DFT%PRINT%MOMENTS")
1285 : END IF
1286 :
1287 : END IF
1288 :
1289 11237 : CALL timestop(handle)
1290 :
1291 11237 : END SUBROUTINE qs_scf_post_moments
1292 :
1293 : ! **************************************************************************************************
1294 : !> \brief Computes and prints the X-ray diffraction spectrum.
1295 : !> \param input ...
1296 : !> \param dft_section ...
1297 : !> \param logger ...
1298 : !> \param qs_env the qs_env in which the qs_env lives
1299 : !> \param output_unit ...
1300 : ! **************************************************************************************************
1301 10051 : SUBROUTINE qs_scf_post_xray(input, dft_section, logger, qs_env, output_unit)
1302 :
1303 : TYPE(section_vals_type), POINTER :: input, dft_section
1304 : TYPE(cp_logger_type), POINTER :: logger
1305 : TYPE(qs_environment_type), POINTER :: qs_env
1306 : INTEGER, INTENT(IN) :: output_unit
1307 :
1308 : CHARACTER(LEN=*), PARAMETER :: routineN = 'qs_scf_post_xray'
1309 :
1310 : CHARACTER(LEN=default_path_length) :: filename
1311 : INTEGER :: handle, unit_nr
1312 : REAL(KIND=dp) :: q_max
1313 : TYPE(section_vals_type), POINTER :: print_key
1314 :
1315 10051 : CALL timeset(routineN, handle)
1316 :
1317 : print_key => section_vals_get_subs_vals(section_vals=input, &
1318 10051 : subsection_name="DFT%PRINT%XRAY_DIFFRACTION_SPECTRUM")
1319 :
1320 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
1321 : q_max = section_get_rval(section_vals=dft_section, &
1322 30 : keyword_name="PRINT%XRAY_DIFFRACTION_SPECTRUM%Q_MAX")
1323 : unit_nr = cp_print_key_unit_nr(logger=logger, &
1324 : basis_section=input, &
1325 : print_key_path="DFT%PRINT%XRAY_DIFFRACTION_SPECTRUM", &
1326 : extension=".dat", &
1327 : middle_name="xrd", &
1328 30 : log_filename=.FALSE.)
1329 30 : IF (output_unit > 0) THEN
1330 15 : INQUIRE (UNIT=unit_nr, NAME=filename)
1331 : WRITE (UNIT=output_unit, FMT="(/,/,T2,A)") &
1332 15 : "X-RAY DIFFRACTION SPECTRUM"
1333 15 : IF (unit_nr /= output_unit) THEN
1334 : WRITE (UNIT=output_unit, FMT="(/,T3,A,/,/,T3,A,/)") &
1335 14 : "The coherent X-ray diffraction spectrum is written to the file:", &
1336 28 : TRIM(filename)
1337 : END IF
1338 : END IF
1339 : CALL xray_diffraction_spectrum(qs_env=qs_env, &
1340 : unit_number=unit_nr, &
1341 30 : q_max=q_max)
1342 : CALL cp_print_key_finished_output(unit_nr=unit_nr, &
1343 : logger=logger, &
1344 : basis_section=input, &
1345 30 : print_key_path="DFT%PRINT%XRAY_DIFFRACTION_SPECTRUM")
1346 : END IF
1347 :
1348 10051 : CALL timestop(handle)
1349 :
1350 10051 : END SUBROUTINE qs_scf_post_xray
1351 :
1352 : ! **************************************************************************************************
1353 : !> \brief Computes and prints Electric Field Gradient
1354 : !> \param input ...
1355 : !> \param logger ...
1356 : !> \param qs_env the qs_env in which the qs_env lives
1357 : ! **************************************************************************************************
1358 10051 : SUBROUTINE qs_scf_post_efg(input, logger, qs_env)
1359 : TYPE(section_vals_type), POINTER :: input
1360 : TYPE(cp_logger_type), POINTER :: logger
1361 : TYPE(qs_environment_type), POINTER :: qs_env
1362 :
1363 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_efg'
1364 :
1365 : INTEGER :: handle
1366 : TYPE(section_vals_type), POINTER :: print_key
1367 :
1368 10051 : CALL timeset(routineN, handle)
1369 :
1370 : print_key => section_vals_get_subs_vals(section_vals=input, &
1371 10051 : subsection_name="DFT%PRINT%ELECTRIC_FIELD_GRADIENT")
1372 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), &
1373 : cp_p_file)) THEN
1374 30 : CALL qs_efg_calc(qs_env=qs_env)
1375 : END IF
1376 :
1377 10051 : CALL timestop(handle)
1378 :
1379 10051 : END SUBROUTINE qs_scf_post_efg
1380 :
1381 : ! **************************************************************************************************
1382 : !> \brief Computes the Electron Transfer Coupling matrix element
1383 : !> \param input ...
1384 : !> \param qs_env the qs_env in which the qs_env lives
1385 : !> \param dft_control ...
1386 : ! **************************************************************************************************
1387 20102 : SUBROUTINE qs_scf_post_et(input, qs_env, dft_control)
1388 : TYPE(section_vals_type), POINTER :: input
1389 : TYPE(qs_environment_type), POINTER :: qs_env
1390 : TYPE(dft_control_type), POINTER :: dft_control
1391 :
1392 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_et'
1393 :
1394 : INTEGER :: handle, ispin
1395 : LOGICAL :: do_et
1396 10051 : TYPE(cp_fm_type), DIMENSION(:), POINTER :: my_mos
1397 : TYPE(section_vals_type), POINTER :: et_section
1398 :
1399 10051 : CALL timeset(routineN, handle)
1400 :
1401 : do_et = .FALSE.
1402 10051 : et_section => section_vals_get_subs_vals(input, "PROPERTIES%ET_COUPLING")
1403 10051 : CALL section_vals_get(et_section, explicit=do_et)
1404 10051 : IF (do_et) THEN
1405 10 : IF (qs_env%et_coupling%first_run) THEN
1406 10 : NULLIFY (my_mos)
1407 50 : ALLOCATE (my_mos(dft_control%nspins))
1408 50 : ALLOCATE (qs_env%et_coupling%et_mo_coeff(dft_control%nspins))
1409 30 : DO ispin = 1, dft_control%nspins
1410 : CALL cp_fm_create(matrix=my_mos(ispin), &
1411 : matrix_struct=qs_env%mos(ispin)%mo_coeff%matrix_struct, &
1412 20 : name="FIRST_RUN_COEFF"//TRIM(ADJUSTL(cp_to_string(ispin)))//"MATRIX")
1413 : CALL cp_fm_to_fm(qs_env%mos(ispin)%mo_coeff, &
1414 30 : my_mos(ispin))
1415 : END DO
1416 10 : CALL set_et_coupling_type(qs_env%et_coupling, et_mo_coeff=my_mos)
1417 10 : DEALLOCATE (my_mos)
1418 : END IF
1419 : END IF
1420 :
1421 10051 : CALL timestop(handle)
1422 :
1423 10051 : END SUBROUTINE qs_scf_post_et
1424 :
1425 : ! **************************************************************************************************
1426 : !> \brief compute the electron localization function
1427 : !>
1428 : !> \param input ...
1429 : !> \param logger ...
1430 : !> \param qs_env ...
1431 : !> \par History
1432 : !> 2012-07 Created [MI]
1433 : ! **************************************************************************************************
1434 10051 : SUBROUTINE qs_scf_post_elf(input, logger, qs_env)
1435 : TYPE(section_vals_type), POINTER :: input
1436 : TYPE(cp_logger_type), POINTER :: logger
1437 : TYPE(qs_environment_type), POINTER :: qs_env
1438 :
1439 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_elf'
1440 :
1441 : CHARACTER(LEN=default_path_length) :: filename, mpi_filename, my_pos_cube, &
1442 : title
1443 : INTEGER :: handle, ispin, output_unit, unit_nr
1444 : LOGICAL :: append_cube, gapw, mpi_io
1445 : REAL(dp) :: rho_cutoff
1446 : TYPE(dft_control_type), POINTER :: dft_control
1447 : TYPE(particle_list_type), POINTER :: particles
1448 : TYPE(pw_env_type), POINTER :: pw_env
1449 10051 : TYPE(pw_pool_p_type), DIMENSION(:), POINTER :: pw_pools
1450 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
1451 10051 : TYPE(pw_r3d_rs_type), ALLOCATABLE, DIMENSION(:) :: elf_r
1452 : TYPE(qs_subsys_type), POINTER :: subsys
1453 : TYPE(section_vals_type), POINTER :: elf_section
1454 :
1455 10051 : CALL timeset(routineN, handle)
1456 10051 : output_unit = cp_logger_get_default_io_unit(logger)
1457 :
1458 10051 : elf_section => section_vals_get_subs_vals(input, "DFT%PRINT%ELF_CUBE")
1459 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
1460 : "DFT%PRINT%ELF_CUBE"), cp_p_file)) THEN
1461 :
1462 80 : NULLIFY (dft_control, pw_env, auxbas_pw_pool, pw_pools, particles, subsys)
1463 80 : CALL get_qs_env(qs_env, dft_control=dft_control, pw_env=pw_env, subsys=subsys)
1464 80 : CALL qs_subsys_get(subsys, particles=particles)
1465 :
1466 80 : gapw = dft_control%qs_control%gapw
1467 80 : IF (.NOT. gapw) THEN
1468 : ! allocate
1469 322 : ALLOCATE (elf_r(dft_control%nspins))
1470 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool, &
1471 80 : pw_pools=pw_pools)
1472 162 : DO ispin = 1, dft_control%nspins
1473 82 : CALL auxbas_pw_pool%create_pw(elf_r(ispin))
1474 162 : CALL pw_zero(elf_r(ispin))
1475 : END DO
1476 :
1477 80 : IF (output_unit > 0) THEN
1478 : WRITE (UNIT=output_unit, FMT="(/,T15,A,/)") &
1479 40 : " ----- ELF is computed on the real space grid -----"
1480 : END IF
1481 80 : rho_cutoff = section_get_rval(elf_section, "density_cutoff")
1482 80 : CALL qs_elf_calc(qs_env, elf_r, rho_cutoff)
1483 :
1484 : ! write ELF into cube file
1485 80 : append_cube = section_get_lval(elf_section, "APPEND")
1486 80 : my_pos_cube = "REWIND"
1487 80 : IF (append_cube) THEN
1488 0 : my_pos_cube = "APPEND"
1489 : END IF
1490 :
1491 162 : DO ispin = 1, dft_control%nspins
1492 82 : WRITE (filename, '(a5,I1.1)') "ELF_S", ispin
1493 82 : WRITE (title, *) "ELF spin ", ispin
1494 82 : mpi_io = .TRUE.
1495 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%ELF_CUBE", extension=".cube", &
1496 : middle_name=TRIM(filename), file_position=my_pos_cube, log_filename=.FALSE., &
1497 82 : mpi_io=mpi_io, fout=mpi_filename)
1498 82 : IF (output_unit > 0) THEN
1499 41 : IF (.NOT. mpi_io) THEN
1500 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
1501 : ELSE
1502 41 : filename = mpi_filename
1503 : END IF
1504 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
1505 41 : "ELF is written in cube file format to the file:", &
1506 82 : TRIM(filename)
1507 : END IF
1508 :
1509 : CALL cp_pw_to_cube(elf_r(ispin), unit_nr, title, particles=particles, &
1510 82 : stride=section_get_ivals(elf_section, "STRIDE"), mpi_io=mpi_io)
1511 82 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%ELF_CUBE", mpi_io=mpi_io)
1512 :
1513 162 : CALL auxbas_pw_pool%give_back_pw(elf_r(ispin))
1514 : END DO
1515 :
1516 : ! deallocate
1517 80 : DEALLOCATE (elf_r)
1518 :
1519 : ELSE
1520 : ! not implemented
1521 0 : CPWARN("ELF not implemented for GAPW calculations!")
1522 : END IF
1523 :
1524 : END IF ! print key
1525 :
1526 10051 : CALL timestop(handle)
1527 :
1528 20102 : END SUBROUTINE qs_scf_post_elf
1529 :
1530 : ! **************************************************************************************************
1531 : !> \brief computes the condition number of the overlap matrix and
1532 : !> prints the value of the total energy. This is needed
1533 : !> for BASIS_MOLOPT optimizations
1534 : !> \param input ...
1535 : !> \param logger ...
1536 : !> \param qs_env the qs_env in which the qs_env lives
1537 : !> \par History
1538 : !> 2007-07 Created [Joost VandeVondele]
1539 : ! **************************************************************************************************
1540 10051 : SUBROUTINE qs_scf_post_molopt(input, logger, qs_env)
1541 : TYPE(section_vals_type), POINTER :: input
1542 : TYPE(cp_logger_type), POINTER :: logger
1543 : TYPE(qs_environment_type), POINTER :: qs_env
1544 :
1545 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_molopt'
1546 :
1547 : INTEGER :: handle, nao, unit_nr
1548 : REAL(KIND=dp) :: S_cond_number
1549 10051 : REAL(KIND=dp), ALLOCATABLE, DIMENSION(:) :: eigenvalues
1550 : TYPE(cp_fm_struct_type), POINTER :: ao_ao_fmstruct
1551 : TYPE(cp_fm_type) :: fm_s, fm_work
1552 : TYPE(cp_fm_type), POINTER :: mo_coeff
1553 10051 : TYPE(dbcsr_p_type), DIMENSION(:), POINTER :: matrix_s
1554 10051 : TYPE(mo_set_type), DIMENSION(:), POINTER :: mos
1555 : TYPE(qs_energy_type), POINTER :: energy
1556 : TYPE(section_vals_type), POINTER :: print_key
1557 :
1558 10051 : CALL timeset(routineN, handle)
1559 :
1560 : print_key => section_vals_get_subs_vals(section_vals=input, &
1561 10051 : subsection_name="DFT%PRINT%BASIS_MOLOPT_QUANTITIES")
1562 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), &
1563 : cp_p_file)) THEN
1564 :
1565 28 : CALL get_qs_env(qs_env, energy=energy, matrix_s=matrix_s, mos=mos)
1566 :
1567 : ! set up the two needed full matrices, using mo_coeff as a template
1568 28 : CALL get_mo_set(mo_set=mos(1), mo_coeff=mo_coeff, nao=nao)
1569 : CALL cp_fm_struct_create(fmstruct=ao_ao_fmstruct, &
1570 : nrow_global=nao, ncol_global=nao, &
1571 28 : template_fmstruct=mo_coeff%matrix_struct)
1572 : CALL cp_fm_create(fm_s, matrix_struct=ao_ao_fmstruct, &
1573 28 : name="fm_s")
1574 : CALL cp_fm_create(fm_work, matrix_struct=ao_ao_fmstruct, &
1575 28 : name="fm_work")
1576 28 : CALL cp_fm_struct_release(ao_ao_fmstruct)
1577 84 : ALLOCATE (eigenvalues(nao))
1578 :
1579 28 : CALL copy_dbcsr_to_fm(matrix_s(1)%matrix, fm_s)
1580 28 : CALL choose_eigv_solver(fm_s, fm_work, eigenvalues)
1581 :
1582 28 : CALL cp_fm_release(fm_s)
1583 28 : CALL cp_fm_release(fm_work)
1584 :
1585 1048 : S_cond_number = MAXVAL(ABS(eigenvalues))/MAX(MINVAL(ABS(eigenvalues)), EPSILON(0.0_dp))
1586 :
1587 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%BASIS_MOLOPT_QUANTITIES", &
1588 28 : extension=".molopt")
1589 :
1590 28 : IF (unit_nr > 0) THEN
1591 : ! please keep this format fixed, needs to be grepable for molopt
1592 : ! optimizations
1593 14 : WRITE (unit_nr, '(T2,A28,2A25)') "", "Tot. Ener.", "S Cond. Numb."
1594 14 : WRITE (unit_nr, '(T2,A28,2E25.17)') "BASIS_MOLOPT_QUANTITIES", energy%total, S_cond_number
1595 : END IF
1596 :
1597 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
1598 84 : "DFT%PRINT%BASIS_MOLOPT_QUANTITIES")
1599 :
1600 : END IF
1601 :
1602 10051 : CALL timestop(handle)
1603 :
1604 20102 : END SUBROUTINE qs_scf_post_molopt
1605 :
1606 : ! **************************************************************************************************
1607 : !> \brief Dumps EPR
1608 : !> \param input ...
1609 : !> \param logger ...
1610 : !> \param qs_env the qs_env in which the qs_env lives
1611 : ! **************************************************************************************************
1612 10051 : SUBROUTINE qs_scf_post_epr(input, logger, qs_env)
1613 : TYPE(section_vals_type), POINTER :: input
1614 : TYPE(cp_logger_type), POINTER :: logger
1615 : TYPE(qs_environment_type), POINTER :: qs_env
1616 :
1617 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_epr'
1618 :
1619 : INTEGER :: handle
1620 : TYPE(section_vals_type), POINTER :: print_key
1621 :
1622 10051 : CALL timeset(routineN, handle)
1623 :
1624 : print_key => section_vals_get_subs_vals(section_vals=input, &
1625 10051 : subsection_name="DFT%PRINT%HYPERFINE_COUPLING_TENSOR")
1626 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), &
1627 : cp_p_file)) THEN
1628 30 : CALL qs_epr_hyp_calc(qs_env=qs_env)
1629 : END IF
1630 :
1631 10051 : CALL timestop(handle)
1632 :
1633 10051 : END SUBROUTINE qs_scf_post_epr
1634 :
1635 : ! **************************************************************************************************
1636 : !> \brief Interface routine to trigger writing of results available from normal
1637 : !> SCF. Can write MO-dependent and MO free results (needed for call from
1638 : !> the linear scaling code)
1639 : !> \param qs_env the qs_env in which the qs_env lives
1640 : !> \param scf_env ...
1641 : ! **************************************************************************************************
1642 10051 : SUBROUTINE write_available_results(qs_env, scf_env)
1643 : TYPE(qs_environment_type), POINTER :: qs_env
1644 : TYPE(qs_scf_env_type), OPTIONAL, POINTER :: scf_env
1645 :
1646 : CHARACTER(len=*), PARAMETER :: routineN = 'write_available_results'
1647 :
1648 : INTEGER :: handle
1649 :
1650 10051 : CALL timeset(routineN, handle)
1651 :
1652 : ! those properties that require MOs (not suitable density matrix based methods)
1653 10051 : CALL write_mo_dependent_results(qs_env, scf_env)
1654 :
1655 : ! those that depend only on the density matrix, they should be linear scaling in their implementation
1656 10051 : CALL write_mo_free_results(qs_env)
1657 :
1658 10051 : CALL timestop(handle)
1659 :
1660 10051 : END SUBROUTINE write_available_results
1661 :
1662 : ! **************************************************************************************************
1663 : !> \brief Write QS results available if MO's are present (if switched on through the print_keys)
1664 : !> Writes only MO dependent results. Split is necessary as ls_scf does not
1665 : !> provide MO's
1666 : !> \param qs_env the qs_env in which the qs_env lives
1667 : !> \param scf_env ...
1668 : ! **************************************************************************************************
1669 10363 : SUBROUTINE write_mo_dependent_results(qs_env, scf_env)
1670 : TYPE(qs_environment_type), POINTER :: qs_env
1671 : TYPE(qs_scf_env_type), OPTIONAL, POINTER :: scf_env
1672 :
1673 : CHARACTER(len=*), PARAMETER :: routineN = 'write_mo_dependent_results'
1674 :
1675 : INTEGER :: handle, homo, ispin, nmo, output_unit
1676 : LOGICAL :: all_equal, do_kpoints, explicit
1677 : REAL(KIND=dp) :: maxocc, s_square, s_square_ideal, &
1678 : total_abs_spin_dens, total_spin_dens
1679 10363 : REAL(KIND=dp), DIMENSION(:), POINTER :: mo_eigenvalues, occupation_numbers
1680 : TYPE(admm_type), POINTER :: admm_env
1681 10363 : TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
1682 : TYPE(cell_type), POINTER :: cell
1683 : TYPE(cp_fm_type), POINTER :: mo_coeff
1684 : TYPE(cp_logger_type), POINTER :: logger
1685 10363 : TYPE(dbcsr_p_type), DIMENSION(:), POINTER :: ks_rmpv, matrix_s
1686 : TYPE(dbcsr_type), POINTER :: mo_coeff_deriv
1687 : TYPE(dft_control_type), POINTER :: dft_control
1688 10363 : TYPE(mo_set_type), DIMENSION(:), POINTER :: mos
1689 10363 : TYPE(molecule_type), POINTER :: molecule_set(:)
1690 : TYPE(particle_list_type), POINTER :: particles
1691 10363 : TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
1692 : TYPE(pw_env_type), POINTER :: pw_env
1693 10363 : TYPE(pw_pool_p_type), DIMENSION(:), POINTER :: pw_pools
1694 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
1695 : TYPE(pw_r3d_rs_type) :: wf_r
1696 10363 : TYPE(pw_r3d_rs_type), DIMENSION(:), POINTER :: rho_r
1697 : TYPE(qs_energy_type), POINTER :: energy
1698 10363 : TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
1699 : TYPE(qs_rho_type), POINTER :: rho
1700 : TYPE(qs_subsys_type), POINTER :: subsys
1701 : TYPE(scf_control_type), POINTER :: scf_control
1702 : TYPE(section_vals_type), POINTER :: dft_section, input, sprint_section, &
1703 : trexio_section
1704 :
1705 : ! TYPE(kpoint_type), POINTER :: kpoints
1706 :
1707 10363 : CALL timeset(routineN, handle)
1708 :
1709 10363 : NULLIFY (cell, dft_control, pw_env, auxbas_pw_pool, pw_pools, mo_coeff, &
1710 10363 : mo_coeff_deriv, mo_eigenvalues, mos, atomic_kind_set, qs_kind_set, &
1711 10363 : particle_set, rho, ks_rmpv, matrix_s, scf_control, dft_section, &
1712 10363 : molecule_set, input, particles, subsys, rho_r)
1713 :
1714 10363 : logger => cp_get_default_logger()
1715 10363 : output_unit = cp_logger_get_default_io_unit(logger)
1716 :
1717 10363 : CPASSERT(ASSOCIATED(qs_env))
1718 : CALL get_qs_env(qs_env, &
1719 : dft_control=dft_control, &
1720 : molecule_set=molecule_set, &
1721 : atomic_kind_set=atomic_kind_set, &
1722 : particle_set=particle_set, &
1723 : qs_kind_set=qs_kind_set, &
1724 : admm_env=admm_env, &
1725 : scf_control=scf_control, &
1726 : input=input, &
1727 : cell=cell, &
1728 10363 : subsys=subsys)
1729 10363 : CALL qs_subsys_get(subsys, particles=particles)
1730 10363 : CALL get_qs_env(qs_env, rho=rho)
1731 10363 : CALL qs_rho_get(rho, rho_r=rho_r)
1732 :
1733 : ! k points
1734 10363 : CALL get_qs_env(qs_env, do_kpoints=do_kpoints)
1735 :
1736 : ! Write last MO information to output file if requested
1737 10363 : dft_section => section_vals_get_subs_vals(input, "DFT")
1738 10363 : IF (.NOT. qs_env%run_rtp) THEN
1739 10051 : CALL qs_scf_write_mos(qs_env, scf_env, final_mos=.TRUE.)
1740 10051 : trexio_section => section_vals_get_subs_vals(dft_section, "PRINT%TREXIO")
1741 10051 : CALL section_vals_get(trexio_section, explicit=explicit)
1742 10051 : IF (explicit) THEN
1743 8 : CALL write_trexio(qs_env, trexio_section)
1744 : END IF
1745 10051 : IF (.NOT. do_kpoints) THEN
1746 9831 : CALL get_qs_env(qs_env, mos=mos, matrix_ks=ks_rmpv)
1747 9831 : CALL write_dm_binary_restart(mos, dft_section, ks_rmpv)
1748 9831 : sprint_section => section_vals_get_subs_vals(dft_section, "PRINT%MO_MOLDEN")
1749 9831 : CALL write_mos_molden(mos, qs_kind_set, particle_set, sprint_section)
1750 : ! Write Chargemol .wfx
1751 9831 : IF (BTEST(cp_print_key_should_output(logger%iter_info, &
1752 : dft_section, "PRINT%CHARGEMOL"), &
1753 : cp_p_file)) THEN
1754 2 : CALL write_wfx(qs_env, dft_section)
1755 : END IF
1756 : END IF
1757 :
1758 : ! DOS printout after the SCF cycle is completed
1759 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, dft_section, "PRINT%DOS") &
1760 : , cp_p_file)) THEN
1761 42 : IF (do_kpoints) THEN
1762 2 : CALL calculate_dos_kp(qs_env, dft_section)
1763 : ELSE
1764 40 : CALL get_qs_env(qs_env, mos=mos)
1765 40 : CALL calculate_dos(mos, dft_section)
1766 : END IF
1767 : END IF
1768 :
1769 : ! Print the projected density of states (pDOS) for each atomic kind
1770 10051 : IF (BTEST(cp_print_key_should_output(logger%iter_info, dft_section, "PRINT%PDOS"), &
1771 : cp_p_file)) THEN
1772 48 : IF (do_kpoints) THEN
1773 0 : CPWARN("Projected density of states (pDOS) is not implemented for k points")
1774 : ELSE
1775 : CALL get_qs_env(qs_env, &
1776 : mos=mos, &
1777 48 : matrix_ks=ks_rmpv)
1778 96 : DO ispin = 1, dft_control%nspins
1779 : ! With ADMM, we have to modify the Kohn-Sham matrix
1780 48 : IF (dft_control%do_admm) THEN
1781 0 : CALL admm_correct_for_eigenvalues(ispin, admm_env, ks_rmpv(ispin)%matrix)
1782 : END IF
1783 48 : IF (PRESENT(scf_env)) THEN
1784 48 : IF (scf_env%method == ot_method_nr) THEN
1785 : CALL get_mo_set(mo_set=mos(ispin), mo_coeff=mo_coeff, &
1786 8 : eigenvalues=mo_eigenvalues)
1787 8 : IF (ASSOCIATED(qs_env%mo_derivs)) THEN
1788 8 : mo_coeff_deriv => qs_env%mo_derivs(ispin)%matrix
1789 : ELSE
1790 0 : mo_coeff_deriv => NULL()
1791 : END IF
1792 : CALL calculate_subspace_eigenvalues(mo_coeff, ks_rmpv(ispin)%matrix, mo_eigenvalues, &
1793 : do_rotation=.TRUE., &
1794 8 : co_rotate_dbcsr=mo_coeff_deriv)
1795 8 : CALL set_mo_occupation(mo_set=mos(ispin))
1796 : END IF
1797 : END IF
1798 48 : IF (dft_control%nspins == 2) THEN
1799 : CALL calculate_projected_dos(mos(ispin), atomic_kind_set, &
1800 0 : qs_kind_set, particle_set, qs_env, dft_section, ispin=ispin)
1801 : ELSE
1802 : CALL calculate_projected_dos(mos(ispin), atomic_kind_set, &
1803 48 : qs_kind_set, particle_set, qs_env, dft_section)
1804 : END IF
1805 : ! With ADMM, we have to undo the modification of the Kohn-Sham matrix
1806 96 : IF (dft_control%do_admm) THEN
1807 0 : CALL admm_uncorrect_for_eigenvalues(ispin, admm_env, ks_rmpv(ispin)%matrix)
1808 : END IF
1809 : END DO
1810 : END IF
1811 : END IF
1812 : END IF
1813 :
1814 : ! Integrated absolute spin density and spin contamination ***
1815 10363 : IF (dft_control%nspins == 2) THEN
1816 1982 : CALL get_qs_env(qs_env, mos=mos)
1817 1982 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env)
1818 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool, &
1819 1982 : pw_pools=pw_pools)
1820 1982 : CALL auxbas_pw_pool%create_pw(wf_r)
1821 1982 : CALL pw_copy(rho_r(1), wf_r)
1822 1982 : CALL pw_axpy(rho_r(2), wf_r, alpha=-1._dp)
1823 1982 : total_spin_dens = pw_integrate_function(wf_r)
1824 1982 : IF (output_unit > 0) WRITE (UNIT=output_unit, FMT='(/,(T3,A,T61,F20.10))') &
1825 1014 : "Integrated spin density: ", total_spin_dens
1826 1982 : total_abs_spin_dens = pw_integrate_function(wf_r, oprt="ABS")
1827 1982 : IF (output_unit > 0) WRITE (UNIT=output_unit, FMT='((T3,A,T61,F20.10))') &
1828 1014 : "Integrated absolute spin density: ", total_abs_spin_dens
1829 1982 : CALL auxbas_pw_pool%give_back_pw(wf_r)
1830 : !
1831 : ! XXX Fix Me XXX
1832 : ! should be extended to the case where added MOs are present
1833 : ! should be extended to the k-point case
1834 : !
1835 1982 : IF (do_kpoints) THEN
1836 30 : CPWARN("Spin contamination estimate not implemented for k-points.")
1837 : ELSE
1838 1952 : all_equal = .TRUE.
1839 5856 : DO ispin = 1, dft_control%nspins
1840 : CALL get_mo_set(mo_set=mos(ispin), &
1841 : occupation_numbers=occupation_numbers, &
1842 : homo=homo, &
1843 : nmo=nmo, &
1844 3904 : maxocc=maxocc)
1845 5856 : IF (nmo > 0) THEN
1846 : all_equal = all_equal .AND. &
1847 : (ALL(occupation_numbers(1:homo) == maxocc) .AND. &
1848 22302 : ALL(occupation_numbers(homo + 1:nmo) == 0.0_dp))
1849 : END IF
1850 : END DO
1851 1952 : IF (.NOT. all_equal) THEN
1852 106 : IF (output_unit > 0) WRITE (UNIT=output_unit, FMT="(T3,A)") &
1853 53 : "WARNING: S**2 computation does not yet treat fractional occupied orbitals"
1854 : ELSE
1855 : CALL get_qs_env(qs_env=qs_env, &
1856 : matrix_s=matrix_s, &
1857 1846 : energy=energy)
1858 : CALL compute_s_square(mos=mos, matrix_s=matrix_s, s_square=s_square, &
1859 1846 : s_square_ideal=s_square_ideal)
1860 1846 : IF (output_unit > 0) WRITE (UNIT=output_unit, FMT='(T3,A,T51,2F15.6)') &
1861 946 : "Ideal and single determinant S**2 : ", s_square_ideal, s_square
1862 1846 : energy%s_square = s_square
1863 : END IF
1864 : END IF
1865 : END IF
1866 :
1867 10363 : CALL timestop(handle)
1868 :
1869 10363 : END SUBROUTINE write_mo_dependent_results
1870 :
1871 : ! **************************************************************************************************
1872 : !> \brief Write QS results always available (if switched on through the print_keys)
1873 : !> Can be called from ls_scf
1874 : !> \param qs_env the qs_env in which the qs_env lives
1875 : ! **************************************************************************************************
1876 11297 : SUBROUTINE write_mo_free_results(qs_env)
1877 : TYPE(qs_environment_type), POINTER :: qs_env
1878 :
1879 : CHARACTER(len=*), PARAMETER :: routineN = 'write_mo_free_results'
1880 : CHARACTER(len=1), DIMENSION(3), PARAMETER :: cdir = ["x", "y", "z"]
1881 :
1882 : CHARACTER(LEN=2) :: element_symbol
1883 : CHARACTER(LEN=default_path_length) :: filename, mpi_filename, my_pos_cube, &
1884 : my_pos_voro
1885 : CHARACTER(LEN=default_string_length) :: name, print_density
1886 : INTEGER :: after, handle, i, iat, iatom, id, ikind, img, iso, ispin, iw, l, n_rep_hf, nat, &
1887 : natom, nd(3), ngto, niso, nkind, np, nr, output_unit, print_level, should_print_bqb, &
1888 : should_print_voro, unit_nr, unit_nr_voro
1889 : LOGICAL :: append_cube, append_voro, do_hfx, do_kpoints, mpi_io, omit_headers, print_it, &
1890 : rho_r_valid, voro_print_txt, write_ks, write_xc, xrd_interface
1891 : REAL(KIND=dp) :: norm_factor, q_max, rho_hard, rho_soft, &
1892 : rho_total, rho_total_rspace, udvol, &
1893 : volume, zeff
1894 11297 : REAL(KIND=dp), ALLOCATABLE, DIMENSION(:) :: zcharge
1895 11297 : REAL(KIND=dp), ALLOCATABLE, DIMENSION(:, :) :: bfun
1896 11297 : REAL(KIND=dp), ALLOCATABLE, DIMENSION(:, :, :) :: aedens, ccdens, ppdens
1897 : REAL(KIND=dp), DIMENSION(3) :: dr
1898 11297 : REAL(KIND=dp), DIMENSION(:), POINTER :: my_Q0
1899 11297 : TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
1900 : TYPE(atomic_kind_type), POINTER :: atomic_kind
1901 : TYPE(cell_type), POINTER :: cell
1902 : TYPE(cp_logger_type), POINTER :: logger
1903 11297 : TYPE(dbcsr_p_type), DIMENSION(:), POINTER :: matrix_hr
1904 11297 : TYPE(dbcsr_p_type), DIMENSION(:, :), POINTER :: ks_rmpv, matrix_vxc, rho_ao
1905 : TYPE(dft_control_type), POINTER :: dft_control
1906 : TYPE(grid_atom_type), POINTER :: grid_atom
1907 : TYPE(iao_env_type) :: iao_env
1908 : TYPE(mp_para_env_type), POINTER :: para_env
1909 : TYPE(particle_list_type), POINTER :: particles
1910 11297 : TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
1911 : TYPE(pw_c1d_gs_type) :: aux_g, rho_elec_gspace
1912 : TYPE(pw_c1d_gs_type), POINTER :: rho0_s_gs, rho_core, rhoz_cneo_s_gs
1913 : TYPE(pw_env_type), POINTER :: pw_env
1914 11297 : TYPE(pw_pool_p_type), DIMENSION(:), POINTER :: pw_pools
1915 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
1916 : TYPE(pw_r3d_rs_type) :: aux_r, rho_elec_rspace, wf_r
1917 11297 : TYPE(pw_r3d_rs_type), DIMENSION(:), POINTER :: rho_r
1918 : TYPE(pw_r3d_rs_type), POINTER :: mb_rho, v_hartree_rspace, vee
1919 11297 : TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
1920 : TYPE(qs_kind_type), POINTER :: qs_kind
1921 : TYPE(qs_rho_type), POINTER :: rho
1922 : TYPE(qs_subsys_type), POINTER :: subsys
1923 : TYPE(rho0_mpole_type), POINTER :: rho0_mpole
1924 11297 : TYPE(rho_atom_type), DIMENSION(:), POINTER :: rho_atom_set
1925 : TYPE(rho_atom_type), POINTER :: rho_atom
1926 : TYPE(section_vals_type), POINTER :: dft_section, hfx_section, input, &
1927 : print_key, print_key_bqb, &
1928 : print_key_voro, xc_section
1929 :
1930 11297 : CALL timeset(routineN, handle)
1931 11297 : NULLIFY (cell, dft_control, pw_env, auxbas_pw_pool, pw_pools, hfx_section, &
1932 11297 : atomic_kind_set, qs_kind_set, particle_set, rho, ks_rmpv, rho_ao, rho_r, &
1933 11297 : dft_section, xc_section, input, particles, subsys, matrix_vxc, v_hartree_rspace, &
1934 11297 : vee)
1935 :
1936 11297 : logger => cp_get_default_logger()
1937 11297 : output_unit = cp_logger_get_default_io_unit(logger)
1938 :
1939 11297 : CPASSERT(ASSOCIATED(qs_env))
1940 : CALL get_qs_env(qs_env, &
1941 : atomic_kind_set=atomic_kind_set, &
1942 : qs_kind_set=qs_kind_set, &
1943 : particle_set=particle_set, &
1944 : cell=cell, &
1945 : para_env=para_env, &
1946 : dft_control=dft_control, &
1947 : input=input, &
1948 : do_kpoints=do_kpoints, &
1949 11297 : subsys=subsys)
1950 11297 : dft_section => section_vals_get_subs_vals(input, "DFT")
1951 11297 : CALL qs_subsys_get(subsys, particles=particles)
1952 :
1953 11297 : CALL get_qs_env(qs_env, rho=rho)
1954 11297 : CALL qs_rho_get(rho, rho_r=rho_r)
1955 :
1956 11297 : CALL get_qs_env(qs_env, nkind=nkind, natom=natom)
1957 33891 : ALLOCATE (zcharge(natom))
1958 31647 : DO ikind = 1, nkind
1959 20350 : CALL get_qs_kind(qs_kind_set(ikind), zeff=zeff)
1960 20350 : CALL get_atomic_kind(atomic_kind_set(ikind), natom=nat)
1961 74836 : DO iatom = 1, nat
1962 43189 : iat = atomic_kind_set(ikind)%atom_list(iatom)
1963 63539 : zcharge(iat) = zeff
1964 : END DO
1965 : END DO
1966 :
1967 : ! Print the total density (electronic + core charge)
1968 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
1969 : "DFT%PRINT%TOT_DENSITY_CUBE"), cp_p_file)) THEN
1970 82 : NULLIFY (rho_core, rho0_s_gs, rhoz_cneo_s_gs)
1971 82 : append_cube = section_get_lval(input, "DFT%PRINT%TOT_DENSITY_CUBE%APPEND")
1972 82 : my_pos_cube = "REWIND"
1973 82 : IF (append_cube) THEN
1974 0 : my_pos_cube = "APPEND"
1975 : END IF
1976 :
1977 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env, rho_core=rho_core, &
1978 82 : rho0_s_gs=rho0_s_gs, rhoz_cneo_s_gs=rhoz_cneo_s_gs)
1979 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool, &
1980 82 : pw_pools=pw_pools)
1981 82 : CALL auxbas_pw_pool%create_pw(wf_r)
1982 82 : IF (dft_control%qs_control%gapw) THEN
1983 0 : IF (dft_control%qs_control%gapw_control%nopaw_as_gpw) THEN
1984 0 : CALL pw_axpy(rho_core, rho0_s_gs)
1985 0 : IF (ASSOCIATED(rhoz_cneo_s_gs)) THEN
1986 0 : CALL pw_axpy(rhoz_cneo_s_gs, rho0_s_gs)
1987 : END IF
1988 0 : CALL pw_transfer(rho0_s_gs, wf_r)
1989 0 : CALL pw_axpy(rho_core, rho0_s_gs, -1.0_dp)
1990 0 : IF (ASSOCIATED(rhoz_cneo_s_gs)) THEN
1991 0 : CALL pw_axpy(rhoz_cneo_s_gs, rho0_s_gs, -1.0_dp)
1992 : END IF
1993 : ELSE
1994 0 : IF (ASSOCIATED(rhoz_cneo_s_gs)) THEN
1995 0 : CALL pw_axpy(rhoz_cneo_s_gs, rho0_s_gs)
1996 : END IF
1997 0 : CALL pw_transfer(rho0_s_gs, wf_r)
1998 0 : IF (ASSOCIATED(rhoz_cneo_s_gs)) THEN
1999 0 : CALL pw_axpy(rhoz_cneo_s_gs, rho0_s_gs, -1.0_dp)
2000 : END IF
2001 : END IF
2002 : ELSE
2003 82 : CALL pw_transfer(rho_core, wf_r)
2004 : END IF
2005 164 : DO ispin = 1, dft_control%nspins
2006 164 : CALL pw_axpy(rho_r(ispin), wf_r)
2007 : END DO
2008 82 : filename = "TOTAL_DENSITY"
2009 82 : mpi_io = .TRUE.
2010 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%TOT_DENSITY_CUBE", &
2011 : extension=".cube", middle_name=TRIM(filename), file_position=my_pos_cube, &
2012 82 : log_filename=.FALSE., mpi_io=mpi_io)
2013 : CALL cp_pw_to_cube(wf_r, unit_nr, "TOTAL DENSITY", &
2014 : particles=particles, zeff=zcharge, &
2015 82 : stride=section_get_ivals(dft_section, "PRINT%TOT_DENSITY_CUBE%STRIDE"), mpi_io=mpi_io)
2016 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2017 82 : "DFT%PRINT%TOT_DENSITY_CUBE", mpi_io=mpi_io)
2018 82 : CALL auxbas_pw_pool%give_back_pw(wf_r)
2019 : END IF
2020 :
2021 : ! Write cube file with electron density
2022 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
2023 : "DFT%PRINT%E_DENSITY_CUBE"), cp_p_file)) THEN
2024 : CALL section_vals_val_get(dft_section, &
2025 : keyword_name="PRINT%E_DENSITY_CUBE%DENSITY_INCLUDE", &
2026 150 : c_val=print_density)
2027 : print_density = TRIM(print_density)
2028 150 : append_cube = section_get_lval(input, "DFT%PRINT%E_DENSITY_CUBE%APPEND")
2029 150 : my_pos_cube = "REWIND"
2030 150 : IF (append_cube) THEN
2031 0 : my_pos_cube = "APPEND"
2032 : END IF
2033 : ! Write the info on core densities for the interface between cp2k and the XRD code
2034 : ! together with the valence density they are used to compute the form factor (Fourier transform)
2035 150 : xrd_interface = section_get_lval(input, "DFT%PRINT%E_DENSITY_CUBE%XRD_INTERFACE")
2036 150 : IF (xrd_interface) THEN
2037 : !cube file only contains soft density (GAPW)
2038 2 : IF (dft_control%qs_control%gapw) print_density = "SOFT_DENSITY"
2039 :
2040 2 : filename = "ELECTRON_DENSITY"
2041 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2042 : extension=".xrd", middle_name=TRIM(filename), &
2043 2 : file_position=my_pos_cube, log_filename=.FALSE.)
2044 2 : ngto = section_get_ival(input, "DFT%PRINT%E_DENSITY_CUBE%NGAUSS")
2045 2 : IF (output_unit > 0) THEN
2046 1 : INQUIRE (UNIT=unit_nr, NAME=filename)
2047 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2048 1 : "The electron density (atomic part) is written to the file:", &
2049 2 : TRIM(filename)
2050 : END IF
2051 :
2052 2 : xc_section => section_vals_get_subs_vals(input, "DFT%XC")
2053 2 : nkind = SIZE(atomic_kind_set)
2054 2 : IF (unit_nr > 0) THEN
2055 1 : WRITE (unit_nr, *) "Atomic (core) densities"
2056 1 : WRITE (unit_nr, *) "Unit cell"
2057 1 : WRITE (unit_nr, FMT="(3F20.12)") cell%hmat(1, 1), cell%hmat(1, 2), cell%hmat(1, 3)
2058 1 : WRITE (unit_nr, FMT="(3F20.12)") cell%hmat(2, 1), cell%hmat(2, 2), cell%hmat(2, 3)
2059 1 : WRITE (unit_nr, FMT="(3F20.12)") cell%hmat(3, 1), cell%hmat(3, 2), cell%hmat(3, 3)
2060 1 : WRITE (unit_nr, *) "Atomic types"
2061 1 : WRITE (unit_nr, *) nkind
2062 : END IF
2063 : ! calculate atomic density and core density
2064 16 : ALLOCATE (ppdens(ngto, 2, nkind), aedens(ngto, 2, nkind), ccdens(ngto, 2, nkind))
2065 6 : DO ikind = 1, nkind
2066 4 : atomic_kind => atomic_kind_set(ikind)
2067 4 : qs_kind => qs_kind_set(ikind)
2068 4 : CALL get_atomic_kind(atomic_kind, name=name, element_symbol=element_symbol)
2069 : CALL calculate_atomic_density(ppdens(:, :, ikind), atomic_kind, qs_kind, ngto, &
2070 4 : iunit=output_unit, confine=.TRUE.)
2071 : CALL calculate_atomic_density(aedens(:, :, ikind), atomic_kind, qs_kind, ngto, &
2072 4 : iunit=output_unit, allelectron=.TRUE., confine=.TRUE.)
2073 52 : ccdens(:, 1, ikind) = aedens(:, 1, ikind)
2074 52 : ccdens(:, 2, ikind) = 0._dp
2075 : CALL project_function_a(ccdens(1:ngto, 2, ikind), ccdens(1:ngto, 1, ikind), &
2076 4 : ppdens(1:ngto, 2, ikind), ppdens(1:ngto, 1, ikind), 0)
2077 52 : ccdens(:, 2, ikind) = aedens(:, 2, ikind) - ccdens(:, 2, ikind)
2078 4 : IF (unit_nr > 0) THEN
2079 2 : WRITE (unit_nr, FMT="(I6,A10,A20)") ikind, TRIM(element_symbol), TRIM(name)
2080 2 : WRITE (unit_nr, FMT="(I6)") ngto
2081 2 : WRITE (unit_nr, *) " Total density"
2082 26 : WRITE (unit_nr, FMT="(2G24.12)") (aedens(i, 1, ikind), aedens(i, 2, ikind), i=1, ngto)
2083 2 : WRITE (unit_nr, *) " Core density"
2084 26 : WRITE (unit_nr, FMT="(2G24.12)") (ccdens(i, 1, ikind), ccdens(i, 2, ikind), i=1, ngto)
2085 : END IF
2086 6 : NULLIFY (atomic_kind)
2087 : END DO
2088 :
2089 2 : IF (dft_control%qs_control%gapw) THEN
2090 2 : CALL get_qs_env(qs_env=qs_env, rho_atom_set=rho_atom_set)
2091 :
2092 2 : IF (unit_nr > 0) THEN
2093 1 : WRITE (unit_nr, *) "Coordinates and GAPW density"
2094 : END IF
2095 2 : np = particles%n_els
2096 6 : DO iat = 1, np
2097 4 : CALL get_atomic_kind(particles%els(iat)%atomic_kind, kind_number=ikind)
2098 4 : CALL get_qs_kind(qs_kind_set(ikind), grid_atom=grid_atom)
2099 4 : rho_atom => rho_atom_set(iat)
2100 4 : IF (ASSOCIATED(rho_atom%rho_rad_h(1)%r_coef)) THEN
2101 2 : nr = SIZE(rho_atom%rho_rad_h(1)%r_coef, 1)
2102 2 : niso = SIZE(rho_atom%rho_rad_h(1)%r_coef, 2)
2103 : ELSE
2104 2 : nr = 0
2105 2 : niso = 0
2106 : END IF
2107 4 : CALL para_env%sum(nr)
2108 4 : CALL para_env%sum(niso)
2109 :
2110 16 : ALLOCATE (bfun(nr, niso))
2111 1840 : bfun = 0._dp
2112 8 : DO ispin = 1, dft_control%nspins
2113 8 : IF (ASSOCIATED(rho_atom%rho_rad_h(1)%r_coef)) THEN
2114 920 : bfun(:, :) = bfun + rho_atom%rho_rad_h(ispin)%r_coef - rho_atom%rho_rad_s(ispin)%r_coef
2115 : END IF
2116 : END DO
2117 4 : CALL para_env%sum(bfun)
2118 52 : ccdens(:, 1, ikind) = ppdens(:, 1, ikind)
2119 52 : ccdens(:, 2, ikind) = 0._dp
2120 4 : IF (unit_nr > 0) THEN
2121 8 : WRITE (unit_nr, '(I10,I5,3f12.6)') iat, ikind, particles%els(iat)%r
2122 : END IF
2123 40 : DO iso = 1, niso
2124 36 : l = indso(1, iso)
2125 36 : CALL project_function_b(ccdens(:, 2, ikind), ccdens(:, 1, ikind), bfun(:, iso), grid_atom, l)
2126 40 : IF (unit_nr > 0) THEN
2127 18 : WRITE (unit_nr, FMT="(3I6)") iso, l, ngto
2128 234 : WRITE (unit_nr, FMT="(2G24.12)") (ccdens(i, 1, ikind), ccdens(i, 2, ikind), i=1, ngto)
2129 : END IF
2130 : END DO
2131 10 : DEALLOCATE (bfun)
2132 : END DO
2133 : ELSE
2134 0 : IF (unit_nr > 0) THEN
2135 0 : WRITE (unit_nr, *) "Coordinates"
2136 0 : np = particles%n_els
2137 0 : DO iat = 1, np
2138 0 : CALL get_atomic_kind(particles%els(iat)%atomic_kind, kind_number=ikind)
2139 0 : WRITE (unit_nr, '(I10,I5,3f12.6)') iat, ikind, particles%els(iat)%r
2140 : END DO
2141 : END IF
2142 : END IF
2143 :
2144 2 : DEALLOCATE (ppdens, aedens, ccdens)
2145 :
2146 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2147 2 : "DFT%PRINT%E_DENSITY_CUBE")
2148 :
2149 : END IF
2150 150 : IF (dft_control%qs_control%gapw .AND. print_density == "TOTAL_DENSITY") THEN
2151 : ! total density in g-space not implemented for k-points
2152 4 : CPASSERT(.NOT. do_kpoints)
2153 : ! Print total electronic density
2154 : CALL get_qs_env(qs_env=qs_env, &
2155 4 : pw_env=pw_env)
2156 : CALL pw_env_get(pw_env=pw_env, &
2157 : auxbas_pw_pool=auxbas_pw_pool, &
2158 4 : pw_pools=pw_pools)
2159 4 : CALL auxbas_pw_pool%create_pw(pw=rho_elec_rspace)
2160 4 : CALL pw_zero(rho_elec_rspace)
2161 4 : CALL auxbas_pw_pool%create_pw(pw=rho_elec_gspace)
2162 4 : CALL pw_zero(rho_elec_gspace)
2163 : CALL get_pw_grid_info(pw_grid=rho_elec_gspace%pw_grid, &
2164 : dr=dr, &
2165 4 : vol=volume)
2166 16 : q_max = SQRT(SUM((pi/dr(:))**2))
2167 : CALL calculate_rhotot_elec_gspace(qs_env=qs_env, &
2168 : auxbas_pw_pool=auxbas_pw_pool, &
2169 : rhotot_elec_gspace=rho_elec_gspace, &
2170 : q_max=q_max, &
2171 : rho_hard=rho_hard, &
2172 4 : rho_soft=rho_soft)
2173 4 : rho_total = rho_hard + rho_soft
2174 : CALL get_pw_grid_info(pw_grid=rho_elec_gspace%pw_grid, &
2175 4 : vol=volume)
2176 : ! rhotot pw coefficients are by default scaled by grid volume
2177 : ! need to undo this to get proper charge from printed cube
2178 4 : CALL pw_scale(rho_elec_gspace, 1.0_dp/volume)
2179 :
2180 4 : CALL pw_transfer(rho_elec_gspace, rho_elec_rspace)
2181 4 : rho_total_rspace = pw_integrate_function(rho_elec_rspace, isign=-1)
2182 4 : filename = "TOTAL_ELECTRON_DENSITY"
2183 4 : mpi_io = .TRUE.
2184 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2185 : extension=".cube", middle_name=TRIM(filename), &
2186 : file_position=my_pos_cube, log_filename=.FALSE., mpi_io=mpi_io, &
2187 4 : fout=mpi_filename)
2188 4 : IF (output_unit > 0) THEN
2189 2 : IF (.NOT. mpi_io) THEN
2190 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
2191 : ELSE
2192 2 : filename = mpi_filename
2193 : END IF
2194 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2195 2 : "The total electron density is written in cube file format to the file:", &
2196 4 : TRIM(filename)
2197 : WRITE (UNIT=output_unit, FMT="(/,(T2,A,F20.10))") &
2198 2 : "q(max) [1/Angstrom] :", q_max/angstrom, &
2199 2 : "Soft electronic charge (G-space) :", rho_soft, &
2200 2 : "Hard electronic charge (G-space) :", rho_hard, &
2201 2 : "Total electronic charge (G-space):", rho_total, &
2202 4 : "Total electronic charge (R-space):", rho_total_rspace
2203 : END IF
2204 : CALL cp_pw_to_cube(rho_elec_rspace, unit_nr, "TOTAL ELECTRON DENSITY", &
2205 : particles=particles, zeff=zcharge, &
2206 4 : stride=section_get_ivals(dft_section, "PRINT%E_DENSITY_CUBE%STRIDE"), mpi_io=mpi_io)
2207 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2208 4 : "DFT%PRINT%E_DENSITY_CUBE", mpi_io=mpi_io)
2209 : ! Print total spin density for spin-polarized systems
2210 4 : IF (dft_control%nspins > 1) THEN
2211 2 : CALL pw_zero(rho_elec_gspace)
2212 2 : CALL pw_zero(rho_elec_rspace)
2213 : CALL calculate_rhotot_elec_gspace(qs_env=qs_env, &
2214 : auxbas_pw_pool=auxbas_pw_pool, &
2215 : rhotot_elec_gspace=rho_elec_gspace, &
2216 : q_max=q_max, &
2217 : rho_hard=rho_hard, &
2218 : rho_soft=rho_soft, &
2219 2 : fsign=-1.0_dp)
2220 2 : rho_total = rho_hard + rho_soft
2221 :
2222 : ! rhotot pw coefficients are by default scaled by grid volume
2223 : ! need to undo this to get proper charge from printed cube
2224 2 : CALL pw_scale(rho_elec_gspace, 1.0_dp/volume)
2225 :
2226 2 : CALL pw_transfer(rho_elec_gspace, rho_elec_rspace)
2227 2 : rho_total_rspace = pw_integrate_function(rho_elec_rspace, isign=-1)
2228 2 : filename = "TOTAL_SPIN_DENSITY"
2229 2 : mpi_io = .TRUE.
2230 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2231 : extension=".cube", middle_name=TRIM(filename), &
2232 : file_position=my_pos_cube, log_filename=.FALSE., mpi_io=mpi_io, &
2233 2 : fout=mpi_filename)
2234 2 : IF (output_unit > 0) THEN
2235 1 : IF (.NOT. mpi_io) THEN
2236 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
2237 : ELSE
2238 1 : filename = mpi_filename
2239 : END IF
2240 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2241 1 : "The total spin density is written in cube file format to the file:", &
2242 2 : TRIM(filename)
2243 : WRITE (UNIT=output_unit, FMT="(/,(T2,A,F20.10))") &
2244 1 : "q(max) [1/Angstrom] :", q_max/angstrom, &
2245 1 : "Soft part of the spin density (G-space):", rho_soft, &
2246 1 : "Hard part of the spin density (G-space):", rho_hard, &
2247 1 : "Total spin density (G-space) :", rho_total, &
2248 2 : "Total spin density (R-space) :", rho_total_rspace
2249 : END IF
2250 : CALL cp_pw_to_cube(rho_elec_rspace, unit_nr, "TOTAL SPIN DENSITY", &
2251 : particles=particles, zeff=zcharge, &
2252 2 : stride=section_get_ivals(dft_section, "PRINT%E_DENSITY_CUBE%STRIDE"), mpi_io=mpi_io)
2253 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2254 2 : "DFT%PRINT%E_DENSITY_CUBE", mpi_io=mpi_io)
2255 : END IF
2256 4 : CALL auxbas_pw_pool%give_back_pw(rho_elec_gspace)
2257 4 : CALL auxbas_pw_pool%give_back_pw(rho_elec_rspace)
2258 :
2259 146 : ELSE IF (print_density == "SOFT_DENSITY" .OR. .NOT. dft_control%qs_control%gapw) THEN
2260 142 : IF (dft_control%nspins > 1) THEN
2261 : CALL get_qs_env(qs_env=qs_env, &
2262 48 : pw_env=pw_env)
2263 : CALL pw_env_get(pw_env=pw_env, &
2264 : auxbas_pw_pool=auxbas_pw_pool, &
2265 48 : pw_pools=pw_pools)
2266 48 : CALL auxbas_pw_pool%create_pw(pw=rho_elec_rspace)
2267 48 : CALL pw_copy(rho_r(1), rho_elec_rspace)
2268 48 : CALL pw_axpy(rho_r(2), rho_elec_rspace)
2269 48 : filename = "ELECTRON_DENSITY"
2270 48 : mpi_io = .TRUE.
2271 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2272 : extension=".cube", middle_name=TRIM(filename), &
2273 : file_position=my_pos_cube, log_filename=.FALSE., mpi_io=mpi_io, &
2274 48 : fout=mpi_filename)
2275 48 : IF (output_unit > 0) THEN
2276 24 : IF (.NOT. mpi_io) THEN
2277 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
2278 : ELSE
2279 24 : filename = mpi_filename
2280 : END IF
2281 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2282 24 : "The sum of alpha and beta density is written in cube file format to the file:", &
2283 48 : TRIM(filename)
2284 : END IF
2285 : CALL cp_pw_to_cube(rho_elec_rspace, unit_nr, "SUM OF ALPHA AND BETA DENSITY", &
2286 : particles=particles, zeff=zcharge, &
2287 : stride=section_get_ivals(dft_section, "PRINT%E_DENSITY_CUBE%STRIDE"), &
2288 48 : mpi_io=mpi_io)
2289 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2290 48 : "DFT%PRINT%E_DENSITY_CUBE", mpi_io=mpi_io)
2291 48 : CALL pw_copy(rho_r(1), rho_elec_rspace)
2292 48 : CALL pw_axpy(rho_r(2), rho_elec_rspace, alpha=-1.0_dp)
2293 48 : filename = "SPIN_DENSITY"
2294 48 : mpi_io = .TRUE.
2295 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2296 : extension=".cube", middle_name=TRIM(filename), &
2297 : file_position=my_pos_cube, log_filename=.FALSE., mpi_io=mpi_io, &
2298 48 : fout=mpi_filename)
2299 48 : IF (output_unit > 0) THEN
2300 24 : IF (.NOT. mpi_io) THEN
2301 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
2302 : ELSE
2303 24 : filename = mpi_filename
2304 : END IF
2305 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2306 24 : "The spin density is written in cube file format to the file:", &
2307 48 : TRIM(filename)
2308 : END IF
2309 : CALL cp_pw_to_cube(rho_elec_rspace, unit_nr, "SPIN DENSITY", &
2310 : particles=particles, zeff=zcharge, &
2311 48 : stride=section_get_ivals(dft_section, "PRINT%E_DENSITY_CUBE%STRIDE"), mpi_io=mpi_io)
2312 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2313 48 : "DFT%PRINT%E_DENSITY_CUBE", mpi_io=mpi_io)
2314 48 : CALL auxbas_pw_pool%give_back_pw(rho_elec_rspace)
2315 : ELSE
2316 94 : filename = "ELECTRON_DENSITY"
2317 94 : mpi_io = .TRUE.
2318 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2319 : extension=".cube", middle_name=TRIM(filename), &
2320 : file_position=my_pos_cube, log_filename=.FALSE., mpi_io=mpi_io, &
2321 94 : fout=mpi_filename)
2322 94 : IF (output_unit > 0) THEN
2323 47 : IF (.NOT. mpi_io) THEN
2324 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
2325 : ELSE
2326 47 : filename = mpi_filename
2327 : END IF
2328 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2329 47 : "The electron density is written in cube file format to the file:", &
2330 94 : TRIM(filename)
2331 : END IF
2332 : CALL cp_pw_to_cube(rho_r(1), unit_nr, "ELECTRON DENSITY", &
2333 : particles=particles, zeff=zcharge, &
2334 94 : stride=section_get_ivals(dft_section, "PRINT%E_DENSITY_CUBE%STRIDE"), mpi_io=mpi_io)
2335 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2336 94 : "DFT%PRINT%E_DENSITY_CUBE", mpi_io=mpi_io)
2337 : END IF ! nspins
2338 :
2339 4 : ELSE IF (dft_control%qs_control%gapw .AND. print_density == "TOTAL_HARD_APPROX") THEN
2340 4 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env, rho0_mpole=rho0_mpole, natom=natom)
2341 4 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool, pw_pools=pw_pools)
2342 4 : CALL auxbas_pw_pool%create_pw(rho_elec_rspace)
2343 :
2344 4 : NULLIFY (my_Q0)
2345 12 : ALLOCATE (my_Q0(natom))
2346 16 : my_Q0 = 0.0_dp
2347 :
2348 : ! (eta/pi)**3: normalization for 3d gaussian of form exp(-eta*r**2)
2349 4 : norm_factor = SQRT((rho0_mpole%zet0_h/pi)**3)
2350 :
2351 : ! store hard part of electronic density in array
2352 16 : DO iat = 1, natom
2353 34 : my_Q0(iat) = SUM(rho0_mpole%mp_rho(iat)%Q0(1:dft_control%nspins))*norm_factor
2354 : END DO
2355 : ! multiply coeff with gaussian and put on realspace grid
2356 : ! coeff is the gaussian prefactor, eta the gaussian exponent
2357 4 : CALL calculate_rho_resp_all(rho_elec_rspace, coeff=my_Q0, natom=natom, eta=rho0_mpole%zet0_h, qs_env=qs_env)
2358 4 : rho_hard = pw_integrate_function(rho_elec_rspace, isign=-1)
2359 :
2360 4 : rho_soft = 0.0_dp
2361 10 : DO ispin = 1, dft_control%nspins
2362 6 : CALL pw_axpy(rho_r(ispin), rho_elec_rspace)
2363 10 : rho_soft = rho_soft + pw_integrate_function(rho_r(ispin), isign=-1)
2364 : END DO
2365 :
2366 4 : rho_total_rspace = rho_soft + rho_hard
2367 :
2368 4 : filename = "ELECTRON_DENSITY"
2369 4 : mpi_io = .TRUE.
2370 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2371 : extension=".cube", middle_name=TRIM(filename), &
2372 : file_position=my_pos_cube, log_filename=.FALSE., mpi_io=mpi_io, &
2373 4 : fout=mpi_filename)
2374 4 : IF (output_unit > 0) THEN
2375 2 : IF (.NOT. mpi_io) THEN
2376 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
2377 : ELSE
2378 2 : filename = mpi_filename
2379 : END IF
2380 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2381 2 : "The electron density is written in cube file format to the file:", &
2382 4 : TRIM(filename)
2383 : WRITE (UNIT=output_unit, FMT="(/,(T2,A,F20.10))") &
2384 2 : "Soft electronic charge (R-space) :", rho_soft, &
2385 2 : "Hard electronic charge (R-space) :", rho_hard, &
2386 4 : "Total electronic charge (R-space):", rho_total_rspace
2387 : END IF
2388 : CALL cp_pw_to_cube(rho_elec_rspace, unit_nr, "ELECTRON DENSITY", &
2389 : particles=particles, zeff=zcharge, &
2390 : stride=section_get_ivals(dft_section, "PRINT%E_DENSITY_CUBE%STRIDE"), &
2391 4 : mpi_io=mpi_io)
2392 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2393 4 : "DFT%PRINT%E_DENSITY_CUBE", mpi_io=mpi_io)
2394 :
2395 : !------------
2396 4 : IF (dft_control%nspins > 1) THEN
2397 8 : DO iat = 1, natom
2398 8 : my_Q0(iat) = (rho0_mpole%mp_rho(iat)%Q0(1) - rho0_mpole%mp_rho(iat)%Q0(2))*norm_factor
2399 : END DO
2400 2 : CALL pw_zero(rho_elec_rspace)
2401 2 : CALL calculate_rho_resp_all(rho_elec_rspace, coeff=my_Q0, natom=natom, eta=rho0_mpole%zet0_h, qs_env=qs_env)
2402 2 : rho_hard = pw_integrate_function(rho_elec_rspace, isign=-1)
2403 :
2404 2 : CALL pw_axpy(rho_r(1), rho_elec_rspace)
2405 2 : CALL pw_axpy(rho_r(2), rho_elec_rspace, alpha=-1.0_dp)
2406 : rho_soft = pw_integrate_function(rho_r(1), isign=-1) &
2407 2 : - pw_integrate_function(rho_r(2), isign=-1)
2408 :
2409 2 : rho_total_rspace = rho_soft + rho_hard
2410 :
2411 2 : filename = "SPIN_DENSITY"
2412 2 : mpi_io = .TRUE.
2413 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%E_DENSITY_CUBE", &
2414 : extension=".cube", middle_name=TRIM(filename), &
2415 : file_position=my_pos_cube, log_filename=.FALSE., mpi_io=mpi_io, &
2416 2 : fout=mpi_filename)
2417 2 : IF (output_unit > 0) THEN
2418 1 : IF (.NOT. mpi_io) THEN
2419 0 : INQUIRE (UNIT=unit_nr, NAME=filename)
2420 : ELSE
2421 1 : filename = mpi_filename
2422 : END IF
2423 : WRITE (UNIT=output_unit, FMT="(/,T2,A,/,/,T2,A)") &
2424 1 : "The spin density is written in cube file format to the file:", &
2425 2 : TRIM(filename)
2426 : WRITE (UNIT=output_unit, FMT="(/,(T2,A,F20.10))") &
2427 1 : "Soft part of the spin density :", rho_soft, &
2428 1 : "Hard part of the spin density :", rho_hard, &
2429 2 : "Total spin density (R-space) :", rho_total_rspace
2430 : END IF
2431 : CALL cp_pw_to_cube(rho_elec_rspace, unit_nr, "SPIN DENSITY", &
2432 : particles=particles, zeff=zcharge, &
2433 2 : stride=section_get_ivals(dft_section, "PRINT%E_DENSITY_CUBE%STRIDE"), mpi_io=mpi_io)
2434 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2435 2 : "DFT%PRINT%E_DENSITY_CUBE", mpi_io=mpi_io)
2436 : END IF ! nspins
2437 4 : CALL auxbas_pw_pool%give_back_pw(rho_elec_rspace)
2438 4 : DEALLOCATE (my_Q0)
2439 : END IF ! print_density
2440 : END IF ! print key
2441 :
2442 : IF (BTEST(cp_print_key_should_output(logger%iter_info, &
2443 11297 : dft_section, "PRINT%ENERGY_WINDOWS"), cp_p_file) .AND. .NOT. do_kpoints) THEN
2444 90 : CALL energy_windows(qs_env)
2445 : END IF
2446 :
2447 : ! Print the hartree potential
2448 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
2449 : "DFT%PRINT%V_HARTREE_CUBE"), cp_p_file)) THEN
2450 :
2451 : CALL get_qs_env(qs_env=qs_env, &
2452 : pw_env=pw_env, &
2453 114 : v_hartree_rspace=v_hartree_rspace)
2454 114 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool)
2455 114 : CALL auxbas_pw_pool%create_pw(aux_r)
2456 :
2457 114 : append_cube = section_get_lval(input, "DFT%PRINT%V_HARTREE_CUBE%APPEND")
2458 114 : my_pos_cube = "REWIND"
2459 114 : IF (append_cube) THEN
2460 0 : my_pos_cube = "APPEND"
2461 : END IF
2462 114 : mpi_io = .TRUE.
2463 114 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env)
2464 114 : CALL pw_env_get(pw_env)
2465 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%V_HARTREE_CUBE", &
2466 114 : extension=".cube", middle_name="v_hartree", file_position=my_pos_cube, mpi_io=mpi_io)
2467 114 : udvol = 1.0_dp/v_hartree_rspace%pw_grid%dvol
2468 :
2469 114 : CALL pw_copy(v_hartree_rspace, aux_r)
2470 114 : CALL pw_scale(aux_r, udvol)
2471 :
2472 : CALL cp_pw_to_cube(aux_r, unit_nr, "HARTREE POTENTIAL", particles=particles, zeff=zcharge, &
2473 : stride=section_get_ivals(dft_section, &
2474 114 : "PRINT%V_HARTREE_CUBE%STRIDE"), mpi_io=mpi_io)
2475 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2476 114 : "DFT%PRINT%V_HARTREE_CUBE", mpi_io=mpi_io)
2477 :
2478 114 : CALL auxbas_pw_pool%give_back_pw(aux_r)
2479 : END IF
2480 :
2481 : ! Print the external potential
2482 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
2483 : "DFT%PRINT%EXTERNAL_POTENTIAL_CUBE"), cp_p_file)) THEN
2484 86 : IF (dft_control%apply_external_potential) THEN
2485 4 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env, vee=vee)
2486 4 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool)
2487 4 : CALL auxbas_pw_pool%create_pw(aux_r)
2488 :
2489 4 : append_cube = section_get_lval(input, "DFT%PRINT%EXTERNAL_POTENTIAL_CUBE%APPEND")
2490 4 : my_pos_cube = "REWIND"
2491 4 : IF (append_cube) THEN
2492 0 : my_pos_cube = "APPEND"
2493 : END IF
2494 4 : mpi_io = .TRUE.
2495 4 : CALL pw_env_get(pw_env)
2496 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%EXTERNAL_POTENTIAL_CUBE", &
2497 4 : extension=".cube", middle_name="ext_pot", file_position=my_pos_cube, mpi_io=mpi_io)
2498 :
2499 4 : CALL pw_copy(vee, aux_r)
2500 :
2501 : CALL cp_pw_to_cube(aux_r, unit_nr, "EXTERNAL POTENTIAL", particles=particles, zeff=zcharge, &
2502 : stride=section_get_ivals(dft_section, &
2503 4 : "PRINT%EXTERNAL_POTENTIAL_CUBE%STRIDE"), mpi_io=mpi_io)
2504 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2505 4 : "DFT%PRINT%EXTERNAL_POTENTIAL_CUBE", mpi_io=mpi_io)
2506 :
2507 4 : CALL auxbas_pw_pool%give_back_pw(aux_r)
2508 : END IF
2509 : END IF
2510 :
2511 : ! Print the Electrical Field Components
2512 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
2513 : "DFT%PRINT%EFIELD_CUBE"), cp_p_file)) THEN
2514 :
2515 82 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env)
2516 82 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool)
2517 82 : CALL auxbas_pw_pool%create_pw(aux_r)
2518 82 : CALL auxbas_pw_pool%create_pw(aux_g)
2519 :
2520 82 : append_cube = section_get_lval(input, "DFT%PRINT%EFIELD_CUBE%APPEND")
2521 82 : my_pos_cube = "REWIND"
2522 82 : IF (append_cube) THEN
2523 0 : my_pos_cube = "APPEND"
2524 : END IF
2525 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env, &
2526 82 : v_hartree_rspace=v_hartree_rspace)
2527 82 : CALL pw_env_get(pw_env)
2528 82 : udvol = 1.0_dp/v_hartree_rspace%pw_grid%dvol
2529 328 : DO id = 1, 3
2530 246 : mpi_io = .TRUE.
2531 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%EFIELD_CUBE", &
2532 : extension=".cube", middle_name="efield_"//cdir(id), file_position=my_pos_cube, &
2533 246 : mpi_io=mpi_io)
2534 :
2535 246 : CALL pw_transfer(v_hartree_rspace, aux_g)
2536 246 : nd = 0
2537 246 : nd(id) = 1
2538 246 : CALL pw_derive(aux_g, nd)
2539 246 : CALL pw_transfer(aux_g, aux_r)
2540 246 : CALL pw_scale(aux_r, udvol)
2541 :
2542 : CALL cp_pw_to_cube(aux_r, &
2543 : unit_nr, "ELECTRIC FIELD", particles=particles, zeff=zcharge, &
2544 : stride=section_get_ivals(dft_section, &
2545 246 : "PRINT%EFIELD_CUBE%STRIDE"), mpi_io=mpi_io)
2546 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
2547 328 : "DFT%PRINT%EFIELD_CUBE", mpi_io=mpi_io)
2548 : END DO
2549 :
2550 82 : CALL auxbas_pw_pool%give_back_pw(aux_r)
2551 82 : CALL auxbas_pw_pool%give_back_pw(aux_g)
2552 : END IF
2553 :
2554 : ! Write cube files from the local energy
2555 11297 : CALL qs_scf_post_local_energy(input, logger, qs_env)
2556 :
2557 : ! Write cube files from the local stress tensor
2558 11297 : CALL qs_scf_post_local_stress(input, logger, qs_env)
2559 :
2560 : ! Write cube files from the implicit Poisson solver
2561 11297 : CALL qs_scf_post_ps_implicit(input, logger, qs_env)
2562 :
2563 : ! post SCF Transport
2564 11297 : CALL qs_scf_post_transport(qs_env)
2565 :
2566 11297 : CALL section_vals_val_get(input, "DFT%PRINT%AO_MATRICES%OMIT_HEADERS", l_val=omit_headers)
2567 : ! Write the density matrices
2568 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
2569 : "DFT%PRINT%AO_MATRICES/DENSITY"), cp_p_file)) THEN
2570 : iw = cp_print_key_unit_nr(logger, input, "DFT%PRINT%AO_MATRICES/DENSITY", &
2571 4 : extension=".Log")
2572 4 : CALL section_vals_val_get(input, "DFT%PRINT%AO_MATRICES%NDIGITS", i_val=after)
2573 4 : CALL qs_rho_get(rho, rho_ao_kp=rho_ao)
2574 4 : after = MIN(MAX(after, 1), 16)
2575 8 : DO ispin = 1, dft_control%nspins
2576 12 : DO img = 1, dft_control%nimages
2577 : CALL cp_dbcsr_write_sparse_matrix(rho_ao(ispin, img)%matrix, 4, after, qs_env, &
2578 8 : para_env, output_unit=iw, omit_headers=omit_headers)
2579 : END DO
2580 : END DO
2581 : CALL cp_print_key_finished_output(iw, logger, input, &
2582 4 : "DFT%PRINT%AO_MATRICES/DENSITY")
2583 : END IF
2584 :
2585 : ! Write the Kohn-Sham matrices
2586 : write_ks = BTEST(cp_print_key_should_output(logger%iter_info, input, &
2587 11297 : "DFT%PRINT%AO_MATRICES/KOHN_SHAM_MATRIX"), cp_p_file)
2588 : write_xc = BTEST(cp_print_key_should_output(logger%iter_info, input, &
2589 11297 : "DFT%PRINT%AO_MATRICES/MATRIX_VXC"), cp_p_file)
2590 : ! we need to update stuff before writing, potentially computing the matrix_vxc
2591 11297 : IF (write_ks .OR. write_xc) THEN
2592 4 : IF (write_xc) qs_env%requires_matrix_vxc = .TRUE.
2593 4 : CALL qs_ks_did_change(qs_env%ks_env, rho_changed=.TRUE.)
2594 : CALL qs_ks_update_qs_env(qs_env, calculate_forces=.FALSE., &
2595 4 : just_energy=.FALSE.)
2596 4 : IF (write_xc) qs_env%requires_matrix_vxc = .FALSE.
2597 : END IF
2598 :
2599 : ! Write the Kohn-Sham matrices
2600 11297 : IF (write_ks) THEN
2601 : iw = cp_print_key_unit_nr(logger, input, "DFT%PRINT%AO_MATRICES/KOHN_SHAM_MATRIX", &
2602 4 : extension=".Log")
2603 4 : CALL get_qs_env(qs_env=qs_env, matrix_ks_kp=ks_rmpv)
2604 4 : CALL section_vals_val_get(input, "DFT%PRINT%AO_MATRICES%NDIGITS", i_val=after)
2605 4 : after = MIN(MAX(after, 1), 16)
2606 8 : DO ispin = 1, dft_control%nspins
2607 12 : DO img = 1, dft_control%nimages
2608 : CALL cp_dbcsr_write_sparse_matrix(ks_rmpv(ispin, img)%matrix, 4, after, qs_env, &
2609 8 : para_env, output_unit=iw, omit_headers=omit_headers)
2610 : END DO
2611 : END DO
2612 : CALL cp_print_key_finished_output(iw, logger, input, &
2613 4 : "DFT%PRINT%AO_MATRICES/KOHN_SHAM_MATRIX")
2614 : END IF
2615 :
2616 : ! write csr matrices
2617 : ! matrices in terms of the PAO basis will be taken care of in pao_post_scf.
2618 11297 : IF (.NOT. dft_control%qs_control%pao) THEN
2619 10785 : CALL write_ks_matrix_csr(qs_env, input)
2620 10785 : CALL write_s_matrix_csr(qs_env, input)
2621 : END IF
2622 :
2623 : ! write adjacency matrix
2624 11297 : CALL write_adjacency_matrix(qs_env, input)
2625 :
2626 : ! Write the xc matrix
2627 11297 : IF (write_xc) THEN
2628 0 : CALL get_qs_env(qs_env=qs_env, matrix_vxc_kp=matrix_vxc)
2629 0 : CPASSERT(ASSOCIATED(matrix_vxc))
2630 : iw = cp_print_key_unit_nr(logger, input, "DFT%PRINT%AO_MATRICES/MATRIX_VXC", &
2631 0 : extension=".Log")
2632 0 : CALL section_vals_val_get(input, "DFT%PRINT%AO_MATRICES%NDIGITS", i_val=after)
2633 0 : after = MIN(MAX(after, 1), 16)
2634 0 : DO ispin = 1, dft_control%nspins
2635 0 : DO img = 1, dft_control%nimages
2636 : CALL cp_dbcsr_write_sparse_matrix(matrix_vxc(ispin, img)%matrix, 4, after, qs_env, &
2637 0 : para_env, output_unit=iw, omit_headers=omit_headers)
2638 : END DO
2639 : END DO
2640 : CALL cp_print_key_finished_output(iw, logger, input, &
2641 0 : "DFT%PRINT%AO_MATRICES/MATRIX_VXC")
2642 : END IF
2643 :
2644 : ! Write the [H,r] commutator matrices
2645 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
2646 : "DFT%PRINT%AO_MATRICES/COMMUTATOR_HR"), cp_p_file)) THEN
2647 : iw = cp_print_key_unit_nr(logger, input, "DFT%PRINT%AO_MATRICES/COMMUTATOR_HR", &
2648 0 : extension=".Log")
2649 0 : CALL section_vals_val_get(input, "DFT%PRINT%AO_MATRICES%NDIGITS", i_val=after)
2650 0 : NULLIFY (matrix_hr)
2651 0 : CALL build_com_hr_matrix(qs_env, matrix_hr)
2652 0 : after = MIN(MAX(after, 1), 16)
2653 0 : DO img = 1, 3
2654 : CALL cp_dbcsr_write_sparse_matrix(matrix_hr(img)%matrix, 4, after, qs_env, &
2655 0 : para_env, output_unit=iw, omit_headers=omit_headers)
2656 : END DO
2657 0 : CALL dbcsr_deallocate_matrix_set(matrix_hr)
2658 : CALL cp_print_key_finished_output(iw, logger, input, &
2659 0 : "DFT%PRINT%AO_MATRICES/COMMUTATOR_HR")
2660 : END IF
2661 :
2662 : ! Compute the Mulliken charges
2663 11297 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%MULLIKEN")
2664 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
2665 4790 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%MULLIKEN", extension=".mulliken", log_filename=.FALSE.)
2666 4790 : print_level = 1
2667 4790 : CALL section_vals_val_get(print_key, "PRINT_GOP", l_val=print_it)
2668 4790 : IF (print_it) print_level = 2
2669 4790 : CALL section_vals_val_get(print_key, "PRINT_ALL", l_val=print_it)
2670 4790 : IF (print_it) print_level = 3
2671 4790 : CALL mulliken_population_analysis(qs_env, unit_nr, print_level)
2672 4790 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%MULLIKEN")
2673 : END IF
2674 :
2675 : ! Compute the Hirshfeld charges
2676 11297 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%HIRSHFELD")
2677 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
2678 : ! we check if real space density is available
2679 4862 : NULLIFY (rho)
2680 4862 : CALL get_qs_env(qs_env=qs_env, rho=rho)
2681 4862 : CALL qs_rho_get(rho, rho_r_valid=rho_r_valid)
2682 4862 : IF (rho_r_valid) THEN
2683 4788 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%HIRSHFELD", extension=".hirshfeld", log_filename=.FALSE.)
2684 4788 : CALL hirshfeld_charges(qs_env, print_key, unit_nr)
2685 4788 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%HIRSHFELD")
2686 : END IF
2687 : END IF
2688 :
2689 : ! Compute EEQ charges
2690 11297 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%EEQ_CHARGES")
2691 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
2692 30 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%EEQ_CHARGES", extension=".eeq", log_filename=.FALSE.)
2693 30 : print_level = 1
2694 30 : CALL eeq_print(qs_env, unit_nr, print_level, ext=.FALSE.)
2695 30 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%MULLIKEN")
2696 : END IF
2697 :
2698 : ! Do a Voronoi Integration or write a compressed BQB File
2699 11297 : print_key_voro => section_vals_get_subs_vals(input, "DFT%PRINT%VORONOI")
2700 11297 : print_key_bqb => section_vals_get_subs_vals(input, "DFT%PRINT%E_DENSITY_BQB")
2701 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key_voro), cp_p_file)) THEN
2702 24 : should_print_voro = 1
2703 : ELSE
2704 11273 : should_print_voro = 0
2705 : END IF
2706 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key_bqb), cp_p_file)) THEN
2707 2 : should_print_bqb = 1
2708 : ELSE
2709 11295 : should_print_bqb = 0
2710 : END IF
2711 11297 : IF ((should_print_voro /= 0) .OR. (should_print_bqb /= 0)) THEN
2712 :
2713 : ! we check if real space density is available
2714 26 : NULLIFY (rho)
2715 26 : CALL get_qs_env(qs_env=qs_env, rho=rho)
2716 26 : CALL qs_rho_get(rho, rho_r_valid=rho_r_valid)
2717 26 : IF (rho_r_valid) THEN
2718 :
2719 26 : IF (dft_control%nspins > 1) THEN
2720 : CALL get_qs_env(qs_env=qs_env, &
2721 0 : pw_env=pw_env)
2722 : CALL pw_env_get(pw_env=pw_env, &
2723 : auxbas_pw_pool=auxbas_pw_pool, &
2724 0 : pw_pools=pw_pools)
2725 0 : NULLIFY (mb_rho)
2726 0 : ALLOCATE (mb_rho)
2727 0 : CALL auxbas_pw_pool%create_pw(pw=mb_rho)
2728 0 : CALL pw_copy(rho_r(1), mb_rho)
2729 0 : CALL pw_axpy(rho_r(2), mb_rho)
2730 : !CALL voronoi_analysis(qs_env, rho_elec_rspace, print_key, unit_nr)
2731 : ELSE
2732 26 : mb_rho => rho_r(1)
2733 : !CALL voronoi_analysis( qs_env, rho_r(1), print_key, unit_nr )
2734 : END IF ! nspins
2735 :
2736 26 : IF (should_print_voro /= 0) THEN
2737 24 : CALL section_vals_val_get(print_key_voro, "OUTPUT_TEXT", l_val=voro_print_txt)
2738 24 : IF (voro_print_txt) THEN
2739 24 : append_voro = section_get_lval(input, "DFT%PRINT%VORONOI%APPEND")
2740 24 : my_pos_voro = "REWIND"
2741 24 : IF (append_voro) THEN
2742 0 : my_pos_voro = "APPEND"
2743 : END IF
2744 : unit_nr_voro = cp_print_key_unit_nr(logger, input, "DFT%PRINT%VORONOI", extension=".voronoi", &
2745 24 : file_position=my_pos_voro, log_filename=.FALSE.)
2746 : ELSE
2747 0 : unit_nr_voro = 0
2748 : END IF
2749 : ELSE
2750 2 : unit_nr_voro = 0
2751 : END IF
2752 :
2753 : CALL entry_voronoi_or_bqb(should_print_voro, should_print_bqb, print_key_voro, print_key_bqb, &
2754 26 : unit_nr_voro, qs_env, mb_rho)
2755 :
2756 26 : IF (dft_control%nspins > 1) THEN
2757 0 : CALL auxbas_pw_pool%give_back_pw(mb_rho)
2758 0 : DEALLOCATE (mb_rho)
2759 : END IF
2760 :
2761 26 : IF (unit_nr_voro > 0) THEN
2762 12 : CALL cp_print_key_finished_output(unit_nr_voro, logger, input, "DFT%PRINT%VORONOI")
2763 : END IF
2764 :
2765 : END IF
2766 : END IF
2767 :
2768 : ! MAO analysis
2769 11297 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%MAO_ANALYSIS")
2770 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
2771 38 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%MAO_ANALYSIS", extension=".mao", log_filename=.FALSE.)
2772 38 : CALL mao_analysis(qs_env, print_key, unit_nr)
2773 38 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%MAO_ANALYSIS")
2774 : END IF
2775 :
2776 : ! MINBAS analysis
2777 11297 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%MINBAS_ANALYSIS")
2778 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
2779 28 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%MINBAS_ANALYSIS", extension=".mao", log_filename=.FALSE.)
2780 28 : CALL minbas_analysis(qs_env, print_key, unit_nr)
2781 28 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%MINBAS_ANALYSIS")
2782 : END IF
2783 :
2784 : ! IAO analysis
2785 11297 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%IAO_ANALYSIS")
2786 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
2787 32 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%IAO_ANALYSIS", extension=".iao", log_filename=.FALSE.)
2788 32 : CALL iao_read_input(iao_env, print_key, cell)
2789 32 : IF (iao_env%do_iao) THEN
2790 4 : CALL iao_wfn_analysis(qs_env, iao_env, unit_nr)
2791 : END IF
2792 32 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%IAO_ANALYSIS")
2793 : END IF
2794 :
2795 : ! Energy Decomposition Analysis
2796 11297 : print_key => section_vals_get_subs_vals(input, "DFT%PRINT%ENERGY_DECOMPOSITION_ANALYSIS")
2797 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, print_key), cp_p_file)) THEN
2798 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%ENERGY_DECOMPOSITION_ANALYSIS", &
2799 58 : extension=".mao", log_filename=.FALSE.)
2800 58 : CALL edmf_analysis(qs_env, print_key, unit_nr)
2801 58 : CALL cp_print_key_finished_output(unit_nr, logger, input, "DFT%PRINT%ENERGY_DECOMPOSITION_ANALYSIS")
2802 : END IF
2803 :
2804 : ! Print the density in the RI-HFX basis
2805 11297 : hfx_section => section_vals_get_subs_vals(input, "DFT%XC%HF")
2806 11297 : CALL section_vals_get(hfx_section, explicit=do_hfx)
2807 11297 : CALL section_vals_get(hfx_section, n_repetition=n_rep_hf)
2808 11297 : IF (do_hfx) THEN
2809 4526 : DO i = 1, n_rep_hf
2810 4526 : IF (qs_env%x_data(i, 1)%do_hfx_ri) CALL print_ri_hfx(qs_env%x_data(i, 1)%ri_data, qs_env)
2811 : END DO
2812 : END IF
2813 :
2814 11297 : DEALLOCATE (zcharge)
2815 :
2816 11297 : CALL timestop(handle)
2817 :
2818 45188 : END SUBROUTINE write_mo_free_results
2819 :
2820 : ! **************************************************************************************************
2821 : !> \brief Calculates Hirshfeld charges
2822 : !> \param qs_env the qs_env where to calculate the charges
2823 : !> \param input_section the input section for Hirshfeld charges
2824 : !> \param unit_nr the output unit number
2825 : ! **************************************************************************************************
2826 4788 : SUBROUTINE hirshfeld_charges(qs_env, input_section, unit_nr)
2827 : TYPE(qs_environment_type), POINTER :: qs_env
2828 : TYPE(section_vals_type), POINTER :: input_section
2829 : INTEGER, INTENT(IN) :: unit_nr
2830 :
2831 : INTEGER :: i, iat, ikind, natom, nkind, nspin, &
2832 : radius_type, refc, shapef
2833 4788 : INTEGER, DIMENSION(:), POINTER :: atom_list
2834 : LOGICAL :: do_radius, do_sc, paw_atom
2835 : REAL(KIND=dp) :: zeff
2836 4788 : REAL(KIND=dp), DIMENSION(:), POINTER :: radii
2837 4788 : REAL(KIND=dp), DIMENSION(:, :), POINTER :: charges
2838 4788 : TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
2839 : TYPE(atomic_kind_type), POINTER :: atomic_kind
2840 4788 : TYPE(dbcsr_p_type), DIMENSION(:, :), POINTER :: matrix_p, matrix_s
2841 : TYPE(dft_control_type), POINTER :: dft_control
2842 : TYPE(hirshfeld_type), POINTER :: hirshfeld_env
2843 : TYPE(mp_para_env_type), POINTER :: para_env
2844 4788 : TYPE(mpole_rho_atom), DIMENSION(:), POINTER :: mp_rho
2845 4788 : TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
2846 4788 : TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
2847 : TYPE(qs_rho_type), POINTER :: rho
2848 : TYPE(rho0_mpole_type), POINTER :: rho0_mpole
2849 :
2850 4788 : NULLIFY (hirshfeld_env)
2851 4788 : NULLIFY (radii)
2852 4788 : CALL create_hirshfeld_type(hirshfeld_env)
2853 : !
2854 4788 : CALL get_qs_env(qs_env, nkind=nkind, natom=natom)
2855 14364 : ALLOCATE (hirshfeld_env%charges(natom))
2856 : ! input options
2857 4788 : CALL section_vals_val_get(input_section, "SELF_CONSISTENT", l_val=do_sc)
2858 4788 : CALL section_vals_val_get(input_section, "USER_RADIUS", l_val=do_radius)
2859 4788 : CALL section_vals_val_get(input_section, "SHAPE_FUNCTION", i_val=shapef)
2860 4788 : CALL section_vals_val_get(input_section, "REFERENCE_CHARGE", i_val=refc)
2861 4788 : IF (do_radius) THEN
2862 0 : radius_type = radius_user
2863 0 : CALL section_vals_val_get(input_section, "ATOMIC_RADII", r_vals=radii)
2864 0 : IF (.NOT. SIZE(radii) == nkind) &
2865 : CALL cp_abort(__LOCATION__, &
2866 : "Length of keyword HIRSHFELD\ATOMIC_RADII does not "// &
2867 0 : "match number of atomic kinds in the input coordinate file.")
2868 : ELSE
2869 4788 : radius_type = radius_covalent
2870 : END IF
2871 : CALL set_hirshfeld_info(hirshfeld_env, shape_function_type=shapef, &
2872 : iterative=do_sc, ref_charge=refc, &
2873 4788 : radius_type=radius_type)
2874 : ! shape function
2875 4788 : CALL get_qs_env(qs_env, qs_kind_set=qs_kind_set, atomic_kind_set=atomic_kind_set)
2876 : CALL create_shape_function(hirshfeld_env, qs_kind_set, atomic_kind_set, &
2877 4788 : radii_list=radii)
2878 : ! reference charges
2879 4788 : CALL get_qs_env(qs_env, rho=rho)
2880 4788 : CALL qs_rho_get(rho, rho_ao_kp=matrix_p)
2881 4788 : nspin = SIZE(matrix_p, 1)
2882 19152 : ALLOCATE (charges(natom, nspin))
2883 4776 : SELECT CASE (refc)
2884 : CASE (ref_charge_atomic)
2885 13082 : DO ikind = 1, nkind
2886 8306 : CALL get_qs_kind(qs_kind_set(ikind), zeff=zeff)
2887 8306 : atomic_kind => atomic_kind_set(ikind)
2888 8306 : CALL get_atomic_kind(atomic_kind, atom_list=atom_list)
2889 41372 : DO iat = 1, SIZE(atom_list)
2890 19984 : i = atom_list(iat)
2891 28290 : hirshfeld_env%charges(i) = zeff
2892 : END DO
2893 : END DO
2894 : CASE (ref_charge_mulliken)
2895 12 : CALL get_qs_env(qs_env, matrix_s_kp=matrix_s, para_env=para_env)
2896 12 : CALL mulliken_charges(matrix_p, matrix_s, para_env, charges)
2897 48 : DO iat = 1, natom
2898 108 : hirshfeld_env%charges(iat) = SUM(charges(iat, :))
2899 : END DO
2900 : CASE DEFAULT
2901 4788 : CPABORT("Unknown type of reference charge for Hirshfeld partitioning.")
2902 : END SELECT
2903 : !
2904 33308 : charges = 0.0_dp
2905 4788 : IF (hirshfeld_env%iterative) THEN
2906 : ! Hirshfeld-I charges
2907 22 : CALL comp_hirshfeld_i_charges(qs_env, hirshfeld_env, charges, unit_nr)
2908 : ELSE
2909 : ! Hirshfeld charges
2910 4766 : CALL comp_hirshfeld_charges(qs_env, hirshfeld_env, charges)
2911 : END IF
2912 4788 : CALL get_qs_env(qs_env, particle_set=particle_set, dft_control=dft_control)
2913 4788 : IF (dft_control%qs_control%gapw) THEN
2914 : ! GAPW: add core charges (rho_hard - rho_soft)
2915 696 : CALL get_qs_env(qs_env, rho0_mpole=rho0_mpole)
2916 696 : CALL get_rho0_mpole(rho0_mpole, mp_rho=mp_rho)
2917 3084 : DO iat = 1, natom
2918 2388 : atomic_kind => particle_set(iat)%atomic_kind
2919 2388 : CALL get_atomic_kind(atomic_kind, kind_number=ikind)
2920 2388 : CALL get_qs_kind(qs_kind_set(ikind), paw_atom=paw_atom)
2921 3084 : IF (paw_atom) THEN
2922 4570 : charges(iat, 1:nspin) = charges(iat, 1:nspin) + mp_rho(iat)%q0(1:nspin)
2923 : END IF
2924 : END DO
2925 : END IF
2926 : !
2927 4788 : IF (unit_nr > 0) THEN
2928 : CALL write_hirshfeld_charges(charges, hirshfeld_env, particle_set, &
2929 2408 : qs_kind_set, unit_nr)
2930 : END IF
2931 : ! Save the charges to the results under the tag [HIRSHFELD-CHARGES]
2932 4788 : CALL save_hirshfeld_charges(charges, particle_set, qs_kind_set, qs_env)
2933 : !
2934 4788 : CALL release_hirshfeld_type(hirshfeld_env)
2935 4788 : DEALLOCATE (charges)
2936 :
2937 9576 : END SUBROUTINE hirshfeld_charges
2938 :
2939 : ! **************************************************************************************************
2940 : !> \brief ...
2941 : !> \param ca ...
2942 : !> \param a ...
2943 : !> \param cb ...
2944 : !> \param b ...
2945 : !> \param l ...
2946 : ! **************************************************************************************************
2947 4 : SUBROUTINE project_function_a(ca, a, cb, b, l)
2948 : ! project function cb on ca
2949 : REAL(KIND=dp), DIMENSION(:), INTENT(OUT) :: ca
2950 : REAL(KIND=dp), DIMENSION(:), INTENT(IN) :: a, cb, b
2951 : INTEGER, INTENT(IN) :: l
2952 :
2953 : INTEGER :: info, n
2954 4 : INTEGER, ALLOCATABLE, DIMENSION(:) :: ipiv
2955 4 : REAL(KIND=dp), ALLOCATABLE, DIMENSION(:, :) :: smat, tmat, v
2956 :
2957 4 : n = SIZE(ca)
2958 40 : ALLOCATE (smat(n, n), tmat(n, n), v(n, 1), ipiv(n))
2959 :
2960 4 : CALL sg_overlap(smat, l, a, a)
2961 4 : CALL sg_overlap(tmat, l, a, b)
2962 1252 : v(:, 1) = MATMUL(tmat, cb)
2963 4 : CALL dgesv(n, 1, smat, n, ipiv, v, n, info)
2964 4 : CPASSERT(info == 0)
2965 52 : ca(:) = v(:, 1)
2966 :
2967 4 : DEALLOCATE (smat, tmat, v, ipiv)
2968 :
2969 4 : END SUBROUTINE project_function_a
2970 :
2971 : ! **************************************************************************************************
2972 : !> \brief ...
2973 : !> \param ca ...
2974 : !> \param a ...
2975 : !> \param bfun ...
2976 : !> \param grid_atom ...
2977 : !> \param l ...
2978 : ! **************************************************************************************************
2979 36 : SUBROUTINE project_function_b(ca, a, bfun, grid_atom, l)
2980 : ! project function f on ca
2981 : REAL(KIND=dp), DIMENSION(:), INTENT(OUT) :: ca
2982 : REAL(KIND=dp), DIMENSION(:), INTENT(IN) :: a, bfun
2983 : TYPE(grid_atom_type), POINTER :: grid_atom
2984 : INTEGER, INTENT(IN) :: l
2985 :
2986 : INTEGER :: i, info, n, nr
2987 36 : INTEGER, ALLOCATABLE, DIMENSION(:) :: ipiv
2988 36 : REAL(KIND=dp), ALLOCATABLE, DIMENSION(:) :: afun
2989 36 : REAL(KIND=dp), ALLOCATABLE, DIMENSION(:, :) :: smat, v
2990 :
2991 36 : n = SIZE(ca)
2992 36 : nr = grid_atom%nr
2993 360 : ALLOCATE (smat(n, n), v(n, 1), ipiv(n), afun(nr))
2994 :
2995 36 : CALL sg_overlap(smat, l, a, a)
2996 468 : DO i = 1, n
2997 22032 : afun(:) = grid_atom%rad(:)**l*EXP(-a(i)*grid_atom%rad2(:))
2998 22068 : v(i, 1) = SUM(afun(:)*bfun(:)*grid_atom%wr(:))
2999 : END DO
3000 36 : CALL dgesv(n, 1, smat, n, ipiv, v, n, info)
3001 36 : CPASSERT(info == 0)
3002 468 : ca(:) = v(:, 1)
3003 :
3004 36 : DEALLOCATE (smat, v, ipiv, afun)
3005 :
3006 36 : END SUBROUTINE project_function_b
3007 :
3008 : ! **************************************************************************************************
3009 : !> \brief Performs printing of cube files from local energy
3010 : !> \param input input
3011 : !> \param logger the logger
3012 : !> \param qs_env the qs_env in which the qs_env lives
3013 : !> \par History
3014 : !> 07.2019 created
3015 : !> \author JGH
3016 : ! **************************************************************************************************
3017 11297 : SUBROUTINE qs_scf_post_local_energy(input, logger, qs_env)
3018 : TYPE(section_vals_type), POINTER :: input
3019 : TYPE(cp_logger_type), POINTER :: logger
3020 : TYPE(qs_environment_type), POINTER :: qs_env
3021 :
3022 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_local_energy'
3023 :
3024 : CHARACTER(LEN=default_path_length) :: filename, my_pos_cube
3025 : INTEGER :: handle, io_unit, natom, unit_nr
3026 : LOGICAL :: append_cube, gapw, gapw_xc, mpi_io
3027 : TYPE(dft_control_type), POINTER :: dft_control
3028 : TYPE(particle_list_type), POINTER :: particles
3029 : TYPE(pw_env_type), POINTER :: pw_env
3030 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
3031 : TYPE(pw_r3d_rs_type) :: eden
3032 : TYPE(qs_subsys_type), POINTER :: subsys
3033 : TYPE(section_vals_type), POINTER :: dft_section
3034 :
3035 11297 : CALL timeset(routineN, handle)
3036 11297 : io_unit = cp_logger_get_default_io_unit(logger)
3037 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
3038 : "DFT%PRINT%LOCAL_ENERGY_CUBE"), cp_p_file)) THEN
3039 32 : dft_section => section_vals_get_subs_vals(input, "DFT")
3040 32 : CALL get_qs_env(qs_env=qs_env, dft_control=dft_control, natom=natom)
3041 32 : gapw = dft_control%qs_control%gapw
3042 32 : gapw_xc = dft_control%qs_control%gapw_xc
3043 32 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env, subsys=subsys)
3044 32 : CALL qs_subsys_get(subsys, particles=particles)
3045 32 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool)
3046 32 : CALL auxbas_pw_pool%create_pw(eden)
3047 : !
3048 32 : CALL qs_local_energy(qs_env, eden)
3049 : !
3050 32 : append_cube = section_get_lval(input, "DFT%PRINT%LOCAL_ENERGY_CUBE%APPEND")
3051 32 : IF (append_cube) THEN
3052 0 : my_pos_cube = "APPEND"
3053 : ELSE
3054 32 : my_pos_cube = "REWIND"
3055 : END IF
3056 32 : mpi_io = .TRUE.
3057 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%LOCAL_ENERGY_CUBE", &
3058 : extension=".cube", middle_name="local_energy", &
3059 32 : file_position=my_pos_cube, mpi_io=mpi_io)
3060 : CALL cp_pw_to_cube(eden, &
3061 : unit_nr, "LOCAL ENERGY", particles=particles, &
3062 : stride=section_get_ivals(dft_section, &
3063 32 : "PRINT%LOCAL_ENERGY_CUBE%STRIDE"), mpi_io=mpi_io)
3064 32 : IF (io_unit > 0) THEN
3065 16 : INQUIRE (UNIT=unit_nr, NAME=filename)
3066 16 : IF (gapw .OR. gapw_xc) THEN
3067 : WRITE (UNIT=io_unit, FMT="(/,T3,A,A)") &
3068 0 : "The soft part of the local energy is written to the file: ", TRIM(ADJUSTL(filename))
3069 : ELSE
3070 : WRITE (UNIT=io_unit, FMT="(/,T3,A,A)") &
3071 16 : "The local energy is written to the file: ", TRIM(ADJUSTL(filename))
3072 : END IF
3073 : END IF
3074 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
3075 32 : "DFT%PRINT%LOCAL_ENERGY_CUBE", mpi_io=mpi_io)
3076 : !
3077 32 : CALL auxbas_pw_pool%give_back_pw(eden)
3078 : END IF
3079 11297 : CALL timestop(handle)
3080 :
3081 11297 : END SUBROUTINE qs_scf_post_local_energy
3082 :
3083 : ! **************************************************************************************************
3084 : !> \brief Performs printing of cube files from local energy
3085 : !> \param input input
3086 : !> \param logger the logger
3087 : !> \param qs_env the qs_env in which the qs_env lives
3088 : !> \par History
3089 : !> 07.2019 created
3090 : !> \author JGH
3091 : ! **************************************************************************************************
3092 11297 : SUBROUTINE qs_scf_post_local_stress(input, logger, qs_env)
3093 : TYPE(section_vals_type), POINTER :: input
3094 : TYPE(cp_logger_type), POINTER :: logger
3095 : TYPE(qs_environment_type), POINTER :: qs_env
3096 :
3097 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_local_stress'
3098 :
3099 : CHARACTER(LEN=default_path_length) :: filename, my_pos_cube
3100 : INTEGER :: handle, io_unit, natom, unit_nr
3101 : LOGICAL :: append_cube, gapw, gapw_xc, mpi_io
3102 : REAL(KIND=dp) :: beta
3103 : TYPE(dft_control_type), POINTER :: dft_control
3104 : TYPE(particle_list_type), POINTER :: particles
3105 : TYPE(pw_env_type), POINTER :: pw_env
3106 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
3107 : TYPE(pw_r3d_rs_type) :: stress
3108 : TYPE(qs_subsys_type), POINTER :: subsys
3109 : TYPE(section_vals_type), POINTER :: dft_section
3110 :
3111 11297 : CALL timeset(routineN, handle)
3112 11297 : io_unit = cp_logger_get_default_io_unit(logger)
3113 11297 : IF (BTEST(cp_print_key_should_output(logger%iter_info, input, &
3114 : "DFT%PRINT%LOCAL_STRESS_CUBE"), cp_p_file)) THEN
3115 30 : dft_section => section_vals_get_subs_vals(input, "DFT")
3116 30 : CALL get_qs_env(qs_env=qs_env, dft_control=dft_control, natom=natom)
3117 30 : gapw = dft_control%qs_control%gapw
3118 30 : gapw_xc = dft_control%qs_control%gapw_xc
3119 30 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env, subsys=subsys)
3120 30 : CALL qs_subsys_get(subsys, particles=particles)
3121 30 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool)
3122 30 : CALL auxbas_pw_pool%create_pw(stress)
3123 : !
3124 : ! use beta=0: kinetic energy density in symmetric form
3125 30 : beta = 0.0_dp
3126 30 : CALL qs_local_stress(qs_env, beta=beta)
3127 : !
3128 30 : append_cube = section_get_lval(input, "DFT%PRINT%LOCAL_STRESS_CUBE%APPEND")
3129 30 : IF (append_cube) THEN
3130 0 : my_pos_cube = "APPEND"
3131 : ELSE
3132 30 : my_pos_cube = "REWIND"
3133 : END IF
3134 30 : mpi_io = .TRUE.
3135 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%LOCAL_STRESS_CUBE", &
3136 : extension=".cube", middle_name="local_stress", &
3137 30 : file_position=my_pos_cube, mpi_io=mpi_io)
3138 : CALL cp_pw_to_cube(stress, &
3139 : unit_nr, "LOCAL STRESS", particles=particles, &
3140 : stride=section_get_ivals(dft_section, &
3141 30 : "PRINT%LOCAL_STRESS_CUBE%STRIDE"), mpi_io=mpi_io)
3142 30 : IF (io_unit > 0) THEN
3143 15 : INQUIRE (UNIT=unit_nr, NAME=filename)
3144 15 : WRITE (UNIT=io_unit, FMT="(/,T3,A)") "Write 1/3*Tr(sigma) to cube file"
3145 15 : IF (gapw .OR. gapw_xc) THEN
3146 : WRITE (UNIT=io_unit, FMT="(T3,A,A)") &
3147 0 : "The soft part of the local stress is written to the file: ", TRIM(ADJUSTL(filename))
3148 : ELSE
3149 : WRITE (UNIT=io_unit, FMT="(T3,A,A)") &
3150 15 : "The local stress is written to the file: ", TRIM(ADJUSTL(filename))
3151 : END IF
3152 : END IF
3153 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
3154 30 : "DFT%PRINT%LOCAL_STRESS_CUBE", mpi_io=mpi_io)
3155 : !
3156 30 : CALL auxbas_pw_pool%give_back_pw(stress)
3157 : END IF
3158 :
3159 11297 : CALL timestop(handle)
3160 :
3161 11297 : END SUBROUTINE qs_scf_post_local_stress
3162 :
3163 : ! **************************************************************************************************
3164 : !> \brief Performs printing of cube files related to the implicit Poisson solver
3165 : !> \param input input
3166 : !> \param logger the logger
3167 : !> \param qs_env the qs_env in which the qs_env lives
3168 : !> \par History
3169 : !> 03.2016 refactored from write_mo_free_results [Hossein Bani-Hashemian]
3170 : !> \author Mohammad Hossein Bani-Hashemian
3171 : ! **************************************************************************************************
3172 11297 : SUBROUTINE qs_scf_post_ps_implicit(input, logger, qs_env)
3173 : TYPE(section_vals_type), POINTER :: input
3174 : TYPE(cp_logger_type), POINTER :: logger
3175 : TYPE(qs_environment_type), POINTER :: qs_env
3176 :
3177 : CHARACTER(len=*), PARAMETER :: routineN = 'qs_scf_post_ps_implicit'
3178 :
3179 : CHARACTER(LEN=default_path_length) :: filename, my_pos_cube
3180 : INTEGER :: boundary_condition, handle, i, j, &
3181 : n_cstr, n_tiles, unit_nr
3182 : LOGICAL :: append_cube, do_cstr_charge_cube, do_dielectric_cube, do_dirichlet_bc_cube, &
3183 : has_dirichlet_bc, has_implicit_ps, mpi_io, tile_cubes
3184 : TYPE(particle_list_type), POINTER :: particles
3185 : TYPE(pw_env_type), POINTER :: pw_env
3186 : TYPE(pw_poisson_type), POINTER :: poisson_env
3187 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
3188 : TYPE(pw_r3d_rs_type) :: aux_r
3189 : TYPE(pw_r3d_rs_type), POINTER :: dirichlet_tile
3190 : TYPE(qs_subsys_type), POINTER :: subsys
3191 : TYPE(section_vals_type), POINTER :: dft_section
3192 :
3193 11297 : CALL timeset(routineN, handle)
3194 :
3195 11297 : NULLIFY (pw_env, auxbas_pw_pool, dft_section, particles)
3196 :
3197 11297 : dft_section => section_vals_get_subs_vals(input, "DFT")
3198 11297 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env, subsys=subsys)
3199 11297 : CALL qs_subsys_get(subsys, particles=particles)
3200 11297 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool)
3201 :
3202 11297 : has_implicit_ps = .FALSE.
3203 11297 : CALL get_qs_env(qs_env=qs_env, pw_env=pw_env)
3204 11297 : IF (pw_env%poisson_env%parameters%solver == pw_poisson_implicit) has_implicit_ps = .TRUE.
3205 :
3206 : ! Write the dielectric constant into a cube file
3207 : do_dielectric_cube = BTEST(cp_print_key_should_output(logger%iter_info, input, &
3208 11297 : "DFT%PRINT%IMPLICIT_PSOLVER%DIELECTRIC_CUBE"), cp_p_file)
3209 11297 : IF (has_implicit_ps .AND. do_dielectric_cube) THEN
3210 0 : append_cube = section_get_lval(input, "DFT%PRINT%IMPLICIT_PSOLVER%DIELECTRIC_CUBE%APPEND")
3211 0 : my_pos_cube = "REWIND"
3212 0 : IF (append_cube) THEN
3213 0 : my_pos_cube = "APPEND"
3214 : END IF
3215 0 : mpi_io = .TRUE.
3216 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%IMPLICIT_PSOLVER%DIELECTRIC_CUBE", &
3217 : extension=".cube", middle_name="DIELECTRIC_CONSTANT", file_position=my_pos_cube, &
3218 0 : mpi_io=mpi_io)
3219 0 : CALL pw_env_get(pw_env, poisson_env=poisson_env, auxbas_pw_pool=auxbas_pw_pool)
3220 0 : CALL auxbas_pw_pool%create_pw(aux_r)
3221 :
3222 0 : boundary_condition = pw_env%poisson_env%parameters%ps_implicit_params%boundary_condition
3223 0 : SELECT CASE (boundary_condition)
3224 : CASE (PERIODIC_BC, MIXED_PERIODIC_BC)
3225 0 : CALL pw_copy(poisson_env%implicit_env%dielectric%eps, aux_r)
3226 : CASE (MIXED_BC, NEUMANN_BC)
3227 : CALL pw_shrink(pw_env%poisson_env%parameters%ps_implicit_params%neumann_directions, &
3228 : pw_env%poisson_env%implicit_env%dct_env%dests_shrink, &
3229 : pw_env%poisson_env%implicit_env%dct_env%srcs_shrink, &
3230 : pw_env%poisson_env%implicit_env%dct_env%bounds_local_shftd, &
3231 0 : poisson_env%implicit_env%dielectric%eps, aux_r)
3232 : END SELECT
3233 :
3234 : CALL cp_pw_to_cube(aux_r, unit_nr, "DIELECTRIC CONSTANT", particles=particles, &
3235 : stride=section_get_ivals(dft_section, "PRINT%IMPLICIT_PSOLVER%DIELECTRIC_CUBE%STRIDE"), &
3236 0 : mpi_io=mpi_io)
3237 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
3238 0 : "DFT%PRINT%IMPLICIT_PSOLVER%DIELECTRIC_CUBE", mpi_io=mpi_io)
3239 :
3240 0 : CALL auxbas_pw_pool%give_back_pw(aux_r)
3241 : END IF
3242 :
3243 : ! Write Dirichlet constraint charges into a cube file
3244 : do_cstr_charge_cube = BTEST(cp_print_key_should_output(logger%iter_info, input, &
3245 11297 : "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_CSTR_CHARGE_CUBE"), cp_p_file)
3246 :
3247 11297 : has_dirichlet_bc = .FALSE.
3248 11297 : IF (has_implicit_ps) THEN
3249 86 : boundary_condition = pw_env%poisson_env%parameters%ps_implicit_params%boundary_condition
3250 86 : IF (boundary_condition == MIXED_PERIODIC_BC .OR. boundary_condition == MIXED_BC) THEN
3251 60 : has_dirichlet_bc = .TRUE.
3252 : END IF
3253 : END IF
3254 :
3255 11297 : IF (has_implicit_ps .AND. do_cstr_charge_cube .AND. has_dirichlet_bc) THEN
3256 : append_cube = section_get_lval(input, &
3257 0 : "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_CSTR_CHARGE_CUBE%APPEND")
3258 0 : my_pos_cube = "REWIND"
3259 0 : IF (append_cube) THEN
3260 0 : my_pos_cube = "APPEND"
3261 : END IF
3262 0 : mpi_io = .TRUE.
3263 : unit_nr = cp_print_key_unit_nr(logger, input, &
3264 : "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_CSTR_CHARGE_CUBE", &
3265 : extension=".cube", middle_name="dirichlet_cstr_charge", file_position=my_pos_cube, &
3266 0 : mpi_io=mpi_io)
3267 0 : CALL pw_env_get(pw_env, poisson_env=poisson_env, auxbas_pw_pool=auxbas_pw_pool)
3268 0 : CALL auxbas_pw_pool%create_pw(aux_r)
3269 :
3270 0 : boundary_condition = pw_env%poisson_env%parameters%ps_implicit_params%boundary_condition
3271 0 : SELECT CASE (boundary_condition)
3272 : CASE (MIXED_PERIODIC_BC)
3273 0 : CALL pw_copy(poisson_env%implicit_env%cstr_charge, aux_r)
3274 : CASE (MIXED_BC)
3275 : CALL pw_shrink(pw_env%poisson_env%parameters%ps_implicit_params%neumann_directions, &
3276 : pw_env%poisson_env%implicit_env%dct_env%dests_shrink, &
3277 : pw_env%poisson_env%implicit_env%dct_env%srcs_shrink, &
3278 : pw_env%poisson_env%implicit_env%dct_env%bounds_local_shftd, &
3279 0 : poisson_env%implicit_env%cstr_charge, aux_r)
3280 : END SELECT
3281 :
3282 : CALL cp_pw_to_cube(aux_r, unit_nr, "DIRICHLET CONSTRAINT CHARGE", particles=particles, &
3283 : stride=section_get_ivals(dft_section, "PRINT%IMPLICIT_PSOLVER%DIRICHLET_CSTR_CHARGE_CUBE%STRIDE"), &
3284 0 : mpi_io=mpi_io)
3285 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
3286 0 : "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_CSTR_CHARGE_CUBE", mpi_io=mpi_io)
3287 :
3288 0 : CALL auxbas_pw_pool%give_back_pw(aux_r)
3289 : END IF
3290 :
3291 : ! Write Dirichlet type constranits into cube files
3292 : do_dirichlet_bc_cube = BTEST(cp_print_key_should_output(logger%iter_info, input, &
3293 11297 : "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE"), cp_p_file)
3294 11297 : has_dirichlet_bc = .FALSE.
3295 11297 : IF (has_implicit_ps) THEN
3296 86 : boundary_condition = pw_env%poisson_env%parameters%ps_implicit_params%boundary_condition
3297 86 : IF (boundary_condition == MIXED_PERIODIC_BC .OR. boundary_condition == MIXED_BC) THEN
3298 60 : has_dirichlet_bc = .TRUE.
3299 : END IF
3300 : END IF
3301 :
3302 11297 : IF (has_implicit_ps .AND. has_dirichlet_bc .AND. do_dirichlet_bc_cube) THEN
3303 0 : append_cube = section_get_lval(input, "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE%APPEND")
3304 0 : my_pos_cube = "REWIND"
3305 0 : IF (append_cube) THEN
3306 0 : my_pos_cube = "APPEND"
3307 : END IF
3308 0 : tile_cubes = section_get_lval(input, "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE%TILE_CUBES")
3309 :
3310 0 : CALL pw_env_get(pw_env, poisson_env=poisson_env, auxbas_pw_pool=auxbas_pw_pool)
3311 0 : CALL auxbas_pw_pool%create_pw(aux_r)
3312 0 : CALL pw_zero(aux_r)
3313 :
3314 0 : IF (tile_cubes) THEN
3315 : ! one cube file per tile
3316 0 : n_cstr = SIZE(poisson_env%implicit_env%contacts)
3317 0 : DO j = 1, n_cstr
3318 0 : n_tiles = poisson_env%implicit_env%contacts(j)%dirichlet_bc%n_tiles
3319 0 : DO i = 1, n_tiles
3320 : filename = "dirichlet_cstr_"//TRIM(ADJUSTL(cp_to_string(j)))// &
3321 0 : "_tile_"//TRIM(ADJUSTL(cp_to_string(i)))
3322 0 : mpi_io = .TRUE.
3323 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE", &
3324 : extension=".cube", middle_name=filename, file_position=my_pos_cube, &
3325 0 : mpi_io=mpi_io)
3326 :
3327 0 : CALL pw_copy(poisson_env%implicit_env%contacts(j)%dirichlet_bc%tiles(i)%tile%tile_pw, aux_r)
3328 :
3329 : CALL cp_pw_to_cube(aux_r, unit_nr, "DIRICHLET TYPE CONSTRAINT", particles=particles, &
3330 : stride=section_get_ivals(dft_section, "PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE%STRIDE"), &
3331 0 : mpi_io=mpi_io)
3332 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
3333 0 : "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE", mpi_io=mpi_io)
3334 : END DO
3335 : END DO
3336 : ELSE
3337 : ! a single cube file
3338 0 : NULLIFY (dirichlet_tile)
3339 0 : ALLOCATE (dirichlet_tile)
3340 0 : CALL auxbas_pw_pool%create_pw(dirichlet_tile)
3341 0 : CALL pw_zero(dirichlet_tile)
3342 0 : mpi_io = .TRUE.
3343 : unit_nr = cp_print_key_unit_nr(logger, input, "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE", &
3344 : extension=".cube", middle_name="DIRICHLET_CSTR", file_position=my_pos_cube, &
3345 0 : mpi_io=mpi_io)
3346 :
3347 0 : n_cstr = SIZE(poisson_env%implicit_env%contacts)
3348 0 : DO j = 1, n_cstr
3349 0 : n_tiles = poisson_env%implicit_env%contacts(j)%dirichlet_bc%n_tiles
3350 0 : DO i = 1, n_tiles
3351 0 : CALL pw_copy(poisson_env%implicit_env%contacts(j)%dirichlet_bc%tiles(i)%tile%tile_pw, dirichlet_tile)
3352 0 : CALL pw_axpy(dirichlet_tile, aux_r)
3353 : END DO
3354 : END DO
3355 :
3356 : CALL cp_pw_to_cube(aux_r, unit_nr, "DIRICHLET TYPE CONSTRAINT", particles=particles, &
3357 : stride=section_get_ivals(dft_section, "PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE%STRIDE"), &
3358 0 : mpi_io=mpi_io)
3359 : CALL cp_print_key_finished_output(unit_nr, logger, input, &
3360 0 : "DFT%PRINT%IMPLICIT_PSOLVER%DIRICHLET_BC_CUBE", mpi_io=mpi_io)
3361 0 : CALL auxbas_pw_pool%give_back_pw(dirichlet_tile)
3362 0 : DEALLOCATE (dirichlet_tile)
3363 : END IF
3364 :
3365 0 : CALL auxbas_pw_pool%give_back_pw(aux_r)
3366 : END IF
3367 :
3368 11297 : CALL timestop(handle)
3369 :
3370 11297 : END SUBROUTINE qs_scf_post_ps_implicit
3371 :
3372 : !**************************************************************************************************
3373 : !> \brief write an adjacency (interaction) matrix
3374 : !> \param qs_env qs environment
3375 : !> \param input the input
3376 : !> \author Mohammad Hossein Bani-Hashemian
3377 : ! **************************************************************************************************
3378 11297 : SUBROUTINE write_adjacency_matrix(qs_env, input)
3379 : TYPE(qs_environment_type), POINTER :: qs_env
3380 : TYPE(section_vals_type), POINTER :: input
3381 :
3382 : CHARACTER(len=*), PARAMETER :: routineN = 'write_adjacency_matrix'
3383 :
3384 : INTEGER :: adjm_size, colind, handle, iatom, ikind, &
3385 : ind, jatom, jkind, k, natom, nkind, &
3386 : output_unit, rowind, unit_nr
3387 11297 : INTEGER, ALLOCATABLE, DIMENSION(:) :: interact_adjm
3388 : LOGICAL :: do_adjm_write, do_symmetric
3389 : TYPE(cp_logger_type), POINTER :: logger
3390 11297 : TYPE(gto_basis_set_p_type), DIMENSION(:), POINTER :: basis_set_list_a, basis_set_list_b
3391 : TYPE(gto_basis_set_type), POINTER :: basis_set_a, basis_set_b
3392 : TYPE(mp_para_env_type), POINTER :: para_env
3393 : TYPE(neighbor_list_iterator_p_type), &
3394 11297 : DIMENSION(:), POINTER :: nl_iterator
3395 : TYPE(neighbor_list_set_p_type), DIMENSION(:), &
3396 11297 : POINTER :: nl
3397 11297 : TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
3398 : TYPE(section_vals_type), POINTER :: dft_section
3399 :
3400 11297 : CALL timeset(routineN, handle)
3401 :
3402 11297 : NULLIFY (dft_section)
3403 :
3404 11297 : logger => cp_get_default_logger()
3405 11297 : output_unit = cp_logger_get_default_io_unit(logger)
3406 :
3407 11297 : dft_section => section_vals_get_subs_vals(input, "DFT")
3408 : do_adjm_write = BTEST(cp_print_key_should_output(logger%iter_info, dft_section, &
3409 11297 : "PRINT%ADJMAT_WRITE"), cp_p_file)
3410 :
3411 11297 : IF (do_adjm_write) THEN
3412 28 : NULLIFY (qs_kind_set, nl_iterator)
3413 28 : NULLIFY (basis_set_list_a, basis_set_list_b, basis_set_a, basis_set_b)
3414 :
3415 28 : CALL get_qs_env(qs_env, qs_kind_set=qs_kind_set, sab_orb=nl, natom=natom, para_env=para_env)
3416 :
3417 28 : nkind = SIZE(qs_kind_set)
3418 28 : CPASSERT(SIZE(nl) > 0)
3419 28 : CALL get_neighbor_list_set_p(neighbor_list_sets=nl, symmetric=do_symmetric)
3420 28 : CPASSERT(do_symmetric)
3421 216 : ALLOCATE (basis_set_list_a(nkind), basis_set_list_b(nkind))
3422 28 : CALL basis_set_list_setup(basis_set_list_a, "ORB", qs_kind_set)
3423 28 : CALL basis_set_list_setup(basis_set_list_b, "ORB", qs_kind_set)
3424 :
3425 28 : adjm_size = ((natom + 1)*natom)/2
3426 84 : ALLOCATE (interact_adjm(4*adjm_size))
3427 620 : interact_adjm = 0
3428 :
3429 28 : NULLIFY (nl_iterator)
3430 28 : CALL neighbor_list_iterator_create(nl_iterator, nl)
3431 2021 : DO WHILE (neighbor_list_iterate(nl_iterator) == 0)
3432 : CALL get_iterator_info(nl_iterator, &
3433 : ikind=ikind, jkind=jkind, &
3434 1993 : iatom=iatom, jatom=jatom)
3435 :
3436 1993 : basis_set_a => basis_set_list_a(ikind)%gto_basis_set
3437 1993 : IF (.NOT. ASSOCIATED(basis_set_a)) CYCLE
3438 1993 : basis_set_b => basis_set_list_b(jkind)%gto_basis_set
3439 1993 : IF (.NOT. ASSOCIATED(basis_set_b)) CYCLE
3440 :
3441 : ! move everything to the upper triangular part
3442 1993 : IF (iatom <= jatom) THEN
3443 : rowind = iatom
3444 : colind = jatom
3445 : ELSE
3446 670 : rowind = jatom
3447 670 : colind = iatom
3448 : ! swap the kinds too
3449 : ikind = ikind + jkind
3450 670 : jkind = ikind - jkind
3451 670 : ikind = ikind - jkind
3452 : END IF
3453 :
3454 : ! indexing upper triangular matrix
3455 1993 : ind = adjm_size - (natom - rowind + 1)*((natom - rowind + 1) + 1)/2 + colind - rowind + 1
3456 : ! convert the upper triangular matrix into a adjm_size x 4 matrix
3457 : ! columns are: iatom, jatom, ikind, jkind
3458 1993 : interact_adjm((ind - 1)*4 + 1) = rowind
3459 1993 : interact_adjm((ind - 1)*4 + 2) = colind
3460 1993 : interact_adjm((ind - 1)*4 + 3) = ikind
3461 1993 : interact_adjm((ind - 1)*4 + 4) = jkind
3462 : END DO
3463 :
3464 28 : CALL para_env%sum(interact_adjm)
3465 :
3466 : unit_nr = cp_print_key_unit_nr(logger, dft_section, "PRINT%ADJMAT_WRITE", &
3467 : extension=".adjmat", file_form="FORMATTED", &
3468 28 : file_status="REPLACE")
3469 28 : IF (unit_nr > 0) THEN
3470 14 : WRITE (unit_nr, "(1A,2X,1A,5X,1A,4X,A5,3X,A5)") "#", "iatom", "jatom", "ikind", "jkind"
3471 88 : DO k = 1, 4*adjm_size, 4
3472 : ! print only the interacting atoms
3473 88 : IF (interact_adjm(k) > 0 .AND. interact_adjm(k + 1) > 0) THEN
3474 74 : WRITE (unit_nr, "(I8,2X,I8,3X,I6,2X,I6)") interact_adjm(k:k + 3)
3475 : END IF
3476 : END DO
3477 : END IF
3478 :
3479 28 : CALL cp_print_key_finished_output(unit_nr, logger, dft_section, "PRINT%ADJMAT_WRITE")
3480 :
3481 28 : CALL neighbor_list_iterator_release(nl_iterator)
3482 56 : DEALLOCATE (basis_set_list_a, basis_set_list_b)
3483 : END IF
3484 :
3485 11297 : CALL timestop(handle)
3486 :
3487 22594 : END SUBROUTINE write_adjacency_matrix
3488 :
3489 : ! **************************************************************************************************
3490 : !> \brief Updates Hartree potential with MP2 density. Important for REPEAT charges
3491 : !> \param rho ...
3492 : !> \param qs_env ...
3493 : !> \author Vladimir Rybkin
3494 : ! **************************************************************************************************
3495 322 : SUBROUTINE update_hartree_with_mp2(rho, qs_env)
3496 : TYPE(qs_rho_type), POINTER :: rho
3497 : TYPE(qs_environment_type), POINTER :: qs_env
3498 :
3499 : LOGICAL :: use_virial
3500 : TYPE(pw_c1d_gs_type) :: rho_tot_gspace, v_hartree_gspace
3501 : TYPE(pw_c1d_gs_type), POINTER :: rho_core
3502 : TYPE(pw_env_type), POINTER :: pw_env
3503 : TYPE(pw_poisson_type), POINTER :: poisson_env
3504 : TYPE(pw_pool_type), POINTER :: auxbas_pw_pool
3505 : TYPE(pw_r3d_rs_type), POINTER :: v_hartree_rspace
3506 : TYPE(qs_energy_type), POINTER :: energy
3507 : TYPE(virial_type), POINTER :: virial
3508 :
3509 322 : NULLIFY (auxbas_pw_pool, pw_env, poisson_env, energy, rho_core, v_hartree_rspace, virial)
3510 : CALL get_qs_env(qs_env, pw_env=pw_env, energy=energy, &
3511 : rho_core=rho_core, virial=virial, &
3512 322 : v_hartree_rspace=v_hartree_rspace)
3513 :
3514 322 : use_virial = virial%pv_availability .AND. (.NOT. virial%pv_numer)
3515 :
3516 : IF (.NOT. use_virial) THEN
3517 :
3518 : CALL pw_env_get(pw_env, auxbas_pw_pool=auxbas_pw_pool, &
3519 268 : poisson_env=poisson_env)
3520 268 : CALL auxbas_pw_pool%create_pw(v_hartree_gspace)
3521 268 : CALL auxbas_pw_pool%create_pw(rho_tot_gspace)
3522 :
3523 268 : CALL calc_rho_tot_gspace(rho_tot_gspace, qs_env, rho)
3524 : CALL pw_poisson_solve(poisson_env, rho_tot_gspace, energy%hartree, &
3525 268 : v_hartree_gspace, rho_core=rho_core)
3526 :
3527 268 : CALL pw_transfer(v_hartree_gspace, v_hartree_rspace)
3528 268 : CALL pw_scale(v_hartree_rspace, v_hartree_rspace%pw_grid%dvol)
3529 :
3530 268 : CALL auxbas_pw_pool%give_back_pw(v_hartree_gspace)
3531 268 : CALL auxbas_pw_pool%give_back_pw(rho_tot_gspace)
3532 : END IF
3533 :
3534 322 : END SUBROUTINE update_hartree_with_mp2
3535 :
3536 : END MODULE qs_scf_post_gpw
|