34 use,
intrinsic :: iso_fortran_env
64 real(real64),
allocatable :: c6free(:)
65 real(real64),
allocatable :: dpfree(:)
66 real(real64),
allocatable :: r0free(:)
67 real(real64),
allocatable :: c6abfree(:, :)
68 real(real64),
allocatable :: volfree(:)
69 real(real64),
allocatable :: c6ab(:, :)
70 real(real64) :: cutoff
71 real(real64) :: damping
74 real(real64),
allocatable :: derivative_coeff(:)
80 type(vdw_ts_t),
intent(out) :: this
81 type(namespace_t),
intent(in) :: namespace
82 type(ions_t),
intent(in) :: ions
84 integer :: ispecies, jspecies
85 real(real64) :: num, den
123 safe_allocate(this%c6free(1:ions%nspecies))
124 safe_allocate(this%dpfree(1:ions%nspecies))
125 safe_allocate(this%r0free(1:ions%nspecies))
126 safe_allocate(this%volfree(1:ions%nspecies))
127 safe_allocate(this%c6abfree(1:ions%nspecies, 1:ions%nspecies))
128 safe_allocate(this%c6ab(1:ions%natoms, 1:ions%natoms))
129 safe_allocate(this%derivative_coeff(1:ions%natoms))
131 do ispecies = 1, ions%nspecies
132 call get_vdw_param(namespace, ions%species(ispecies)%s%get_label(), &
133 this%c6free(ispecies), this%dpfree(ispecies), this%r0free(ispecies))
134 select type(spec=>ions%species(ispecies)%s)
142 do ispecies = 1, ions%nspecies
143 do jspecies = 1, ions%nspecies
144 num =
m_two*this%c6free(ispecies)*this%c6free(jspecies)
145 den = (this%dpfree(jspecies)/this%dpfree(ispecies))*this%c6free(ispecies) &
146 + (this%dpfree(ispecies)/this%dpfree(jspecies))*this%c6free(jspecies)
147 this%c6abfree(ispecies, jspecies) = num/den
156 type(vdw_ts_t),
intent(inout) :: this
160 safe_deallocate_a(this%c6free)
161 safe_deallocate_a(this%dpfree)
162 safe_deallocate_a(this%r0free)
163 safe_deallocate_a(this%volfree)
164 safe_deallocate_a(this%c6abfree)
165 safe_deallocate_a(this%c6ab)
166 safe_deallocate_a(this%derivative_coeff)
173 subroutine vdw_ts_calculate(this, namespace, space, latt, atom, natoms, pos, mesh, nspin, density, energy, potential, force)
174 type(
vdw_ts_t),
intent(inout) :: this
176 class(
space_t),
intent(in) :: space
178 type(
atom_t),
intent(in) :: atom(:)
179 integer,
intent(in) :: natoms
180 real(real64),
intent(in) :: pos(1:space%dim,1:natoms)
181 class(
mesh_t),
intent(in) :: mesh
182 integer,
intent(in) :: nspin
183 real(real64),
intent(in) :: density(:, :)
184 real(real64),
intent(out) :: energy
185 real(real64),
contiguous,
intent(out) :: potential(:)
186 real(real64),
intent(out) :: force(:, :)
189 subroutine f90_vdw_calculate(natoms, dd, sr, zatom, coordinates, vol_ratio, &
190 energy, force, derivative_coeff)
191 use,
intrinsic :: iso_fortran_env
193 integer,
intent(in) :: natoms
194 real(real64),
intent(in) :: dd
195 real(real64),
intent(in) :: sr
196 integer,
intent(in) :: zatom
197 real(real64),
intent(in) :: coordinates
198 real(real64),
intent(in) :: vol_ratio
199 real(real64),
intent(out) :: energy
200 real(real64),
intent(out) :: force
201 real(real64),
intent(out) :: derivative_coeff
202 end subroutine f90_vdw_calculate
206 integer :: iatom, jatom, ispecies, jspecies, jcopy, ip
207 real(real64) :: rr, rr6, dffdr0, ee, ff, dee, dffdrab, dffdvra, deabdvra
208 real(real64),
allocatable :: coordinates(:,:), vol_ratio(:), dvadens(:), dvadrr(:), &
209 dr0dvra(:), r0ab(:,:)
211 integer,
allocatable :: zatom(:)
212 real(real64) :: x_j(space%dim)
216 safe_allocate(vol_ratio(1:natoms))
217 safe_allocate(dvadens(1:mesh%np))
218 safe_allocate(dvadrr(1:3))
219 safe_allocate(dr0dvra(1:natoms))
222 force(1:space%dim, 1:natoms) =
m_zero
223 this%derivative_coeff(1:natoms) =
m_zero
224 call hirshfeld_init(hirshfeld, mesh, namespace, space, latt, atom, natoms, pos, nspin)
231 ispecies = atom(iatom)%species%get_index()
234 jspecies = atom(jatom)%species%get_index()
236 this%c6ab(iatom,jatom) = vol_ratio(iatom)*vol_ratio(jatom)*this%c6abfree(ispecies,jspecies)
240 if (space%is_periodic())
then
241 safe_allocate(r0ab(1:natoms,1:natoms))
245 ispecies = atom(iatom)%species%get_index()
247 jspecies = atom(jatom)%species%get_index()
249 r0ab(iatom,jatom) = (vol_ratio(iatom)**(
m_one/
m_three))*this%r0free(ispecies) &
250 + (vol_ratio(jatom)**(
m_one/
m_three))*this%r0free(jspecies)
256 jspecies = atom(jatom)%species%get_index()
258 do jcopy = 1, latt_iter%n_cells
259 x_j = pos(:, jatom) + latt_iter%get(jcopy)
262 ispecies = atom(iatom)%species%get_index()
263 rr = norm2(x_j - pos(:, iatom))
266 if (rr < 1.0e-10_real64) cycle
268 ee =
exp(-this%damping * ((rr / (this%sr*r0ab(iatom, jatom))) -
m_one))
273 dffdrab = (this%damping/(this%sr*r0ab(iatom, jatom)))*dee
275 dffdr0 = -this%damping*rr/(this%sr*r0ab(iatom, jatom)**2)*dee
277 energy = energy -
m_half*ff*this%c6ab(iatom, jatom)/rr6
280 dffdvra = dffdr0*dr0dvra(iatom)
283 deabdvra = (dffdvra*this%c6ab(iatom, jatom) + ff*vol_ratio(jatom)*this%c6abfree(ispecies, jspecies))/rr6
285 this%derivative_coeff(iatom) = this%derivative_coeff(iatom) + deabdvra
291 safe_deallocate_a(r0ab)
293 safe_allocate(coordinates(1:space%dim, 1:natoms))
294 safe_allocate(zatom(1:natoms))
297 coordinates(:, iatom) = pos(:, iatom)
298 zatom(iatom) = int(atom(iatom)%species%get_z())
302 call f90_vdw_calculate(natoms, this%damping, this%sr, zatom(1), coordinates(1, 1), &
303 vol_ratio(1), energy, force(1, 1), this%derivative_coeff(1))
306 safe_deallocate_a(coordinates)
307 safe_deallocate_a(zatom)
314 call lalg_axpy(mesh%np, -this%derivative_coeff(iatom), dvadens, potential)
323 safe_deallocate_a(vol_ratio)
324 safe_deallocate_a(dvadens)
325 safe_deallocate_a(dvadrr)
326 safe_deallocate_a(dr0dvra)
336 type(
ions_t),
intent(in) :: ions
337 real(real64),
intent(inout) :: force_vdw(1:ions%space%dim, 1:ions%natoms)
338 class(
mesh_t),
intent(in) :: mesh
339 integer,
intent(in) :: nspin
340 real(real64),
intent(in) :: density(:, :)
345 integer :: iatom, jatom, ispecies, jspecies, jcopy
346 real(real64) :: rr, rr6, dffdr0, ee, ff, dee, dffdvra, deabdvra, deabdrab, x_j(ions%space%dim)
347 real(real64),
allocatable :: vol_ratio(:), dvadrr(:), dr0dvra(:), r0ab(:,:), derivative_coeff(:), c6ab(:,:)
353 safe_allocate(vol_ratio(1:ions%natoms))
354 safe_allocate(dvadrr(1:3))
355 safe_allocate(dr0dvra(1:ions%natoms))
356 safe_allocate(r0ab(1:ions%natoms,1:ions%natoms))
357 safe_allocate(derivative_coeff(1:ions%natoms))
358 safe_allocate(c6ab(1:ions%natoms,1:ions%natoms))
361 force_vdw(1:ions%space%dim, 1:ions%natoms) =
m_zero
362 derivative_coeff(1:ions%natoms) =
m_zero
363 c6ab(1:ions%natoms,1:ions%natoms) =
m_zero
364 r0ab(1:ions%natoms,1:ions%natoms) =
m_zero
365 dr0dvra(1:ions%natoms) =
m_zero
366 dvadrr(1:ions%space%dim) =
m_zero
367 vol_ratio(1:ions%natoms) =
m_zero
370 call hirshfeld_init(hirshfeld, mesh, ions%namespace, ions%space, ions%latt, ions%atom, ions%natoms, ions%pos, nspin)
373 do iatom = 1, ions%natoms
377 do iatom = 1, ions%natoms
378 ispecies = ions%atom(iatom)%species%get_index()
380 do jatom = 1, ions%natoms
381 jspecies = ions%atom(jatom)%species%get_index()
382 c6ab(iatom, jatom) = vol_ratio(iatom)*vol_ratio(jatom)*this%c6abfree(ispecies, jspecies)
387 do iatom = 1, ions%natoms
388 ispecies = ions%atom(iatom)%species%get_index()
389 do jatom = iatom, ions%natoms
390 jspecies = ions%atom(jatom)%species%get_index()
392 r0ab(iatom, jatom) = (vol_ratio(iatom)**(
m_one/
m_three))*this%r0free(ispecies) &
393 + (vol_ratio(jatom)**(
m_one/
m_three))*this%r0free(jspecies)
394 if (iatom /= jatom) r0ab(jatom, iatom) = r0ab(iatom, jatom)
399 do jatom = 1, ions%natoms
400 jspecies = ions%atom(jatom)%species%get_index()
402 do jcopy = 1, latt_iter%n_cells
403 x_j = ions%pos(:, jatom) + latt_iter%get(jcopy)
404 do iatom = 1, ions%natoms
405 ispecies = ions%atom(iatom)%species%get_index()
406 rr = norm2(x_j - ions%pos(:, iatom))
411 ee =
exp(-this%damping*(rr/(this%sr*r0ab(iatom, jatom)) -
m_one))
415 dffdr0 = -this%damping*rr/( this%sr*r0ab(iatom, jatom)**2)*dee
417 deabdrab = c6ab(iatom,jatom)*(this%damping/(this%sr*r0ab(iatom, jatom))*dee - 6.0_real64*ff/rr)/rr6
419 dffdvra = dffdr0*dr0dvra(iatom)
421 deabdvra = (dffdvra*c6ab(iatom, jatom) + ff*vol_ratio(jatom)*this%c6abfree(ispecies, jspecies))/rr6
423 derivative_coeff(iatom) = derivative_coeff(iatom) + deabdvra
426 deabdrab = c6ab(iatom, jatom)*(this%damping/(this%sr*r0ab(iatom, jatom))*dee - 6.0_real64*ff/rr)/rr6
427 force_vdw(:, iatom) = force_vdw(:, iatom) +
m_half*deabdrab*(ions%pos(:, iatom) - x_j)/rr
432 do iatom = 1, ions%natoms
433 do jatom = 1, ions%natoms
437 force_vdw(:, jatom)= force_vdw(:, jatom) + derivative_coeff(iatom)*dvadrr
443 safe_deallocate_a(vol_ratio)
444 safe_deallocate_a(dvadrr)
445 safe_deallocate_a(dr0dvra)
446 safe_deallocate_a(r0ab)
447 safe_deallocate_a(derivative_coeff)
448 safe_deallocate_a(c6ab)
458 type(
vdw_ts_t) ,
intent(inout) :: this
459 type(
ions_t),
intent(in) :: ions
460 character(len=*),
intent(in) :: dir, fname
463 integer :: iunit, iatom, jatom
469 iunit =
io_open(trim(dir) //
"/" // trim(fname), namespace, action=
'write')
470 write(iunit,
'(a)')
' # Atom1 Atom2 C6_{12}^{eff}'
473 do iatom = 1, ions%natoms
474 do jatom = 1, ions%natoms
475 write(iunit,
'(3x, i5, i5, e15.6)') iatom, jatom, this%c6ab(iatom, jatom)
491 character(len=*),
intent(in) :: atom
492 real(real64),
intent(out) :: c6
493 real(real64),
intent(out) :: alpha
494 real(real64),
intent(out) :: r0
498 select case (trim(atom))
501 alpha = 4.500000_real64
506 alpha = 1.380000_real64
511 alpha = 164.200000_real64
512 c6 = 1387.000000_real64
516 alpha = 38.000000_real64
517 c6 = 214.000000_real64
521 alpha = 21.000000_real64
522 c6 = 99.500000_real64
526 alpha = 12.000000_real64
527 c6 = 46.600000_real64
531 alpha = 7.400000_real64
532 c6 = 24.200000_real64
536 alpha = 5.400000_real64
537 c6 = 15.600000_real64
541 alpha = 3.800000_real64
546 alpha = 2.670000_real64
551 alpha = 162.700000_real64
552 c6 = 1556.000000_real64
556 alpha = 71.000000_real64
557 c6 = 627.000000_real64
561 alpha = 60.000000_real64
562 c6 = 528.000000_real64
566 alpha = 37.000000_real64
567 c6 = 305.000000_real64
571 alpha = 25.000000_real64
572 c6 = 185.000000_real64
576 alpha = 19.600000_real64
577 c6 = 134.000000_real64
581 alpha = 15.000000_real64
582 c6 = 94.600000_real64
586 alpha = 11.100000_real64
587 c6 = 64.300000_real64
591 alpha = 292.900000_real64
592 c6 = 3897.000000_real64
596 alpha = 160.000000_real64
597 c6 = 2221.000000_real64
601 alpha = 120.000000_real64
602 c6 = 1383.000000_real64
606 alpha = 98.000000_real64
607 c6 = 1044.000000_real64
611 alpha = 84.000000_real64
612 c6 = 832.000000_real64
616 alpha = 78.000000_real64
617 c6 = 602.000000_real64
621 alpha = 63.000000_real64
622 c6 = 552.000000_real64
626 alpha = 56.000000_real64
627 c6 = 482.000000_real64
631 alpha = 50.000000_real64
632 c6 = 408.000000_real64
636 alpha = 48.000000_real64
637 c6 = 373.000000_real64
641 alpha = 42.000000_real64
642 c6 = 253.000000_real64
646 alpha = 40.000000_real64
647 c6 = 284.000000_real64
651 alpha = 60.000000_real64
652 c6 = 498.000000_real64
656 alpha = 41.000000_real64
657 c6 = 354.000000_real64
661 alpha = 29.000000_real64
662 c6 = 246.000000_real64
666 alpha = 25.000000_real64
667 c6 = 210.000000_real64
671 alpha = 20.000000_real64
672 c6 = 162.000000_real64
676 alpha = 16.800000_real64
677 c6 = 129.600000_real64
681 alpha = 319.200000_real64
682 c6 = 4691.000000_real64
686 alpha = 199.000000_real64
687 c6 = 3170.000000_real64
696 alpha = 23.680000_real64
697 c6 = 157.500000_real64
701 alpha = 50.600000_real64
702 c6 = 339.000000_real64
716 alpha = 35.000000_real64
717 c6 = 385.000000_real64
721 alpha = 27.300000_real64
722 c6 = 285.900000_real64
762 call messages_write(
'vdw ts: reference free atom parameters not available for species '//trim(atom))
constant times a vector plus a vector
double exp(double __x) __attribute__((__nothrow__
type(debug_t), save, public debug
real(real64), parameter, public m_two
real(real64), parameter, public m_zero
real(real64), parameter, public m_half
real(real64), parameter, public m_one
real(real64), parameter, public m_three
subroutine, public hirshfeld_init(this, mesh, namespace, space, latt, atom, natoms, pos, nspin)
real(real64), parameter, public tol_hirshfeld
subroutine, public hirshfeld_end(this)
subroutine, public hirshfeld_density_derivative(this, iatom, ddensity)
subroutine, public hirshfeld_position_derivative(this, space, iatom, jatom, density, dposition)
subroutine, public hirshfeld_volume_ratio(this, iatom, density, volume_ratio)
subroutine, public dio_function_output(how, dir, fname, namespace, space, mesh, ff, unit, ierr, pos, atoms, grp, root)
Top-level IO routine for functions defined on the mesh.
subroutine, public io_close(iunit, grp)
subroutine, public io_mkdir(fname, namespace, parents)
integer function, public io_open(file, namespace, action, status, form, position, die, recl, grp)
This module defines the meshes, which are used in Octopus.
subroutine, public messages_fatal(no_lines, only_root_writes, namespace)
logical function mpi_grp_is_root(grp)
Is the current MPI process of grpcomm, root.
type(mpi_grp_t), public mpi_world
subroutine, public profiling_out(label)
Increment out counter and sum up difference between entry and exit time.
subroutine, public profiling_in(label, exclude)
Increment in counter and save entry time.
real(real64) function, public ps_density_volume(ps, namespace)
brief This module defines the class unit_t which is used by the unit_systems_oct_m module.
This module defines the unit system, used for input and output.
type(unit_system_t), public units_inp
the units systems for reading and writing
type(unit_t), public unit_one
some special units required for particular quantities
Tkatchenko-Scheffler pairwise method for van der Waals (vdW, dispersion) interactions.
subroutine, public vdw_ts_init(this, namespace, ions)
subroutine, public vdw_ts_calculate(this, namespace, space, latt, atom, natoms, pos, mesh, nspin, density, energy, potential, force)
Calculate the potential for the Tatchenko-Scheffler vdW correction as described in Phys....
subroutine, public vdw_ts_write_c6ab(this, ions, dir, fname, namespace)
subroutine get_vdw_param(namespace, atom, c6, alpha, r0)
subroutine, public vdw_ts_force_calculate(this, force_vdw, ions, mesh, nspin, density)
subroutine, public vdw_ts_end(this)
The following class implements a lattice iterator. It allows one to loop over all cells that are with...
Describes mesh distribution to nodes.