47 USE dftd4,
ONLY: d4_model, &
50 get_rational_damping, &
55 rational_damping_param, &
56 get_coordination_number, &
58 USE dftd4_charge,
ONLY: get_charges
61#include "./base/base_uses.f90"
67 CHARACTER(len=*),
PARAMETER,
PRIVATE :: moduleN =
'qs_dispersion_d4'
87 TYPE(qs_environment_type),
POINTER :: qs_env
88 TYPE(qs_dispersion_type),
INTENT(IN),
POINTER :: dispersion_env
89 REAL(KIND=
dp),
INTENT(INOUT) :: evdw
90 LOGICAL,
INTENT(IN) :: calculate_forces
91 INTEGER,
INTENT(IN) :: iw
92 REAL(KIND=
dp),
DIMENSION(:),
OPTIONAL :: atomic_energy
94 CHARACTER(LEN=*),
PARAMETER :: routineN =
'calculate_dispersion_d4_pairpot'
96 INTEGER :: atoma, cnfun, enshift, handle, i, iatom, &
97 ikind, mref, natom, nghost
98 INTEGER,
ALLOCATABLE,
DIMENSION(:) :: atom_of_kind, atomtype, kind_of, &
100 INTEGER,
DIMENSION(3) :: periodic
101 LOGICAL :: debug, grad, ifloating, ighost, &
103 LOGICAL,
ALLOCATABLE,
DIMENSION(:) :: a_ghost
104 LOGICAL,
DIMENSION(3) :: lperiod
105 REAL(KIND=
dp) :: ed2, ed3, ev1, ev2, ev3, ev4, pd2, pd3, &
106 ta, tb, tc, td, te, ts
107 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:) :: cn, cnd, dedcn, dedq, edcn, edq, enerd2, &
108 enerd3, energies, energies3, q, qd
109 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:, :) :: ga, gradient, gwdcn, gwdq, gwvec, t_xyz, &
111 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:, :, :) :: gdeb
112 REAL(KIND=
dp),
DIMENSION(3, 3) :: sigma, stress
113 REAL(KIND=
dp),
DIMENSION(3, 3, 4) :: sdeb
114 TYPE(atomic_kind_type),
DIMENSION(:),
POINTER :: atomic_kind_set
115 TYPE(cell_type),
POINTER :: cell
116 TYPE(dcnum_type),
ALLOCATABLE,
DIMENSION(:) :: dcnum
117 TYPE(mp_para_env_type),
POINTER :: para_env
118 TYPE(particle_type),
DIMENSION(:),
POINTER :: particle_set
119 TYPE(qs_force_type),
DIMENSION(:),
POINTER :: force
120 TYPE(qs_kind_type),
DIMENSION(:),
POINTER :: qs_kind_set
121 TYPE(virial_type),
POINTER :: virial
123 CLASS(damping_param),
ALLOCATABLE :: param
124 TYPE(d4_model) :: disp
125 TYPE(structure_type) :: mol
126 TYPE(realspace_cutoff) :: cutoff
128 CALL timeset(routinen, handle)
130 debug = dispersion_env%d4_debug
132 CALL get_qs_env(qs_env=qs_env, particle_set=particle_set, atomic_kind_set=atomic_kind_set, &
133 cell=cell, force=force, virial=virial, para_env=para_env)
137 natom =
SIZE(particle_set)
139 ALLOCATE (t_xyz(3, natom), t_atomtype(natom), a_ghost(natom))
140 CALL get_qs_env(qs_env=qs_env, qs_kind_set=qs_kind_set)
142 t_xyz(:, iatom) = particle_set(iatom)%r(:)
143 ikind = kind_of(iatom)
144 CALL get_qs_kind(qs_kind_set(ikind), zatom=t_atomtype(iatom), ghost=ighost, floating=ifloating)
145 a_ghost(iatom) = ighost .OR. ifloating
146 IF (a_ghost(iatom)) nghost = nghost + 1
149 natom = natom - nghost
151 ALLOCATE (xyz(3, natom), atomtype(natom))
152 DO i = 1, natom + nghost
153 IF (.NOT. a_ghost(i))
THEN
155 xyz(:, iatom) = t_xyz(:, i)
156 atomtype(iatom) = t_atomtype(i)
159 DEALLOCATE (a_ghost, t_xyz, t_atomtype)
162 CALL get_cell(cell=cell, periodic=periodic)
163 lperiod(1) = periodic(1) == 1
164 lperiod(2) = periodic(2) == 1
165 lperiod(3) = periodic(3) == 1
172 CALL new(mol, atomtype, xyz, lattice=cell%hmat, periodic=lperiod)
173 CALL new_d4_model(disp, mol)
175 IF (dispersion_env%ref_functional ==
"none")
THEN
176 CALL get_rational_damping(
"pbe", param, s9=0.0_dp)
178 TYPE is (rational_damping_param)
179 param%s6 = dispersion_env%s6
180 param%s8 = dispersion_env%s8
181 param%a1 = dispersion_env%a1
182 param%a2 = dispersion_env%a2
183 param%alp = dispersion_env%alp
186 CALL get_rational_damping(dispersion_env%ref_functional, param, s9=dispersion_env%s9)
188 TYPE is (rational_damping_param)
189 dispersion_env%s6 = param%s6
190 dispersion_env%s8 = param%s8
191 dispersion_env%a1 = param%a1
192 dispersion_env%a2 = param%a2
193 dispersion_env%alp = param%alp
198 cutoff%cn = dispersion_env%rc_cn
200 cutoff%disp2 = dispersion_env%rc_d4*2._dp
202 cutoff%disp3 = dispersion_env%rc_disp*2._dp
203 IF (cutoff%disp3 > cutoff%disp2)
THEN
204 cpabort(
"D4: Three-body cutoff should be smaller than two-body cutoff")
207 IF (calculate_forces)
THEN
209 use_virial = virial%pv_availability .AND. (.NOT. virial%pv_numer)
215 IF (dispersion_env%d4_reference_code)
THEN
218 IF (.NOT. dispersion_env%doabc)
THEN
219 cpwarn(
"Using D4_REFERENCE_CODE enforces calculation of C9 term.")
222 ALLOCATE (gradient(3, natom))
223 CALL get_dispersion(mol, disp, param, cutoff, evdw, gradient, stress)
224 IF (calculate_forces)
THEN
226 virial%pv_virial = virial%pv_virial - stress/para_env%num_pe
229 ikind = kind_of(iatom)
230 atoma = atom_of_kind(iatom)
231 force(ikind)%dispersion(:, atoma) = &
232 force(ikind)%dispersion(:, atoma) + gradient(:, iatom)/para_env%num_pe
235 DEALLOCATE (gradient)
237 CALL get_dispersion(mol, disp, param, cutoff, evdw)
240 evdw = evdw/para_env%num_pe
241 IF (dispersion_env%ext_charges) dispersion_env%dcharges = 0.0_dp
242 IF (
PRESENT(atomic_energy))
THEN
243 cpwarn(
"Atomic energies not available for D4 reference code")
244 atomic_energy = 0.0_dp
250 WRITE (iw,
'(/,T2,A)')
'!-----------------------------------------------------------------------------!'
251 WRITE (iw, fmt=
"(T32,A)")
"DEBUG D4 DISPERSION"
252 WRITE (iw,
'(T2,A)')
'!-----------------------------------------------------------------------------!'
253 WRITE (iw,
'(A,T71,A10)')
" DEBUG D4| Reference functional ", trim(dispersion_env%ref_functional)
254 WRITE (iw,
'(A,T71,F10.4)')
" DEBUG D4| Scaling parameter (s6) ", dispersion_env%s6
255 WRITE (iw,
'(A,T71,F10.4)')
" DEBUG D4| Scaling parameter (s8) ", dispersion_env%s8
256 WRITE (iw,
'(A,T71,F10.4)')
" DEBUG D4| BJ Damping parameter (a1) ", dispersion_env%a1
257 WRITE (iw,
'(A,T71,F10.4)')
" DEBUG D4| BJ Damping parameter (a2) ", dispersion_env%a2
258 WRITE (iw,
'(A,T71,E10.4)')
" DEBUG D4| Cutoff value coordination numbers ", dispersion_env%eps_cn
259 WRITE (iw,
'(A,T71,F10.4)')
" DEBUG D4| Cutoff radius coordination numbers ", dispersion_env%rc_cn
260 WRITE (iw,
'(A,T71,I10)')
" DEBUG D4| Coordination number function type ", dispersion_env%cnfun
261 WRITE (iw,
'(A,T71,F10.4)')
" DEBUG D4| Cutoff radius 2-body terms [bohr]", 2._dp*dispersion_env%rc_d4
262 WRITE (iw,
'(A,T71,F10.4)')
" DEBUG D4| Cutoff radius 3-body terms [bohr]", 2._dp*dispersion_env%rc_disp
266 IF (debug .AND. iw > 0)
THEN
268 CALL refd4_debug(param, disp, mol, cutoff, grad, dispersion_env%doabc, &
269 enerd2, enerd3, cnd, qd, edcn, edq, gdeb, sdeb)
277 mref = maxval(disp%ref)
279 cnfun = dispersion_env%cnfun
281 IF (debug .AND. iw > 0)
THEN
282 WRITE (iw,
'(A,T71,F10.6)')
" DEBUG D4| CN differences (max)", maxval(abs(cn - cnd))
283 WRITE (iw,
'(A,T71,F10.6)')
" DEBUG D4| CN differences (ave)", sum(abs(cn - cnd))/natom
288 IF (dispersion_env%ext_charges)
THEN
289 q(1:natom) = dispersion_env%charges(1:natom)
291 CALL eeq_charges(qs_env, q, dispersion_env%eeq_sparam, 2, enshift)
293 IF (debug .AND. iw > 0)
THEN
294 WRITE (iw,
'(A,T71,F10.6)')
" DEBUG D4| Charge differences (max)", maxval(abs(q - qd))
295 WRITE (iw,
'(A,T71,F10.6)')
" DEBUG D4| Charge differences (ave)", sum(abs(q - qd))/natom
298 ALLOCATE (gwvec(mref, natom))
299 IF (grad)
ALLOCATE (gwdcn(mref, natom), gwdq(mref, natom))
300 CALL disp%weight_references(mol, cn, q, gwvec, gwdcn, gwdq)
302 ALLOCATE (energies(natom))
305 ALLOCATE (gradient(3, natom), ga(3, natom))
306 ALLOCATE (dedcn(natom), dedq(natom))
307 dedcn(:) = 0.0_dp; dedq(:) = 0.0_dp
311 CALL dispersion_2b(dispersion_env, cutoff%disp2, disp%r4r2, &
312 gwvec, gwdcn, gwdq, disp%c6, disp%ref, &
313 energies, dedcn, dedq, grad, ga, sigma)
315 gradient(1:3, 1:natom) = ga(1:3, 1:natom)
318 CALL para_env%sum(ga)
319 CALL para_env%sum(sigma)
321 CALL gerror(ga, gdeb(:, :, 1), ev1, ev2, ev3, ev4)
322 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| RMS error Gradient [2B]", ev1, ev2,
" %"
323 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Gradient [2B]", ev3, ev4,
" %"
325 CALL serror(sigma, sdeb(:, :, 1), ev1, ev2)
326 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Stress [2B]", ev1, ev2,
" %"
334 IF (dispersion_env%ext_charges)
THEN
335 dispersion_env%dcharges = dedq
337 CALL para_env%sum(dedq)
340 CALL eeq_forces(qs_env, q, dedq, ga, sigma, dispersion_env%eeq_sparam, &
341 2, enshift, response_only=.true.)
342 gradient(1:3, 1:natom) = gradient(1:3, 1:natom) + ga(1:3, 1:natom)
343 stress = stress + sigma
345 CALL para_env%sum(ga)
346 CALL para_env%sum(sigma)
348 CALL verror(dedq, edq, ev1, ev2)
349 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Derivative dEdq", ev1, ev2,
" %"
350 CALL gerror(ga, gdeb(:, :, 2), ev1, ev2, ev3, ev4)
351 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| RMS error Gradient [dEdq]", ev1, ev2,
" %"
352 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Gradient [dEdq]", ev3, ev4,
" %"
354 CALL serror(sigma, sdeb(:, :, 2), ev1, ev2)
355 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Stress [dEdq]", ev1, ev2,
" %"
362 IF (dispersion_env%doabc)
THEN
363 ALLOCATE (energies3(natom))
364 energies3(:) = 0.0_dp
367 CALL disp%weight_references(mol, cn, q, gwvec, gwdcn, gwdq)
374 CALL get_lattice_points(mol%periodic, mol%lattice, cutoff%disp3, tvec)
375 CALL dispersion_3b(qs_env, dispersion_env, tvec, cutoff%disp3, disp%r4r2, &
376 gwvec, gwdcn, gwdq, disp%c6, disp%ref, &
377 energies3, dedcn, dedq, grad, ga, sigma)
379 gradient(1:3, 1:natom) = gradient(1:3, 1:natom) + ga(1:3, 1:natom)
380 stress = stress + sigma
382 CALL para_env%sum(ga)
383 CALL para_env%sum(sigma)
385 CALL gerror(ga, gdeb(:, :, 3), ev1, ev2, ev3, ev4)
386 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| RMS error Gradient [3B]", ev1, ev2,
" %"
387 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Gradient [3B]", ev3, ev4,
" %"
389 CALL serror(sigma, sdeb(:, :, 3), ev1, ev2)
390 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Stress [3B]", ev1, ev2,
" %"
398 CALL para_env%sum(dedcn)
401 CALL dedcn_force(qs_env, dedcn, dcnum, ga, sigma)
402 gradient(1:3, 1:natom) = gradient(1:3, 1:natom) + ga(1:3, 1:natom)
403 stress = stress + sigma
405 CALL para_env%sum(ga)
406 CALL para_env%sum(sigma)
408 CALL verror(dedcn, edcn, ev1, ev2)
409 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Derivative dEdcn", ev1, ev2,
" %"
410 CALL gerror(ga, gdeb(:, :, 4), ev1, ev2, ev3, ev4)
411 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| RMS error Gradient [dEdcn]", ev1, ev2,
" %"
412 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Gradient [dEdcn]", ev3, ev4,
" %"
414 CALL serror(sigma, sdeb(:, :, 4), ev1, ev2)
415 WRITE (iw,
'(A,T51,F14.10,T69,F10.4,A)')
" DEBUG D4| MAV error Stress [dEdcn]", ev1, ev2,
" %"
427 CALL para_env%sum(ta)
431 pd2 = abs(ed2)/abs(tb)*100.
432 WRITE (iw,
'(A,T51,F14.8,T69,F10.4,A)')
" DEBUG D4| Energy error 2-body", ed2, pd2,
" %"
434 IF (dispersion_env%doabc)
THEN
436 CALL para_env%sum(ta)
440 pd3 = abs(ed3)/abs(tb)*100.
441 WRITE (iw,
'(A,T51,F14.8,T69,F10.4,A)')
" DEBUG D4| Energy error 3-body", ed3, pd3,
" %"
445 WRITE (iw,
'(A,T67,F14.4)')
" DEBUG D4| Time for reference code [s]", td
446 WRITE (iw,
'(A,T67,F14.4)')
" DEBUG D4| Time for production code [s]", tc
450 IF (dispersion_env%doabc)
THEN
451 energies(:) = energies(:) + energies3(:)
454 IF (
PRESENT(atomic_energy))
THEN
455 atomic_energy(1:natom) = energies(1:natom)
458 IF (use_virial .AND. calculate_forces)
THEN
459 virial%pv_virial = virial%pv_virial - stress
461 IF (calculate_forces)
THEN
463 ikind = kind_of(iatom)
464 atoma = atom_of_kind(iatom)
465 force(ikind)%dispersion(:, atoma) = &
466 force(ikind)%dispersion(:, atoma) + gradient(:, iatom)
470 DEALLOCATE (energies)
471 IF (dispersion_env%doabc)
DEALLOCATE (energies3)
473 DEALLOCATE (gradient, ga)
478 DEALLOCATE (xyz, atomtype)
480 CALL timestop(handle)
501 SUBROUTINE refd4_debug(param, disp, mol, cutoff, grad, doabc, &
502 enerd2, enerd3, cnd, qd, dEdcn, dEdq, gradient, stress)
503 CLASS(damping_param) :: param
504 TYPE(d4_model) :: disp
505 TYPE(structure_type) :: mol
506 TYPE(realspace_cutoff) :: cutoff
507 LOGICAL,
INTENT(IN) :: grad, doabc
508 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:) :: enerd2, enerd3, cnd, qd, dedcn, dedq
509 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:, :, :) :: gradient
510 REAL(KIND=
dp),
DIMENSION(3, 3, 4) :: stress
512 INTEGER :: mref, natom, i
513 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:) :: q, qq
514 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:, :) :: lattr, gwdcn, gwdq, gwvec, &
516 REAL(KIND=
dp),
ALLOCATABLE,
DIMENSION(:, :, :) :: cndr, cndl, qdr, qdl
518 mref = maxval(disp%ref)
522 ALLOCATE (cnd(natom))
523 IF (grad)
ALLOCATE (cndr(3, natom, natom), cndl(3, 3, natom))
524 CALL get_lattice_points(mol%periodic, mol%lattice, cutoff%cn, lattr)
525 CALL get_coordination_number(mol, lattr, cutoff%cn, disp%rcov, disp%en, &
529 IF (grad)
ALLOCATE (qdr(3, natom, natom), qdl(3, 3, natom))
530 CALL get_charges(mol, qd, qdr, qdl)
532 ALLOCATE (gwvec(mref, natom))
533 IF (grad)
ALLOCATE (gwdcn(mref, natom), gwdq(mref, natom))
534 CALL disp%weight_references(mol, cnd, qd, gwvec, gwdcn, gwdq)
535 ALLOCATE (c6(natom, natom))
536 IF (grad)
ALLOCATE (dc6dcn(natom, natom), dc6dq(natom, natom))
537 CALL disp%get_atomic_c6(mol, gwvec, gwdcn, gwdq, c6, dc6dcn, dc6dq)
538 CALL get_lattice_points(mol%periodic, mol%lattice, cutoff%disp2, lattr)
541 ALLOCATE (gradient(3, natom, 4))
546 ALLOCATE (enerd2(natom))
549 ALLOCATE (dedcn(natom), dedq(natom))
550 dedcn(:) = 0.0_dp; dedq(:) = 0.0_dp
552 CALL param%get_dispersion2(mol, lattr, cutoff%disp2, disp%r4r2, c6, dc6dcn, dc6dq, &
553 enerd2, dedcn, dedq, gradient(:, :, 1), stress(:, :, 1))
557 gradient(i, :, 2) = matmul(qdr(i, :, :), dedq(:))
558 stress(i, :, 2) = matmul(qdl(i, :, :), dedq(:))
563 ALLOCATE (q(natom), qq(natom))
564 q(:) = 0.0_dp; qq(:) = 0.0_dp
565 ALLOCATE (enerd3(natom))
567 CALL disp%weight_references(mol, cnd, q, gwvec, gwdcn, gwdq)
568 CALL disp%get_atomic_c6(mol, gwvec, gwdcn, gwdq, c6, dc6dcn, dc6dq)
569 CALL get_lattice_points(mol%periodic, mol%lattice, cutoff%disp3, lattr)
570 CALL param%get_dispersion3(mol, lattr, cutoff%disp3, disp%r4r2, c6, dc6dcn, dc6dq, &
571 enerd3, dedcn, qq, gradient(:, :, 3), stress(:, :, 3))
575 gradient(i, :, 4) = matmul(cndr(i, :, :), dedcn(:))
576 stress(i, :, 4) = matmul(cndl(i, :, :), dedcn(:))
580 END SUBROUTINE refd4_debug
597 REAL(kind=
dp),
INTENT(INOUT) :: evdw
598 LOGICAL,
INTENT(IN) :: calculate_forces
599 INTEGER,
INTENT(IN) :: iw
600 REAL(kind=
dp),
DIMENSION(:),
OPTIONAL :: atomic_energy
603 mark_used(dispersion_env)
605 mark_used(calculate_forces)
607 mark_used(atomic_energy)
609 cpabort(
"CP2K build without DFTD4")
632 SUBROUTINE dispersion_2b(dispersion_env, cutoff, r4r2, &
633 gwvec, gwdcn, gwdq, c6ref, mrefs, &
634 energies, dEdcn, dEdq, &
635 calculate_forces, gradient, stress)
637 REAL(kind=
dp),
INTENT(IN) :: cutoff
638 REAL(kind=
dp),
DIMENSION(:),
INTENT(IN) :: r4r2
639 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(IN) :: gwvec, gwdcn, gwdq
640 REAL(kind=
dp),
DIMENSION(:, :, :, :),
INTENT(IN) :: c6ref
641 INTEGER,
DIMENSION(:),
INTENT(IN) :: mrefs
642 REAL(kind=
dp),
DIMENSION(:),
INTENT(INOUT) :: energies, dedcn, dedq
643 LOGICAL,
INTENT(IN) :: calculate_forces
644 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(INOUT) :: gradient, stress
646 INTEGER :: iatom, ikind, jatom, jkind, mepos, num_pe
647 REAL(kind=
dp) :: a1, a2, c6ij, cutoff2, d6, d8, de, dr2, &
648 edisp,
fac, gdisp, r0ij, rrij, s6, s8, &
650 REAL(kind=
dp),
DIMENSION(2) :: dcdcn, dcdq
651 REAL(kind=
dp),
DIMENSION(3) :: dg, rij
652 REAL(kind=
dp),
DIMENSION(3, 3) :: ds
654 DIMENSION(:),
POINTER :: nl_iterator
658 a1 = dispersion_env%a1
659 a2 = dispersion_env%a2
660 s6 = dispersion_env%s6
661 s8 = dispersion_env%s8
662 cutoff2 = cutoff*cutoff
664 sab_vdw => dispersion_env%sab_vdw
672 iatom=iatom, jatom=jatom, r=rij)
675 IF (dr2 <= cutoff2 .AND. dr2 > 0.0000001_dp)
THEN
676 rrij = 3._dp*r4r2(ikind)*r4r2(jkind)
677 r0ij = a1*sqrt(rrij) + a2
678 IF (calculate_forces)
THEN
679 CALL get_c6derivs(c6ij, dcdcn, dcdq, iatom, jatom, ikind, jkind, &
680 gwvec, gwdcn, gwdq, c6ref, mrefs)
682 CALL get_c6value(c6ij, iatom, jatom, ikind, jkind, gwvec, c6ref, mrefs)
685 IF (iatom == jatom)
fac = 0.5_dp
686 t6 = 1.0_dp/(dr2**3 + r0ij**6)
687 t8 = 1.0_dp/(dr2**4 + r0ij**8)
689 edisp = (s6*t6 + s8*rrij*t8)*
fac
691 energies(iatom) = energies(iatom) + de*0.5_dp
692 energies(jatom) = energies(jatom) + de*0.5_dp
694 IF (calculate_forces)
THEN
695 d6 = -6.0_dp*dr2**2*t6**2
696 d8 = -8.0_dp*dr2**3*t8**2
697 gdisp = (s6*d6 + s8*rrij*d8)*
fac
698 dg(:) = -c6ij*gdisp*rij(:)
699 gradient(:, iatom) = gradient(:, iatom) - dg
700 gradient(:, jatom) = gradient(:, jatom) + dg
701 ds(:, :) = spread(dg, 1, 3)*spread(rij, 2, 3)
702 stress(:, :) = stress(:, :) + ds(:, :)
703 dedcn(iatom) = dedcn(iatom) - dcdcn(1)*edisp
704 dedq(iatom) = dedq(iatom) - dcdq(1)*edisp
705 dedcn(jatom) = dedcn(jatom) - dcdcn(2)*edisp
706 dedq(jatom) = dedq(jatom) - dcdq(2)*edisp
713 END SUBROUTINE dispersion_2b
734 SUBROUTINE dispersion_3b(qs_env, dispersion_env, tvec, cutoff, r4r2, &
735 gwvec, gwdcn, gwdq, c6ref, mrefs, &
736 energies, dEdcn, dEdq, &
737 calculate_forces, gradient, stress)
740 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(IN) :: tvec
741 REAL(kind=
dp),
INTENT(IN) :: cutoff
742 REAL(kind=
dp),
DIMENSION(:),
INTENT(IN) :: r4r2
743 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(IN) :: gwvec, gwdcn, gwdq
744 REAL(kind=
dp),
DIMENSION(:, :, :, :),
INTENT(IN) :: c6ref
745 INTEGER,
DIMENSION(:),
INTENT(IN) :: mrefs
746 REAL(kind=
dp),
DIMENSION(:),
INTENT(INOUT) :: energies, dedcn, dedq
747 LOGICAL,
INTENT(IN) :: calculate_forces
748 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(INOUT) :: gradient, stress
750 INTEGER :: iatom, ikind, jatom, jkind, katom, &
751 kkind, ktr, mepos, natom, num_pe
752 INTEGER,
ALLOCATABLE,
DIMENSION(:) :: kind_of
753 INTEGER,
DIMENSION(3) :: cell_b
754 REAL(kind=
dp) :: a1, a2, alp, ang, c6ij, c6ik, c6jk, c9, &
755 cutoff2, dang, de, dfdmp,
fac, fdmp, &
756 r0, r0ij, r0ik, r0jk, r1, r2, r2ij, &
757 r2ik, r2jk, r3, r5, rr, s6, s8, s9
758 REAL(kind=
dp),
ALLOCATABLE,
DIMENSION(:, :) :: rcpbc
759 REAL(kind=
dp),
DIMENSION(2) :: dc6dcnij, dc6dcnik, dc6dcnjk, dc6dqij, &
761 REAL(kind=
dp),
DIMENSION(3) :: dgij, dgik, dgjk, ra, rb, rb0, rij, vij, &
763 REAL(kind=
dp),
DIMENSION(3, 3) :: ds
767 DIMENSION(:),
POINTER :: nl_iterator
772 CALL get_qs_env(qs_env=qs_env, natom=natom, cell=cell, &
773 atomic_kind_set=atomic_kind_set, particle_set=particle_set)
775 ALLOCATE (rcpbc(3, natom))
777 rcpbc(:, iatom) =
pbc(particle_set(iatom)%r(:), cell)
781 a1 = dispersion_env%a1
782 a2 = dispersion_env%a2
783 s6 = dispersion_env%s6
784 s8 = dispersion_env%s8
785 s9 = dispersion_env%s9
786 alp = dispersion_env%alp
790 sab_vdw => dispersion_env%sab_vdw
797 CALL get_iterator_info(nl_iterator, mepos=mepos, ikind=ikind, jkind=jkind, iatom=iatom, jatom=jatom, r=rij)
799 r2ij = sum(rij(:)**2)
800 IF (calculate_forces)
THEN
801 CALL get_c6derivs(c6ij, dc6dcnij, dc6dqij, iatom, jatom, ikind, jkind, &
802 gwvec, gwdcn, gwdq, c6ref, mrefs)
804 CALL get_c6value(c6ij, iatom, jatom, ikind, jkind, gwvec, c6ref, mrefs)
806 r0ij = a1*sqrt(3._dp*r4r2(jkind)*r4r2(ikind)) + a2
807 IF (r2ij <= cutoff2 .AND. r2ij > epsilon(1._dp))
THEN
809 rb0(:) = matmul(cell%hmat, cell_b)
810 ra(:) = rcpbc(:, iatom)
811 rb(:) = rcpbc(:, jatom) + rb0
812 vij(:) = rb(:) - ra(:)
814 DO katom = 1, min(iatom, jatom)
815 kkind = kind_of(katom)
816 IF (calculate_forces)
THEN
817 CALL get_c6derivs(c6ik, dc6dcnik, dc6dqik, katom, iatom, kkind, ikind, &
818 gwvec, gwdcn, gwdq, c6ref, mrefs)
819 CALL get_c6derivs(c6jk, dc6dcnjk, dc6dqjk, katom, jatom, kkind, jkind, &
820 gwvec, gwdcn, gwdq, c6ref, mrefs)
822 CALL get_c6value(c6ik, katom, iatom, kkind, ikind, gwvec, c6ref, mrefs)
823 CALL get_c6value(c6jk, katom, jatom, kkind, jkind, gwvec, c6ref, mrefs)
825 c9 = -s9*sqrt(abs(c6ij*c6ik*c6jk))
826 r0ik = a1*sqrt(3._dp*r4r2(kkind)*r4r2(ikind)) + a2
827 r0jk = a1*sqrt(3._dp*r4r2(kkind)*r4r2(jkind)) + a2
829 fac = triple_scale(iatom, jatom, katom)
830 DO ktr = 1,
SIZE(tvec, 2)
831 vik(:) = rcpbc(:, katom) + tvec(:, ktr) - rcpbc(:, iatom)
832 r2ik = vik(1)*vik(1) + vik(2)*vik(2) + vik(3)*vik(3)
833 IF (r2ik > cutoff2 .OR. r2ik < epsilon(1.0_dp)) cycle
834 vjk(:) = rcpbc(:, katom) + tvec(:, ktr) - rb(:)
835 r2jk = vjk(1)*vjk(1) + vjk(2)*vjk(2) + vjk(3)*vjk(3)
836 IF (r2jk > cutoff2 .OR. r2jk < epsilon(1.0_dp)) cycle
842 fdmp = 1.0_dp/(1.0_dp + 6.0_dp*(r0/r1)**(alp/3.0_dp))
843 ang = 0.375_dp*(r2ij + r2jk - r2ik)*(r2ij - r2jk + r2ik)* &
844 (-r2ij + r2jk + r2ik)/r5 + 1.0_dp/r3
848 energies(iatom) = energies(iatom) - de/3._dp
849 energies(jatom) = energies(jatom) - de/3._dp
850 energies(katom) = energies(katom) - de/3._dp
852 IF (calculate_forces)
THEN
854 dfdmp = -2.0_dp*alp*(r0/r1)**(alp/3.0_dp)*fdmp**2
857 dang = -0.375_dp*(r2ij**3 + r2ij**2*(r2jk + r2ik) &
858 + r2ij*(3.0_dp*r2jk**2 + 2.0_dp*r2jk*r2ik &
860 - 5.0_dp*(r2jk - r2ik)**2*(r2jk + r2ik))/r5
861 dgij(:) = c9*(-dang*fdmp + ang*dfdmp)/r2ij*vij
864 dang = -0.375_dp*(r2ik**3 + r2ik**2*(r2jk + r2ij) &
865 + r2ik*(3.0_dp*r2jk**2 + 2.0_dp*r2jk*r2ij &
867 - 5.0_dp*(r2jk - r2ij)**2*(r2jk + r2ij))/r5
868 dgik(:) = c9*(-dang*fdmp + ang*dfdmp)/r2ik*vik
871 dang = -0.375_dp*(r2jk**3 + r2jk**2*(r2ik + r2ij) &
872 + r2jk*(3.0_dp*r2ik**2 + 2.0_dp*r2ik*r2ij &
874 - 5.0_dp*(r2ik - r2ij)**2*(r2ik + r2ij))/r5
875 dgjk(:) = c9*(-dang*fdmp + ang*dfdmp)/r2jk*vjk
877 gradient(:, iatom) = gradient(:, iatom) - dgij - dgik
878 gradient(:, jatom) = gradient(:, jatom) + dgij - dgjk
879 gradient(:, katom) = gradient(:, katom) + dgik + dgjk
881 ds(:, :) = spread(dgij, 1, 3)*spread(vij, 2, 3) &
882 + spread(dgik, 1, 3)*spread(vik, 2, 3) &
883 + spread(dgjk, 1, 3)*spread(vjk, 2, 3)
885 stress(:, :) = stress + ds*
fac
887 dedcn(iatom) = dedcn(iatom) - de*0.5_dp &
888 *(dc6dcnij(1)/c6ij + dc6dcnik(2)/c6ik)
889 dedcn(jatom) = dedcn(jatom) - de*0.5_dp &
890 *(dc6dcnij(2)/c6ij + dc6dcnjk(2)/c6jk)
891 dedcn(katom) = dedcn(katom) - de*0.5_dp &
892 *(dc6dcnik(1)/c6ik + dc6dcnjk(1)/c6jk)
894 dedq(iatom) = dedq(iatom) - de*0.5_dp &
895 *(dc6dqij(1)/c6ij + dc6dqik(2)/c6ik)
896 dedq(jatom) = dedq(jatom) - de*0.5_dp &
897 *(dc6dqij(2)/c6ij + dc6dqjk(2)/c6jk)
898 dedq(katom) = dedq(katom) - de*0.5_dp &
899 *(dc6dqik(1)/c6ik + dc6dqjk(1)/c6jk)
912 END SUBROUTINE dispersion_3b
921 FUNCTION triple_scale(ii, jj, kk)
RESULT(triple)
922 INTEGER,
INTENT(IN) :: ii, jj, kk
923 REAL(kind=
dp) :: triple
928 triple = 1.0_dp/6.0_dp
934 IF (ii /= kk .AND. jj /= kk)
THEN
943 END FUNCTION triple_scale
953 SUBROUTINE dedcn_force(qs_env, dEdcn, dcnum, gradient, stress)
955 REAL(kind=
dp),
DIMENSION(:),
INTENT(IN) :: dedcn
956 TYPE(
dcnum_type),
DIMENSION(:),
INTENT(IN) :: dcnum
957 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(INOUT) :: gradient
958 REAL(kind=
dp),
DIMENSION(3, 3),
INTENT(INOUT) :: stress
960 CHARACTER(len=*),
PARAMETER :: routinen =
'dEdcn_force'
962 INTEGER :: handle, i, ia, iatom, ikind, katom, &
964 LOGICAL :: use_virial
966 REAL(kind=
dp),
DIMENSION(3) :: fdik, rik
970 CALL timeset(routinen, handle)
972 CALL get_qs_env(qs_env, nkind=nkind, natom=natom, &
973 local_particles=local_particles, &
975 use_virial = virial%pv_availability .AND. (.NOT. virial%pv_numer)
978 DO ia = 1, local_particles%n_el(ikind)
979 iatom = local_particles%list(ikind)%array(ia)
980 DO i = 1, dcnum(iatom)%neighbors
981 katom = dcnum(iatom)%nlist(i)
982 rik = dcnum(iatom)%rik(:, i)
983 drk = sqrt(sum(rik(:)**2))
984 fdik(:) = -(dedcn(iatom) + dedcn(katom))*dcnum(iatom)%dvals(i)*rik(:)/drk
985 gradient(:, iatom) = gradient(:, iatom) + fdik(:)
993 CALL timestop(handle)
995 END SUBROUTINE dedcn_force
1008 SUBROUTINE get_c6value(c6ij, ia, ja, ik, jk, gwvec, c6ref, mrefs)
1009 REAL(kind=
dp),
INTENT(OUT) :: c6ij
1010 INTEGER,
INTENT(IN) :: ia, ja, ik, jk
1011 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(IN) :: gwvec
1012 REAL(kind=
dp),
DIMENSION(:, :, :, :),
INTENT(IN) :: c6ref
1013 INTEGER,
DIMENSION(:),
INTENT(IN) :: mrefs
1015 INTEGER :: iref, jref
1016 REAL(kind=
dp) :: refc6
1019 DO jref = 1, mrefs(jk)
1020 DO iref = 1, mrefs(ik)
1021 refc6 = c6ref(iref, jref, ik, jk)
1022 c6ij = c6ij + gwvec(iref, ia)*gwvec(jref, ja)*refc6
1026 END SUBROUTINE get_c6value
1043 SUBROUTINE get_c6derivs(c6ij, dc6dcn, dc6dq, ia, ja, ik, jk, &
1044 gwvec, gwdcn, gwdq, c6ref, mrefs)
1045 REAL(kind=
dp),
INTENT(OUT) :: c6ij
1046 REAL(kind=
dp),
DIMENSION(2),
INTENT(OUT) :: dc6dcn, dc6dq
1047 INTEGER,
INTENT(IN) :: ia, ja, ik, jk
1048 REAL(kind=
dp),
DIMENSION(:, :),
INTENT(IN) :: gwvec, gwdcn, gwdq
1049 REAL(kind=
dp),
DIMENSION(:, :, :, :),
INTENT(IN) :: c6ref
1050 INTEGER,
DIMENSION(:),
INTENT(IN) :: mrefs
1052 INTEGER :: iref, jref
1053 REAL(kind=
dp) :: refc6
1058 DO jref = 1, mrefs(jk)
1059 DO iref = 1, mrefs(ik)
1060 refc6 = c6ref(iref, jref, ik, jk)
1061 c6ij = c6ij + gwvec(iref, ia)*gwvec(jref, ja)*refc6
1062 dc6dcn(1) = dc6dcn(1) + gwdcn(iref, ia)*gwvec(jref, ja)*refc6
1063 dc6dcn(2) = dc6dcn(2) + gwvec(iref, ia)*gwdcn(jref, ja)*refc6
1064 dc6dq(1) = dc6dq(1) + gwdq(iref, ia)*gwvec(jref, ja)*refc6
1065 dc6dq(2) = dc6dq(2) + gwvec(iref, ia)*gwdq(jref, ja)*refc6
1069 END SUBROUTINE get_c6derivs
1080 SUBROUTINE gerror(ga, gd, ev1, ev2, ev3, ev4)
1081 REAL(kind=
dp),
DIMENSION(:, :) :: ga, gd
1082 REAL(kind=
dp),
INTENT(OUT) :: ev1, ev2, ev3, ev4
1084 INTEGER :: na, np(2)
1087 ev1 = sqrt(sum((gd - ga)**2)/na)
1088 ev2 = ev1/sqrt(sum(gd**2)/na)*100._dp
1089 np = maxloc(abs(gd - ga))
1090 ev3 = abs(gd(np(1), np(2)) - ga(np(1), np(2)))
1091 ev4 = abs(gd(np(1), np(2)))
1092 IF (ev4 > 1.e-6)
THEN
1093 ev4 = ev3/ev4*100._dp
1098 END SUBROUTINE gerror
1107 SUBROUTINE serror(sa, sd, ev1, ev2)
1108 REAL(kind=
dp),
DIMENSION(3, 3) :: sa, sd
1109 REAL(kind=
dp),
INTENT(OUT) :: ev1, ev2
1112 REAL(kind=
dp) :: rel
1114 ev1 = maxval(abs(sd - sa))
1118 IF (abs(sd(i, j)) > 1.e-6_dp)
THEN
1119 rel = abs(sd(i, j) - sa(i, j))/abs(sd(i, j))*100._dp
1125 END SUBROUTINE serror
1134 SUBROUTINE verror(va, vd, ev1, ev2)
1135 REAL(kind=
dp),
DIMENSION(:) :: va, vd
1136 REAL(kind=
dp),
INTENT(OUT) :: ev1, ev2
1139 REAL(kind=
dp) :: rel
1142 ev1 = maxval(abs(vd - va))
1145 IF (abs(vd(i)) > 1.e-8_dp)
THEN
1146 rel = abs(vd(i) - va(i))/abs(vd(i))*100._dp
1151 END SUBROUTINE verror
static GRID_HOST_DEVICE double fac(const int i)
Factorial function, e.g. fac(5) = 5! = 120.
Define the atomic kind types and their sub types.
subroutine, public get_atomic_kind_set(atomic_kind_set, atom_of_kind, kind_of, natom_of_kind, maxatom, natom, nshell, fist_potential_present, shell_present, shell_adiabatic, shell_check_distance, damping_present)
Get attributes of an atomic kind set.
subroutine, public get_atomic_kind(atomic_kind, fist_potential, element_symbol, name, mass, kind_number, natom, atom_list, rcov, rvdw, z, qeff, apol, cpol, mm_radius, shell, shell_active, damping)
Get attributes of an atomic kind.
Handles all functions related to the CELL.
subroutine, public get_cell(cell, alpha, beta, gamma, deth, orthorhombic, abc, periodic, h, h_inv, symmetry_id, tag)
Get informations about a simulation cell.
real(kind=dp) function, public plane_distance(h, k, l, cell)
Calculate the distance between two lattice planes as defined by a triple of Miller indices (hkl).
stores a lists of integer that are local to a processor. The idea is that these integers represent ob...
Calculation of charge equilibration method.
subroutine, public eeq_forces(qs_env, charges, dcharges, gradient, stress, eeq_sparam, eeq_model, enshift_type, response_only)
...
subroutine, public eeq_charges(qs_env, charges, eeq_sparam, eeq_model, enshift_type)
...
Defines the basic variable types.
integer, parameter, public dp
Machine interface based on Fortran 2003 and POSIX.
subroutine, public m_flush(lunit)
flushes units if the &GLOBAL flag is set accordingly
real(kind=dp) function, public m_walltime()
returns time from a real-time clock, protected against rolling early/easily
Interface to the message passing library MPI.
Define the data structure for the particle information.
Coordination number routines for dispersion pairpotentials.
subroutine, public cnumber_release(cnumbers, dcnum, derivatives)
...
subroutine, public cnumber_init(qs_env, cnumbers, dcnum, ftype, derivatives, disp_env)
...
Calculation of dispersion using pair potentials.
subroutine, public calculate_dispersion_d4_pairpot(qs_env, dispersion_env, evdw, calculate_forces, iw, atomic_energy)
...
Definition of disperson types for DFT calculations.
Set disperson types for DFT calculations.
integer function, public cellhash(cell, ncell)
...
subroutine, public get_qs_env(qs_env, atomic_kind_set, qs_kind_set, cell, super_cell, cell_ref, use_ref_cell, kpoints, dft_control, mos, sab_orb, sab_all, qmmm, qmmm_periodic, sac_ae, sac_ppl, sac_lri, sap_ppnl, sab_vdw, sab_scp, sap_oce, sab_lrc, sab_se, sab_xtbe, sab_tbe, sab_core, sab_xb, sab_xtb_pp, sab_xtb_nonbond, sab_almo, sab_kp, sab_kp_nosym, 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, harris_env, dispersion_env, gcp_env, vee, rho_external, external_vxc, mask, mp2_env, bs_env, kg_env, wanniercentres, atprop, ls_scf_env, do_transport, transport_env, v_hartree_rspace, s_mstruct_changed, rho_changed, potential_changed, forces_up_to_date, mscfg_env, almo_scf_env, gradient_history, variable_history, embed_pot, spin_embed_pot, polar_env, mos_last_converged, eeq, rhs)
Get the QUICKSTEP environment.
Define the quickstep kind type and their sub types.
subroutine, public get_qs_kind(qs_kind, basis_set, basis_type, ncgf, nsgf, all_potential, tnadd_potential, gth_potential, sgp_potential, upf_potential, se_parameter, dftb_parameter, xtb_parameter, dftb3_param, zatom, zeff, elec_conf, mao, lmax_dftb, alpha_core_charge, ccore_charge, core_charge, core_charge_radius, paw_proj_set, paw_atom, hard_radius, hard0_radius, max_rad_local, covalent_radius, vdw_radius, gpw_type_forced, harmonics, max_iso_not0, max_s_harm, grid_atom, ngrid_ang, ngrid_rad, lmax_rho0, dft_plus_u_atom, l_of_dft_plus_u, n_of_dft_plus_u, u_minus_j, u_of_dft_plus_u, j_of_dft_plus_u, alpha_of_dft_plus_u, beta_of_dft_plus_u, j0_of_dft_plus_u, occupation_of_dft_plus_u, dispersion, bs_occupation, magnetization, no_optimize, addel, laddel, naddel, orbitals, max_scf, eps_scf, smear, u_ramping, u_minus_j_target, eps_u_ramping, init_u_ramping_each_scf, reltmat, ghost, floating, name, element_symbol, pao_basis_size, pao_model_file, pao_potentials, pao_descriptors, nelec)
Get attributes of an atomic kind.
subroutine, public set_qs_kind(qs_kind, paw_atom, ghost, floating, hard_radius, hard0_radius, covalent_radius, vdw_radius, lmax_rho0, zeff, no_optimize, dispersion, u_minus_j, reltmat, dftb_parameter, xtb_parameter, elec_conf, pao_basis_size)
Set the components of an atomic kind data set.
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 defining parameters related to the simulation cell.
structure to store local (to a processor) ordered lists of integers.
stores all the informations relevant to an mpi environment
Provides all information about a quickstep kind.