(git:374b731)
Loading...
Searching...
No Matches
qs_gcp_method.F
Go to the documentation of this file.
1!--------------------------------------------------------------------------------------------------!
2! CP2K: A general program to perform molecular dynamics simulations !
3! Copyright 2000-2024 CP2K developers group <https://cp2k.org> !
4! !
5! SPDX-License-Identifier: GPL-2.0-or-later !
6!--------------------------------------------------------------------------------------------------!
7
8! **************************************************************************************************
9!> \brief Calculation of gCP pair potentials
10!> \author JGH
11! **************************************************************************************************
13 USE ai_overlap, ONLY: overlap_ab
18 USE cell_types, ONLY: cell_type
20 USE kinds, ONLY: dp
23 USE physcon, ONLY: kcalmol
27 USE qs_gcp_types, ONLY: qs_gcp_type
36 USE virial_types, ONLY: virial_type
37#include "./base/base_uses.f90"
38
39 IMPLICIT NONE
40
41 PRIVATE
42
43 CHARACTER(len=*), PARAMETER, PRIVATE :: moduleN = 'qs_gcp_method'
44
45 PUBLIC :: calculate_gcp_pairpot
46
47! **************************************************************************************************
48
49CONTAINS
50
51! **************************************************************************************************
52!> \brief ...
53!> \param qs_env ...
54!> \param gcp_env ...
55!> \param energy ...
56!> \param calculate_forces ...
57!> \param ategcp ...
58!> \note
59!> \note energy_correction_type: also add gcp_env and egcp to the type
60!> \note
61! **************************************************************************************************
62 SUBROUTINE calculate_gcp_pairpot(qs_env, gcp_env, energy, calculate_forces, ategcp)
63
64 TYPE(qs_environment_type), POINTER :: qs_env
65 TYPE(qs_gcp_type), POINTER :: gcp_env
66 REAL(kind=dp), INTENT(OUT) :: energy
67 LOGICAL, INTENT(IN) :: calculate_forces
68 REAL(kind=dp), DIMENSION(:), OPTIONAL :: ategcp
69
70 CHARACTER(LEN=*), PARAMETER :: routinen = 'calculate_gcp_pairpot'
71
72 INTEGER :: atom_a, atom_b, handle, i, iatom, ikind, &
73 jatom, jkind, mepos, natom, nkind, &
74 nsto, unit_nr
75 INTEGER, ALLOCATABLE, DIMENSION(:) :: atom_of_kind, kind_of, ngcpat
76 LOGICAL :: atenergy, atex, atstress, use_virial, &
77 verbose
78 REAL(kind=dp) :: eama, eamb, egcp, expab, fac, fda, fdb, &
79 gnorm, nvirta, nvirtb, rcc, sint, sqa, &
80 sqb
81 REAL(kind=dp), ALLOCATABLE, DIMENSION(:) :: egcpat
82 REAL(kind=dp), DIMENSION(3) :: dsint, fdij, rij
83 REAL(kind=dp), DIMENSION(3, 3) :: dvirial
84 REAL(kind=dp), DIMENSION(6) :: cla, clb, rcut, zeta, zetb
85 REAL(kind=dp), DIMENSION(6, 6) :: sab
86 REAL(kind=dp), DIMENSION(6, 6, 3) :: dab
87 REAL(kind=dp), DIMENSION(:), POINTER :: atener
88 REAL(kind=dp), DIMENSION(:, :, :), POINTER :: atstr
89 TYPE(atomic_kind_type), DIMENSION(:), POINTER :: atomic_kind_set
90 TYPE(atprop_type), POINTER :: atprop
91 TYPE(cell_type), POINTER :: cell
92 TYPE(mp_para_env_type), POINTER :: para_env
94 DIMENSION(:), POINTER :: nl_iterator
95 TYPE(neighbor_list_set_p_type), DIMENSION(:), &
96 POINTER :: sab_gcp
97 TYPE(particle_type), DIMENSION(:), POINTER :: particle_set
98 TYPE(qs_force_type), DIMENSION(:), POINTER :: force
99 TYPE(qs_kind_type), DIMENSION(:), POINTER :: qs_kind_set
100 TYPE(virial_type), POINTER :: virial
101
102 energy = 0._dp
103 IF (.NOT. gcp_env%do_gcp) RETURN
104
105 CALL timeset(routinen, handle)
106
107 NULLIFY (atomic_kind_set, qs_kind_set, particle_set, sab_gcp)
108
109 CALL get_qs_env(qs_env=qs_env, atomic_kind_set=atomic_kind_set, qs_kind_set=qs_kind_set, &
110 cell=cell, virial=virial, para_env=para_env, atprop=atprop)
111 nkind = SIZE(atomic_kind_set)
112 NULLIFY (particle_set)
113 CALL get_qs_env(qs_env=qs_env, particle_set=particle_set)
114 natom = SIZE(particle_set)
115
116 verbose = gcp_env%verbose
117 IF (verbose) THEN
119 ELSE
120 unit_nr = -1
121 END IF
122 ! atomic energy and stress arrays
123 atenergy = atprop%energy
124 IF (atenergy) THEN
125 CALL atprop_array_init(atprop%ategcp, natom)
126 atener => atprop%ategcp
127 END IF
128 atstress = atprop%stress
129 atstr => atprop%atstress
130 ! external atomic energy
131 atex = .false.
132 IF (PRESENT(ategcp)) atex = .true.
133
134 IF (unit_nr > 0) THEN
135 WRITE (unit_nr, *)
136 WRITE (unit_nr, *) " Pair potential geometrical counterpoise (gCP) calculation"
137 WRITE (unit_nr, *)
138 WRITE (unit_nr, "(T15,A,T74,F7.4)") " Gloabal Parameters: sigma = ", gcp_env%sigma, &
139 " alpha = ", gcp_env%alpha, &
140 " beta = ", gcp_env%beta, &
141 " eta = ", gcp_env%eta
142 WRITE (unit_nr, *)
143 WRITE (unit_nr, "(T31,4(A5,10X))") " kind", "nvirt", "Emiss", " asto"
144 DO ikind = 1, nkind
145 WRITE (unit_nr, "(T31,i5,F15.1,F15.4,F15.4)") ikind, gcp_env%gcp_kind(ikind)%nbvirt, &
146 gcp_env%gcp_kind(ikind)%eamiss, gcp_env%gcp_kind(ikind)%asto
147 END DO
148 WRITE (unit_nr, *)
149 END IF
150
151 IF (calculate_forces) THEN
152 NULLIFY (force)
153 CALL get_qs_env(qs_env=qs_env, force=force)
154 ALLOCATE (atom_of_kind(natom), kind_of(natom))
155 CALL get_atomic_kind_set(atomic_kind_set, atom_of_kind=atom_of_kind, kind_of=kind_of)
156 use_virial = virial%pv_availability .AND. (.NOT. virial%pv_numer)
157 IF (use_virial) dvirial = virial%pv_virial
158 END IF
159
160 ! include all integrals in the list
161 rcut = 1.e6_dp
162
163 egcp = 0.0_dp
164 IF (verbose) THEN
165 ALLOCATE (egcpat(natom), ngcpat(natom))
166 egcpat = 0.0_dp
167 ngcpat = 0
168 END IF
169
170 nsto = 6
171 DO ikind = 1, nkind
172 cpassert(nsto == SIZE(gcp_env%gcp_kind(jkind)%al))
173 END DO
174
175 sab_gcp => gcp_env%sab_gcp
176 CALL neighbor_list_iterator_create(nl_iterator, sab_gcp)
177 DO WHILE (neighbor_list_iterate(nl_iterator) == 0)
178
179 CALL get_iterator_info(nl_iterator, mepos=mepos, ikind=ikind, jkind=jkind, iatom=iatom, jatom=jatom, r=rij)
180
181 rcc = sqrt(rij(1)*rij(1) + rij(2)*rij(2) + rij(3)*rij(3))
182 IF (rcc > 1.e-6_dp) THEN
183 fac = 1._dp
184 IF (iatom == jatom) fac = 0.5_dp
185 nvirta = gcp_env%gcp_kind(ikind)%nbvirt
186 nvirtb = gcp_env%gcp_kind(jkind)%nbvirt
187 eama = gcp_env%gcp_kind(ikind)%eamiss
188 eamb = gcp_env%gcp_kind(jkind)%eamiss
189 expab = exp(-gcp_env%alpha*rcc**gcp_env%beta)
190 zeta(1:nsto) = gcp_env%gcp_kind(ikind)%al(1:nsto)
191 zetb(1:nsto) = gcp_env%gcp_kind(jkind)%al(1:nsto)
192 cla(1:nsto) = gcp_env%gcp_kind(ikind)%cl(1:nsto)
193 clb(1:nsto) = gcp_env%gcp_kind(jkind)%cl(1:nsto)
194 IF (calculate_forces) THEN
195 CALL overlap_ab(0, 0, nsto, rcut, zeta, 0, 0, nsto, rcut, zetb, rij, sab, dab)
196 DO i = 1, 3
197 dsint(i) = sum(cla*matmul(dab(:, :, i), clb))
198 END DO
199 ELSE
200 CALL overlap_ab(0, 0, nsto, rcut, zeta, 0, 0, nsto, rcut, zetb, rij, sab)
201 END IF
202 sint = sum(cla*matmul(sab, clb))
203 IF (sint < 1.e-16_dp) cycle
204 sqa = sqrt(sint*nvirta)
205 sqb = sqrt(sint*nvirtb)
206 IF (sqb > 1.e-12_dp) THEN
207 fda = gcp_env%sigma*eama*expab/sqb
208 ELSE
209 fda = 0.0_dp
210 END IF
211 IF (sqa > 1.e-12_dp) THEN
212 fdb = gcp_env%sigma*eamb*expab/sqa
213 ELSE
214 fdb = 0.0_dp
215 END IF
216 egcp = egcp + fac*(fda + fdb)
217 IF (verbose) THEN
218 egcpat(iatom) = egcpat(iatom) + fac*fda
219 egcpat(jatom) = egcpat(jatom) + fac*fdb
220 ngcpat(iatom) = ngcpat(iatom) + 1
221 ngcpat(jatom) = ngcpat(jatom) + 1
222 END IF
223 IF (calculate_forces) THEN
224 fdij = -fac*(fda + fdb)*(gcp_env%alpha*gcp_env%beta*rcc**(gcp_env%beta - 1.0_dp)*rij(1:3)/rcc)
225 IF (sqa > 1.e-12_dp) THEN
226 fdij = fdij + 0.25_dp*fac*fdb/(sqa*sqa)*dsint(1:3)
227 END IF
228 IF (sqb > 1.e-12_dp) THEN
229 fdij = fdij + 0.25_dp*fac*fda/(sqb*sqb)*dsint(1:3)
230 END IF
231 atom_a = atom_of_kind(iatom)
232 atom_b = atom_of_kind(jatom)
233 force(ikind)%gcp(:, atom_a) = force(ikind)%gcp(:, atom_a) - fdij(:)
234 force(jkind)%gcp(:, atom_b) = force(jkind)%gcp(:, atom_b) + fdij(:)
235 IF (use_virial) THEN
236 CALL virial_pair_force(virial%pv_virial, -1._dp, fdij, rij)
237 END IF
238 IF (atstress) THEN
239 CALL virial_pair_force(atstr(:, :, iatom), -0.5_dp, fdij, rij)
240 CALL virial_pair_force(atstr(:, :, jatom), -0.5_dp, fdij, rij)
241 END IF
242 END IF
243 IF (atenergy) THEN
244 atener(iatom) = atener(iatom) + fda*fac
245 atener(jatom) = atener(jatom) + fdb*fac
246 END IF
247 IF (atex) THEN
248 ategcp(iatom) = ategcp(iatom) + fda*fac
249 ategcp(jatom) = ategcp(jatom) + fdb*fac
250 END IF
251 END IF
252 END DO
253
254 CALL neighbor_list_iterator_release(nl_iterator)
255
256 ! set gCP energy
257 CALL para_env%sum(egcp)
258 energy = egcp
259 IF (verbose) THEN
260 CALL para_env%sum(egcpat)
261 CALL para_env%sum(ngcpat)
262 END IF
263
264 IF (unit_nr > 0) THEN
265 WRITE (unit_nr, "(T15,A,T61,F20.10)") " Total gCP energy [au] :", egcp
266 WRITE (unit_nr, "(T15,A,T61,F20.10)") " Total gCP energy [kcal] :", egcp*kcalmol
267 WRITE (unit_nr, *)
268 WRITE (unit_nr, "(T19,A)") " gCP atomic energy contributions"
269 WRITE (unit_nr, "(T19,A,T60,A20)") " # sites", " BSSE [kcal/mol]"
270 DO i = 1, natom
271 WRITE (unit_nr, "(12X,I8,10X,I8,T61,F20.10)") i, ngcpat(i), egcpat(i)*kcalmol
272 END DO
273 END IF
274 IF (calculate_forces) THEN
275 IF (unit_nr > 0) THEN
276 WRITE (unit_nr, *) " gCP Forces "
277 WRITE (unit_nr, *) " Atom Kind Forces "
278 END IF
279 gnorm = 0._dp
280 DO iatom = 1, natom
281 ikind = kind_of(iatom)
282 atom_a = atom_of_kind(iatom)
283 fdij(1:3) = force(ikind)%gcp(:, atom_a)
284 CALL para_env%sum(fdij)
285 gnorm = gnorm + sum(abs(fdij))
286 IF (unit_nr > 0) WRITE (unit_nr, "(i5,i7,3F20.14)") iatom, ikind, fdij
287 END DO
288 IF (unit_nr > 0) THEN
289 WRITE (unit_nr, *)
290 WRITE (unit_nr, *) " |G| = ", gnorm
291 WRITE (unit_nr, *)
292 END IF
293 IF (use_virial) THEN
294 dvirial = virial%pv_virial - dvirial
295 CALL para_env%sum(dvirial)
296 IF (unit_nr > 0) THEN
297 WRITE (unit_nr, *) " Stress Tensor (gCP)"
298 WRITE (unit_nr, "(3G20.12)") dvirial
299 WRITE (unit_nr, *) " Tr(P)/3 : ", (dvirial(1, 1) + dvirial(2, 2) + dvirial(3, 3))/3._dp
300 WRITE (unit_nr, *)
301 END IF
302 END IF
303 END IF
304 IF (verbose) THEN
305 DEALLOCATE (egcpat, ngcpat)
306 END IF
307
308 CALL timestop(handle)
309
310 END SUBROUTINE calculate_gcp_pairpot
311
312! **************************************************************************************************
313
314END MODULE qs_gcp_method
static GRID_HOST_DEVICE double fac(const int i)
Factorial function, e.g. fac(5) = 5! = 120.
Definition grid_common.h:48
Calculation of the overlap integrals over Cartesian Gaussian-type functions.
Definition ai_overlap.F:18
subroutine, public overlap_ab(la_max, la_min, npgfa, rpgfa, zeta, lb_max, lb_min, npgfb, rpgfb, zetb, rab, sab, dab, ddab)
Calculation of the two-center overlap integrals [a|b] over Cartesian Gaussian-type functions....
Definition ai_overlap.F:680
Define the atomic kind types and their sub types.
subroutine, public get_atomic_kind_set(atomic_kind_set, atom_of_kind, kind_of, natom_of_kind, maxatom, natom, nshell, fist_potential_present, shell_present, shell_adiabatic, shell_check_distance, damping_present)
Get attributes of an atomic kind set.
Holds information on atomic properties.
subroutine, public atprop_array_init(atarray, natom)
...
Handles all functions related to the CELL.
Definition cell_types.F:15
various routines to log and control the output. The idea is that decisions about where to log should ...
integer function, public cp_logger_get_default_io_unit(logger)
returns the unit nr for the ionode (-1 on all other processors) skips as well checks if the procs cal...
Defines the basic variable types.
Definition kinds.F:23
integer, parameter, public dp
Definition kinds.F:34
Interface to the message passing library MPI.
Define the data structure for the particle information.
Definition of physical constants:
Definition physcon.F:68
real(kind=dp), parameter, public kcalmol
Definition physcon.F:171
subroutine, public get_qs_env(qs_env, atomic_kind_set, qs_kind_set, cell, super_cell, cell_ref, use_ref_cell, kpoints, dft_control, mos, sab_orb, sab_all, qmmm, qmmm_periodic, sac_ae, sac_ppl, sac_lri, sap_ppnl, sab_vdw, sab_scp, sap_oce, sab_lrc, sab_se, sab_xtbe, sab_tbe, sab_core, sab_xb, sab_xtb_nonbond, sab_almo, sab_kp, sab_kp_nosym, particle_set, energy, force, matrix_h, matrix_h_im, matrix_ks, matrix_ks_im, matrix_vxc, run_rtp, rtp, matrix_h_kp, matrix_h_im_kp, matrix_ks_kp, matrix_ks_im_kp, matrix_vxc_kp, kinetic_kp, matrix_s_kp, matrix_w_kp, matrix_s_ri_aux_kp, matrix_s, matrix_s_ri_aux, matrix_w, matrix_p_mp2, matrix_p_mp2_admm, rho, rho_xc, pw_env, ewald_env, ewald_pw, active_space, mpools, input, para_env, blacs_env, scf_control, rel_control, kinetic, qs_charges, vppl, rho_core, rho_nlcc, rho_nlcc_g, ks_env, ks_qmmm_env, wf_history, scf_env, local_particles, local_molecules, distribution_2d, dbcsr_dist, molecule_kind_set, molecule_set, subsys, cp_subsys, oce, local_rho_set, rho_atom_set, task_list, task_list_soft, rho0_atom_set, rho0_mpole, rhoz_set, ecoul_1c, rho0_s_rs, rho0_s_gs, do_kpoints, has_unit_metric, requires_mo_derivs, mo_derivs, mo_loc_history, nkind, natom, nelectron_total, nelectron_spin, efield, neighbor_list_id, linres_control, xas_env, virial, cp_ddapc_env, cp_ddapc_ewald, outer_scf_history, outer_scf_ihistory, x_data, et_coupling, dftb_potential, results, se_taper, se_store_int_env, se_nddo_mpole, se_nonbond_env, admm_env, lri_env, lri_density, exstate_env, ec_env, dispersion_env, gcp_env, vee, rho_external, external_vxc, mask, mp2_env, bs_env, kg_env, wanniercentres, atprop, ls_scf_env, do_transport, transport_env, v_hartree_rspace, s_mstruct_changed, rho_changed, potential_changed, forces_up_to_date, mscfg_env, almo_scf_env, gradient_history, variable_history, embed_pot, spin_embed_pot, polar_env, mos_last_converged, rhs)
Get the QUICKSTEP environment.
Calculation of gCP pair potentials.
subroutine, public calculate_gcp_pairpot(qs_env, gcp_env, energy, calculate_forces, ategcp)
...
Definition of gCP types for DFT calculations.
Define the quickstep kind type and their sub types.
Define the neighbor list data types and the corresponding functionality.
subroutine, public neighbor_list_iterator_create(iterator_set, nl, search, nthread)
Neighbor list iterator functions.
subroutine, public neighbor_list_iterator_release(iterator_set)
...
integer function, public neighbor_list_iterate(iterator_set, mepos)
...
subroutine, public get_iterator_info(iterator_set, mepos, ikind, jkind, nkind, ilist, nlist, inode, nnode, iatom, jatom, r, cell)
...
pure subroutine, public virial_pair_force(pv_virial, f0, force, rab)
Computes the contribution to the stress tensor from two-body pair-wise forces.
Provides all information about an atomic kind.
type for the atomic properties
Type defining parameters related to the simulation cell.
Definition cell_types.F:55
stores all the informations relevant to an mpi environment
Provides all information about a quickstep kind.