80#include "../base/base_uses.f90"
99 SUBROUTINE cp_eval_at(gopt_env, x, f, gradient, master, &
100 final_evaluation, para_env)
106 TYPE(gopt_f_type),
POINTER :: gopt_env
107 REAL(KIND=
dp),
DIMENSION(:),
POINTER :: x
108 REAL(KIND=
dp),
INTENT(out),
OPTIONAL :: f
109 REAL(KIND=
dp),
DIMENSION(:),
OPTIONAL, &
111 INTEGER,
INTENT(IN) :: master
112 LOGICAL,
INTENT(IN),
OPTIONAL :: final_evaluation
113 TYPE(mp_para_env_type),
POINTER :: para_env
119 CHARACTER(len=*),
PARAMETER,
PRIVATE :: moduleN =
'bfgs_optimizer'
120 LOGICAL,
PARAMETER :: debug_this_module = .true.
137 RECURSIVE SUBROUTINE geoopt_bfgs(force_env, gopt_param, globenv, geo_section, gopt_env, x0)
143 TYPE(gopt_f_type),
POINTER :: gopt_env
144 REAL(kind=dp),
DIMENSION(:),
POINTER :: x0
146 CHARACTER(len=*),
PARAMETER :: routinen =
'geoopt_bfgs'
147 REAL(kind=dp),
PARAMETER :: one = 1.0_dp, zero = 0.0_dp
149 CHARACTER(LEN=5) :: wildcard
150 CHARACTER(LEN=default_path_length) :: hes_filename
151 INTEGER :: handle, hesunit_read, indf, info, &
152 iter_nr, its, maxiter, ndf, nfree, &
154 LOGICAL :: conv, hesrest, ionode, shell_present, &
155 should_stop, use_mod_hes, use_rfo
156 REAL(kind=dp) :: ediff, emin, eold, etot, pred, rad, rat, &
157 step, t_diff, t_now, t_old
158 REAL(kind=dp),
ALLOCATABLE,
DIMENSION(:) :: dg, dr, dx, eigval, gold, work, xold
159 REAL(kind=dp),
DIMENSION(:),
POINTER :: g
163 TYPE(
cp_fm_type) :: eigvec_mat, hess_mat, hess_tmp
165 TYPE(mp_para_env_type),
POINTER :: para_env
170 NULLIFY (logger, g, blacs_env, spgr)
172 para_env => force_env%para_env
173 root_section => force_env%root_section
174 spgr => gopt_env%spgr
177 CALL timeset(routinen, handle)
180 ionode = para_env%is_source()
181 maxiter = gopt_param%max_iter
188 SELECT CASE (gopt_env%type_id)
190 cpabort(
"BFGS method not yet working with DIMER")
198 IF (output_unit > 0)
THEN
200 WRITE (unit=output_unit, fmt=
"(/,T2,A,T78,A3)") &
201 "BFGS| Use rational function optimization for step estimation: ",
"YES"
203 WRITE (unit=output_unit, fmt=
"(/,T2,A,T78,A3)") &
204 "BFGS| Use rational function optimization for step estimation: ",
" NO"
206 IF (use_mod_hes)
THEN
207 WRITE (unit=output_unit, fmt=
"(T2,A,T78,A3)") &
208 "BFGS| Use model Hessian for initial guess: ",
"YES"
210 WRITE (unit=output_unit, fmt=
"(T2,A,T78,A3)") &
211 "BFGS| Use model Hessian for initial guess: ",
" NO"
214 WRITE (unit=output_unit, fmt=
"(T2,A,T78,A3)") &
215 "BFGS| Restart Hessian: ",
"YES"
217 WRITE (unit=output_unit, fmt=
"(T2,A,T78,A3)") &
218 "BFGS| Restart Hessian: ",
" NO"
220 WRITE (unit=output_unit, fmt=
"(T2,A,T61,F20.3)") &
221 "BFGS| Trust radius: ", rad
225 nfree = gopt_env%nfree
227 CALL cp_warn(__location__, &
228 "The dimension of the Hessian matrix ("// &
229 trim(adjustl(
cp_to_string(ndf)))//
") is greater than 3000. "// &
230 "The diagonalisation of the full Hessian matrix needed for BFGS "// &
231 "is computationally expensive. You should consider to use the linear "// &
232 "scaling variant L-BFGS instead.")
236 globenv%blacs_repeatable)
238 nrow_global=ndf, ncol_global=ndf)
239 CALL cp_fm_create(hess_mat, fm_struct_hes, name=
"hess_mat")
240 CALL cp_fm_create(hess_tmp, fm_struct_hes, name=
"hess_tmp")
241 CALL cp_fm_create(eigvec_mat, fm_struct_hes, name=
"eigvec_mat")
242 ALLOCATE (eigval(ndf))
248 IF (use_mod_hes)
THEN
249 IF (shell_present)
THEN
250 CALL cp_warn(__location__, &
251 "No model Hessian is available for core-shell models. "// &
252 "A unit matrix is used as the initial Hessian.")
253 use_mod_hes = .false.
256 CALL cp_warn(__location__, &
257 "No model Hessian is available for cell optimizations. "// &
258 "A unit matrix is used as the initial Hessian.")
259 use_mod_hes = .false.
263 IF (use_mod_hes)
THEN
265 CALL construct_initial_hess(gopt_env%force_env, hess_mat)
271 IF (output_unit > 0)
WRITE (output_unit, *) &
272 "BFGS: Matrix diagonalization failed, using unity as model Hessian."
274 DO its = 1,
SIZE(eigval)
275 IF (eigval(its) .LT. 0.1_dp) eigval(its) = 0.1_dp
279 CALL parallel_gemm(
"N",
"T", ndf, ndf, ndf, one, hess_tmp, eigvec_mat, zero, hess_mat)
308 IF (spgr%keep_space_group)
THEN
315 CALL cp_iterate(logger%iter_info, increment=0, iter_nr_out=iter_nr)
319 CALL cp_eval_at(gopt_env, x0, etot, g, gopt_env%force_env%para_env%mepos, &
320 .false., gopt_env%force_env%para_env)
323 IF (spgr%keep_space_group)
THEN
331 t_diff = t_now - t_old
333 CALL gopt_f_io_init(gopt_env, output_unit, etot, wildcard=wildcard, its=iter_nr, used_time=t_diff)
334 DO its = iter_nr + 1, maxiter
335 CALL cp_iterate(logger%iter_info, last=(its == maxiter))
340 IF (((its - iter_nr) == 1) .AND. hesrest)
THEN
343 IF (len_trim(hes_filename) == 0)
THEN
345 hes_filename = trim(logger%iter_info%project_name)//
"-BFGS.Hessian"
347 IF (output_unit > 0)
THEN
348 WRITE (unit=output_unit, fmt=
"(/,T2,A)") &
349 "BFGS| Checking for Hessian restart file <"//trim(adjustl(hes_filename))//
">"
351 CALL open_file(file_name=trim(hes_filename), file_status=
"OLD", &
352 file_form=
"UNFORMATTED", file_action=
"READ", unit_number=hesunit_read)
353 IF (output_unit > 0)
THEN
354 WRITE (unit=output_unit, fmt=
"(T2,A)") &
355 "BFGS| Hessian restart file read"
359 IF (ionode)
CALL close_file(unit_number=hesunit_read)
361 IF ((its - iter_nr) > 1)
THEN
363 IF (spgr%keep_space_group)
THEN
369 dx(indf) = x0(indf) - xold(indf)
370 dg(indf) = g(indf) - gold(indf)
373 CALL bfgs(ndf, dx, dg, hess_mat, work, para_env)
376 IF (spgr%keep_space_group)
THEN
383 CALL write_bfgs_hessian(geo_section, hess_mat, logger)
389 IF (spgr%keep_space_group)
THEN
405 IF (output_unit > 0)
WRITE (output_unit, *) &
406 "BFGS: Matrix diagonalization failed, resetting Hessian to unity."
413 CALL set_hes_eig(ndf, eigval, work)
415 CALL rat_fun_opt(ndf, dg, eigval, work, eigvec_mat, g, para_env)
417 CALL geoopt_get_step(ndf, eigval, eigvec_mat, hess_tmp, dr, g, para_env, use_rfo)
420 IF (spgr%keep_space_group)
THEN
424 CALL trust_radius(ndf, step, rad, rat, dr, output_unit)
430 IF (spgr%keep_space_group)
THEN
434 CALL energy_predict(ndf, work, hess_mat, dr, g, conv, pred, para_env)
438 CALL cp_eval_at(gopt_env, x0, etot, g, gopt_env%force_env%para_env%mepos, &
439 .false., gopt_env%force_env%para_env)
444 IF (spgr%keep_space_group)
THEN
450 IF (should_stop)
EXIT
454 t_diff = t_now - t_old
456 CALL gopt_f_io(gopt_env, force_env, root_section, its, etot, output_unit, &
457 eold, emin, wildcard, gopt_param, ndf, dr, g, conv, pred, rat, &
458 step, rad, used_time=t_diff)
460 IF (conv .OR. (its == maxiter))
EXIT
461 IF (etot < emin) emin = etot
462 IF (use_rfo)
CALL update_trust_rad(rat, rad, step, ediff)
465 IF (its == maxiter .AND. (.NOT. conv))
THEN
470 CALL cp_iterate(logger%iter_info, last=.true., increment=0)
471 CALL write_bfgs_hessian(geo_section, hess_mat, logger)
473 gopt_env%force_env%para_env, gopt_env%force_env%para_env%mepos, output_unit)
491 "PRINT%PROGRAM_RUN_INFO")
492 CALL timestop(handle)
506 SUBROUTINE rat_fun_opt(ndf, dg, eigval, work, eigvec_mat, g, para_env)
508 INTEGER,
INTENT(IN) :: ndf
509 REAL(kind=dp),
INTENT(INOUT) :: dg(ndf), eigval(ndf), work(ndf)
511 REAL(kind=dp),
INTENT(INOUT) :: g(ndf)
512 TYPE(mp_para_env_type),
OPTIONAL,
POINTER :: para_env
514 CHARACTER(LEN=*),
PARAMETER :: routinen =
'rat_fun_opt'
515 REAL(kind=dp),
PARAMETER :: one = 1.0_dp
517 INTEGER :: handle, i, indf, iref, iter, j, k, l, &
518 maxit, ncol_local, nrow_local
519 INTEGER,
DIMENSION(:),
POINTER :: col_indices, row_indices
520 LOGICAL :: bisec, fail, set
521 REAL(kind=dp) :: fun, fun1, fun2, fun3, fung, lam1, lam2, &
522 ln, lp, ssize, step, stol
523 REAL(kind=dp),
CONTIGUOUS,
DIMENSION(:, :),
POINTER :: local_data
525 CALL timeset(routinen, handle)
535 CALL cp_fm_get_info(eigvec_mat, row_indices=row_indices, col_indices=col_indices, &
536 local_data=local_data, nrow_local=nrow_local, ncol_local=ncol_local)
542 dg(l) = dg(l) + local_data(i, k)*g(j)
545 CALL para_env%sum(dg)
556 IF (eigval(iref) < 0.0_dp) ln = eigval(iref) - 0.01_dp
564 fun = fun + dg(indf)**2/(ln - eigval(indf))
565 fung = fung - dg(indf)**2/(ln - eigval(indf)**2)
571 IF (abs(step) < stol)
GOTO 200
572 IF (iter >= maxit)
EXIT
579 IF (eigval(iref) < 0.0_dp) lam1 = eigval(iref) - 0.01_dp
582 fun1 = fun1 + dg(indf)**2/(lam1 - eigval(indf))
585 step = abs(lam1)/1000.0_dp
586 IF (step < ssize) step = ssize
589 IF (iter > maxit)
THEN
596 lam2 = lam1 - iter*step
598 fun2 = fun2 + eigval(indf)**2/(lam2 - eigval(indf))
601 IF (fun2*fun1 < 0.0_dp)
THEN
605 IF (iter > maxit)
THEN
611 step = (lam1 + lam2)/2
614 fun3 = fun3 + dg(indf)**2/(step - eigval(indf))
618 IF (abs(step - lam2) < stol)
THEN
623 IF (fun3*fun1 < stol)
THEN
633 IF ((ln > eigval(iref)) .OR. ((ln > 0.0_dp) .AND. &
634 (eigval(iref) > 0.0_dp)))
THEN
636 IF (.NOT. bisec)
GOTO 100
644 IF (fail .AND. .NOT. set)
THEN
647 eigval(indf) = eigval(indf)*work(indf)
657 eigval(indf) = eigval(indf) - ln
662 CALL timestop(handle)
664 END SUBROUTINE rat_fun_opt
675 SUBROUTINE bfgs(ndf, dx, dg, hess_mat, work, para_env)
676 INTEGER,
INTENT(IN) :: ndf
677 REAL(kind=dp),
INTENT(INOUT) :: dx(ndf), dg(ndf)
679 REAL(kind=dp),
INTENT(INOUT) :: work(ndf)
680 TYPE(mp_para_env_type),
OPTIONAL,
POINTER :: para_env
682 CHARACTER(LEN=*),
PARAMETER :: routinen =
'bfgs'
683 REAL(kind=dp),
PARAMETER :: one = 1.0_dp, zero = 0.0_dp
685 INTEGER :: handle, i, j, k, l, ncol_local, &
687 INTEGER,
DIMENSION(:),
POINTER :: col_indices, row_indices
688 REAL(kind=dp) :: ddot, dxw, gdx
689 REAL(kind=dp),
CONTIGUOUS,
DIMENSION(:, :),
POINTER :: local_hes
691 CALL timeset(routinen, handle)
693 CALL cp_fm_get_info(hess_mat, row_indices=row_indices, col_indices=col_indices, &
694 local_data=local_hes, nrow_local=nrow_local, ncol_local=ncol_local)
701 work(j) = work(j) + local_hes(i, k)*dx(l)
705 CALL para_env%sum(work)
707 gdx = ddot(ndf, dg, 1, dx, 1)
709 dxw = ddot(ndf, dx, 1, work, 1)
716 local_hes(i, k) = local_hes(i, k) + gdx*dg(j)*dg(l) - &
721 CALL timestop(handle)
731 SUBROUTINE set_hes_eig(ndf, eigval, work)
732 INTEGER,
INTENT(IN) :: ndf
733 REAL(kind=dp),
INTENT(INOUT) :: eigval(ndf), work(ndf)
735 CHARACTER(LEN=*),
PARAMETER :: routinen =
'set_hes_eig'
736 REAL(kind=dp),
PARAMETER :: max_neg = -0.5_dp, max_pos = 5.0_dp, &
737 min_eig = 0.005_dp, one = 1.0_dp
739 INTEGER :: handle, indf
742 CALL timeset(routinen, handle)
745 IF (eigval(indf) < 0.0_dp) neg = .true.
746 IF (eigval(indf) > 1000.0_dp) eigval(indf) = 1000.0_dp
749 IF (eigval(indf) < 0.0_dp)
THEN
750 IF (eigval(indf) < max_neg)
THEN
751 eigval(indf) = max_neg
752 ELSE IF (eigval(indf) > -min_eig)
THEN
753 eigval(indf) = -min_eig
755 ELSE IF (eigval(indf) < 1000.0_dp)
THEN
756 IF (eigval(indf) < min_eig)
THEN
757 eigval(indf) = min_eig
758 ELSE IF (eigval(indf) > max_pos)
THEN
759 eigval(indf) = max_pos
765 IF (eigval(indf) < 0.0_dp)
THEN
772 CALL timestop(handle)
774 END SUBROUTINE set_hes_eig
787 SUBROUTINE geoopt_get_step(ndf, eigval, eigvec_mat, hess_tmp, dr, g, para_env, use_rfo)
789 INTEGER,
INTENT(IN) :: ndf
790 REAL(kind=dp),
INTENT(INOUT) :: eigval(ndf)
791 TYPE(
cp_fm_type),
INTENT(IN) :: eigvec_mat, hess_tmp
792 REAL(kind=dp),
INTENT(INOUT) :: dr(ndf), g(ndf)
793 TYPE(mp_para_env_type),
OPTIONAL,
POINTER :: para_env
796 REAL(kind=dp),
PARAMETER :: one = 1.0_dp, zero = 0.0_dp
798 INTEGER :: i, indf, j, k, l, ncol_local, nrow_local
799 INTEGER,
DIMENSION(:),
POINTER :: col_indices, row_indices
800 REAL(kind=dp),
CONTIGUOUS,
DIMENSION(:, :),
POINTER :: local_data
807 eigval(indf) = one/eigval(indf)
811 eigval(indf) = one/max(0.0001_dp, eigval(indf))
819 CALL parallel_gemm(
"N",
"T", ndf, ndf, ndf, one, hess_tmp, eigvec_mat, zero, tmp)
826 CALL cp_fm_get_info(hess_tmp, row_indices=row_indices, col_indices=col_indices, &
827 local_data=local_data, nrow_local=nrow_local, ncol_local=ncol_local)
834 dr(j) = dr(j) - local_data(i, k)*g(l)
838 CALL para_env%sum(dr)
840 END SUBROUTINE geoopt_get_step
851 SUBROUTINE trust_radius(ndf, step, rad, rat, dr, output_unit)
852 INTEGER,
INTENT(IN) :: ndf
853 REAL(kind=dp),
INTENT(INOUT) :: step, rad, rat, dr(ndf)
854 INTEGER,
INTENT(IN) :: output_unit
856 CHARACTER(LEN=*),
PARAMETER :: routinen =
'trust_radius'
857 REAL(kind=dp),
PARAMETER :: one = 1.0_dp
860 REAL(kind=dp) :: scal
862 CALL timeset(routinen, handle)
864 step = maxval(abs(dr))
865 scal = max(one, rad/step)
869 CALL dscal(ndf, rat, dr, 1)
871 IF (output_unit > 0)
THEN
872 WRITE (unit=output_unit, fmt=
"(/,T2,A,F8.5)") &
873 " Step is scaled; Scaling factor = ", rat
877 CALL timestop(handle)
879 END SUBROUTINE trust_radius
892 SUBROUTINE energy_predict(ndf, work, hess_mat, dr, g, conv, pred, para_env)
894 INTEGER,
INTENT(IN) :: ndf
895 REAL(kind=dp),
INTENT(INOUT) :: work(ndf)
897 REAL(kind=dp),
INTENT(INOUT) :: dr(ndf), g(ndf)
898 LOGICAL,
INTENT(INOUT) :: conv
899 REAL(kind=dp),
INTENT(INOUT) :: pred
900 TYPE(mp_para_env_type),
POINTER :: para_env
902 CHARACTER(LEN=*),
PARAMETER :: routinen =
'energy_predict'
903 REAL(kind=dp),
PARAMETER :: zero = 0.0_dp
905 INTEGER :: handle, i, j, k, l, ncol_local, &
907 INTEGER,
DIMENSION(:),
POINTER :: col_indices, row_indices
908 REAL(kind=dp) :: ddot, ener1, ener2
909 REAL(kind=dp),
CONTIGUOUS,
DIMENSION(:, :),
POINTER :: local_data
911 CALL timeset(routinen, handle)
913 ener1 = ddot(ndf, g, 1, dr, 1)
915 CALL cp_fm_get_info(hess_mat, row_indices=row_indices, col_indices=col_indices, &
916 local_data=local_data, nrow_local=nrow_local, ncol_local=ncol_local)
923 work(j) = work(j) + local_data(i, k)*dr(l)
927 CALL para_env%sum(work)
928 ener2 = ddot(ndf, dr, 1, work, 1)
929 pred = ener1 + 0.5_dp*ener2
931 CALL timestop(handle)
933 END SUBROUTINE energy_predict
942 SUBROUTINE update_trust_rad(rat, rad, step, ediff)
944 REAL(kind=dp),
INTENT(INOUT) :: rat, rad, step, ediff
946 CHARACTER(LEN=*),
PARAMETER :: routinen =
'update_trust_rad'
947 REAL(kind=dp),
PARAMETER :: max_trust = 1.0_dp, min_trust = 0.1_dp
951 CALL timeset(routinen, handle)
953 IF (rat > 4.0_dp)
THEN
954 IF (ediff < 0.0_dp)
THEN
959 ELSE IF (rat > 2.0_dp)
THEN
960 IF (ediff < 0.0_dp)
THEN
965 ELSE IF (rat > 4.0_dp/3.0_dp)
THEN
966 IF (ediff < 0.0_dp)
THEN
971 ELSE IF (rat > 10.0_dp/9.0_dp)
THEN
972 IF (ediff < 0.0_dp)
THEN
977 ELSE IF (rat > 0.9_dp)
THEN
978 IF (ediff < 0.0_dp)
THEN
983 ELSE IF (rat > 0.75_dp)
THEN
984 IF (ediff < 0.0_dp)
THEN
989 ELSE IF (rat > 0.5_dp)
THEN
990 IF (ediff < 0.0_dp)
THEN
995 ELSE IF (rat > 0.25_dp)
THEN
996 IF (ediff < 0.0_dp)
THEN
1001 ELSE IF (ediff < 0.0_dp)
THEN
1007 rad = max(rad, min_trust)
1008 rad = min(rad, max_trust)
1009 CALL timestop(handle)
1011 END SUBROUTINE update_trust_rad
1021 SUBROUTINE write_bfgs_hessian(geo_section, hess_mat, logger)
1027 CHARACTER(LEN=*),
PARAMETER :: routinen =
'write_bfgs_hessian'
1029 INTEGER :: handle, hesunit
1031 CALL timeset(routinen, handle)
1034 extension=
".Hessian", file_form=
"UNFORMATTED", file_action=
"WRITE", &
1035 file_position=
"REWIND")
1041 CALL timestop(handle)
1043 END SUBROUTINE write_bfgs_hessian
1051 SUBROUTINE construct_initial_hess(force_env, hess_mat)
1056 INTEGER :: i, iat_col, iat_row, iglobal, iind, j, &
1057 jat_row, jglobal, jind, k, natom, &
1058 ncol_local, nrow_local, z
1059 INTEGER,
ALLOCATABLE,
DIMENSION(:) :: at_row
1060 INTEGER,
DIMENSION(:),
POINTER :: col_indices, row_indices
1061 REAL(kind=dp),
ALLOCATABLE,
DIMENSION(:, :) :: d_ij, rho_ij
1062 REAL(kind=dp),
ALLOCATABLE,
DIMENSION(:, :, :) :: r_ij
1063 REAL(kind=dp),
DIMENSION(3, 3) :: alpha, r0
1064 REAL(kind=dp),
CONTIGUOUS,
DIMENSION(:, :),
POINTER :: fixed, local_data
1069 CALL force_env_get(force_env=force_env, subsys=subsys, cell=cell)
1071 particles=particles)
1073 alpha(1, :) = (/1._dp, 0.3949_dp, 0.3949_dp/)
1074 alpha(2, :) = (/0.3494_dp, 0.2800_dp, 0.2800_dp/)
1075 alpha(3, :) = (/0.3494_dp, 0.2800_dp, 0.1800_dp/)
1077 r0(1, :) = (/1.35_dp, 2.10_dp, 2.53_dp/)
1078 r0(2, :) = (/2.10_dp, 2.87_dp, 3.40_dp/)
1079 r0(3, :) = (/2.53_dp, 3.40_dp, 3.40_dp/)
1081 CALL cp_fm_get_info(hess_mat, row_indices=row_indices, col_indices=col_indices, &
1082 local_data=local_data, nrow_local=nrow_local, ncol_local=ncol_local)
1083 natom = particles%n_els
1084 ALLOCATE (at_row(natom))
1085 ALLOCATE (rho_ij(natom, natom))
1086 ALLOCATE (d_ij(natom, natom))
1087 ALLOCATE (r_ij(natom, natom, 3))
1088 ALLOCATE (fixed(3, natom))
1092 CALL hess_mat%matrix_struct%para_env%min(fixed(i, :))
1099 IF (z .LE. 10) at_row(i) = 2
1100 IF (z .LE. 2) at_row(i) = 1
1107 r_ij(j, i, :) =
pbc(particles%els(i)%r, particles%els(j)%r, cell)
1108 r_ij(i, j, :) = -r_ij(j, i, :)
1109 d_ij(j, i) = sqrt(dot_product(r_ij(j, i, :), r_ij(j, i, :)))
1110 d_ij(i, j) = d_ij(j, i)
1111 rho_ij(j, i) = exp(alpha(jat_row, iat_row)*(r0(jat_row, iat_row)**2 - d_ij(j, i)**2))
1112 rho_ij(i, j) = rho_ij(j, i)
1115 DO i = 1, ncol_local
1116 iglobal = col_indices(i)
1117 iind = mod(iglobal - 1, 3) + 1
1118 iat_col = (iglobal + 2)/3
1119 IF (iat_col .GT. natom) cycle
1120 DO j = 1, nrow_local
1121 jglobal = row_indices(j)
1122 jind = mod(jglobal - 1, 3) + 1
1123 iat_row = (jglobal + 2)/3
1124 IF (iat_row .GT. natom) cycle
1125 IF (iat_row .NE. iat_col)
THEN
1126 IF (d_ij(iat_row, iat_col) .LT. 6.0_dp) &
1127 local_data(j, i) = local_data(j, i) + &
1128 angle_second_deriv(r_ij, d_ij, rho_ij, iind, jind, iat_col, iat_row, natom)
1130 local_data(j, i) = local_data(j, i) + &
1131 angle_second_deriv(r_ij, d_ij, rho_ij, iind, jind, iat_col, iat_row, natom)
1133 IF (iat_col .NE. iat_row)
THEN
1134 IF (d_ij(iat_row, iat_col) .LT. 6.0_dp) &
1135 local_data(j, i) = local_data(j, i) - &
1136 dist_second_deriv(r_ij(iat_col, iat_row, :), &
1137 iind, jind, d_ij(iat_row, iat_col), rho_ij(iat_row, iat_col))
1140 IF (k == iat_col) cycle
1141 IF (d_ij(iat_row, k) .LT. 6.0_dp) &
1142 local_data(j, i) = local_data(j, i) + &
1143 dist_second_deriv(r_ij(iat_col, k, :), &
1144 iind, jind, d_ij(iat_row, k), rho_ij(iat_row, k))
1147 IF (fixed(jind, iat_row) .LT. 0.5_dp .OR. fixed(iind, iat_col) .LT. 0.5_dp)
THEN
1148 local_data(j, i) = 0.0_dp
1149 IF (jind == iind .AND. iat_row == iat_col) local_data(j, i) = 1.0_dp
1159 END SUBROUTINE construct_initial_hess
1170 FUNCTION dist_second_deriv(r1, i, j, d, rho)
RESULT(deriv)
1171 REAL(kind=dp),
DIMENSION(3) :: r1
1173 REAL(kind=dp) :: d, rho, deriv
1175 deriv = 0.45_dp*rho*(r1(i)*r1(j))/d**2
1190 FUNCTION angle_second_deriv(r_ij, d_ij, rho_ij, idir, jdir, iat_der, jat_der, natom)
RESULT(deriv)
1191 REAL(kind=dp),
DIMENSION(:, :, :) :: r_ij
1192 REAL(kind=dp),
DIMENSION(:, :) :: d_ij, rho_ij
1193 INTEGER :: idir, jdir, iat_der, jat_der, natom
1194 REAL(kind=dp) :: deriv
1196 INTEGER :: i, iat, idr, j, jat, jdr
1197 REAL(kind=dp) :: d12, d23, d31, d_mat(3, 2), denom1, &
1198 denom2, denom3, ka1, ka2, ka3, rho12, &
1199 rho23, rho31, rsst1, rsst2, rsst3
1200 REAL(kind=dp),
DIMENSION(3) :: r12, r23, r31
1203 IF (iat_der == jat_der)
THEN
1205 IF (rho_ij(iat_der, i) .LT. 0.00001) cycle
1207 IF (rho_ij(iat_der, j) .LT. 0.00001) cycle
1208 IF (i == iat_der .OR. j == iat_der) cycle
1209 IF (iat_der .LT. i .OR. iat_der .GT. j)
THEN
1210 r12 = r_ij(iat_der, i, :); r23 = r_ij(i, j, :); r31 = r_ij(j, iat_der, :)
1211 d12 = d_ij(iat_der, i); d23 = d_ij(i, j); d31 = d_ij(j, iat_der)
1212 rho12 = rho_ij(iat_der, i); rho23 = rho_ij(i, j); rho31 = rho_ij(j, iat_der)
1214 r12 = r_ij(iat_der, j, :); r23 = r_ij(j, i, :); r31 = r_ij(i, iat_der, :)
1215 d12 = d_ij(iat_der, j); d23 = d_ij(j, i); d31 = d_ij(i, iat_der)
1216 rho12 = rho_ij(iat_der, j); rho23 = rho_ij(j, i); rho31 = rho_ij(i, iat_der)
1218 ka1 = 0.15_dp*rho12*rho23; ka2 = 0.15_dp*rho23*rho31; ka3 = 0.15_dp*rho31*rho12
1219 rsst1 = dot_product(r12, r23); rsst2 = dot_product(r23, r31); rsst3 = dot_product(r31, r12)
1220 denom1 = 1.0_dp - rsst1**2/(d12**2*d23**2); denom2 = 1.0_dp - rsst2**2/(d23**2*d31**2)
1221 denom3 = 1.0_dp - rsst3**2/(d31**2*d12**2)
1222 denom1 = sign(1.0_dp, denom1)*max(abs(denom1), 0.01_dp)
1223 denom2 = sign(1.0_dp, denom2)*max(abs(denom2), 0.01_dp)
1224 denom3 = sign(1.0_dp, denom3)*max(abs(denom3), 0.01_dp)
1225 d_mat(1, 1) = r23(idir)/(d12*d23) - rsst1*r12(idir)/(d12**3*d23)
1226 d_mat(1, 2) = r23(jdir)/(d12*d23) - rsst1*r12(jdir)/(d12**3*d23)
1227 d_mat(2, 1) = -r23(idir)/(d23*d31) + rsst2*r31(idir)/(d23*d31**3)
1228 d_mat(2, 2) = -r23(jdir)/(d23*d31) + rsst2*r31(jdir)/(d23*d31**3)
1229 d_mat(3, 1) = (r31(idir) - r12(idir))/(d31*d12) + rsst3*r31(idir)/(d31**3*d12) - &
1230 rsst3*r12(idir)/(d31*d12**3)
1231 d_mat(3, 2) = (r31(jdir) - r12(jdir))/(d31*d12) + rsst3*r31(jdir)/(d31**3*d12) - &
1232 rsst3*r12(jdir)/(d31*d12**3)
1233 IF (abs(denom1) .LE. 0.011_dp) d_mat(1, 1) = 0.0_dp
1234 IF (abs(denom2) .LE. 0.011_dp) d_mat(2, 1) = 0.0_dp
1235 IF (abs(denom3) .LE. 0.011_dp) d_mat(3, 1) = 0.0_dp
1236 deriv = deriv + ka1*d_mat(1, 1)*d_mat(1, 2)/denom1 + &
1237 ka2*d_mat(2, 1)*d_mat(2, 2)/denom2 + &
1238 ka3*d_mat(3, 1)*d_mat(3, 2)/denom3
1244 IF (i == iat_der .OR. i == jat_der) cycle
1245 IF (jat_der .LT. iat_der)
THEN
1246 iat = jat_der; jat = iat_der; idr = jdir; jdr = idir
1248 iat = iat_der; jat = jat_der; idr = idir; jdr = jdir
1250 IF (jat .LT. i .OR. iat .GT. i)
THEN
1251 r12 = r_ij(iat, jat, :); r23 = r_ij(jat, i, :); r31 = r_ij(i, iat, :)
1252 d12 = d_ij(iat, jat); d23 = d_ij(jat, i); d31 = d_ij(i, iat)
1253 rho12 = rho_ij(iat, jat); rho23 = rho_ij(jat, i); rho31 = rho_ij(i, iat)
1255 r12 = r_ij(iat, i, :); r23 = r_ij(i, jat, :); r31 = r_ij(jat, iat, :)
1256 d12 = d_ij(iat, i); d23 = d_ij(i, jat); d31 = d_ij(jat, iat)
1257 rho12 = rho_ij(iat, i); rho23 = rho_ij(i, jat); rho31 = rho_ij(jat, iat)
1259 ka1 = 0.15_dp*rho12*rho23; ka2 = 0.15_dp*rho23*rho31; ka3 = 0.15_dp*rho31*rho12
1260 rsst1 = dot_product(r12, r23); rsst2 = dot_product(r23, r31); rsst3 = dot_product(r31, r12)
1261 denom1 = 1.0_dp - rsst1**2/(d12**2*d23**2); denom2 = 1.0_dp - rsst2**2/(d23**2*d31**2)
1262 denom3 = 1.0_dp - rsst3**2/(d31**2*d12**2)
1263 denom1 = sign(1.0_dp, denom1)*max(abs(denom1), 0.01_dp)
1264 denom2 = sign(1.0_dp, denom2)*max(abs(denom2), 0.01_dp)
1265 denom3 = sign(1.0_dp, denom3)*max(abs(denom3), 0.01_dp)
1266 d_mat(1, 1) = r23(idr)/(d12*d23) - rsst1*r12(idr)/(d12**3*d23)
1267 d_mat(2, 1) = -r23(idr)/(d23*d31) + rsst2*r31(idr)/(d23*d31**3)
1268 d_mat(3, 1) = (r31(idr) - r12(idr))/(d31*d12) + rsst3*r31(idr)/(d31**3*d12) - &
1269 rsst3*r12(idr)/(d31*d12**3)
1270 IF (jat .LT. i .OR. iat .GT. i)
THEN
1271 d_mat(1, 2) = (r12(jdr) - r23(jdr))/(d12*d23) + rsst1*r12(jdr)/(d12**3*d23) - &
1272 rsst1*r23(jdr)/(d12*d23**3)
1273 d_mat(2, 2) = r31(jdr)/(d23*d31) - rsst2*r23(jdr)/(d23**3*d31)
1274 d_mat(3, 2) = -r31(jdr)/(d31*d12) + rsst3*r12(jdr)/(d31*d12**3)
1276 d_mat(1, 2) = -r12(jdr)/(d12*d23) + rsst1*r23(jdr)/(d12*d23**3)
1277 d_mat(2, 2) = (r23(jdr) - r31(jdr))/(d23*d31) + rsst2*r23(jdr)/(d23**3*d31) - &
1278 rsst2*r31(jdr)/(d23*d31**3)
1279 d_mat(3, 2) = r12(jdr)/(d31*d12) - rsst3*r31(jdr)/(d31**3*d12)
1281 IF (abs(denom1) .LE. 0.011_dp) d_mat(1, 1) = 0.0_dp
1282 IF (abs(denom2) .LE. 0.011_dp) d_mat(2, 1) = 0.0_dp
1283 IF (abs(denom3) .LE. 0.011_dp) d_mat(3, 1) = 0.0_dp
1285 deriv = deriv + ka1*d_mat(1, 1)*d_mat(1, 2)/denom1 + &
1286 ka2*d_mat(2, 1)*d_mat(2, 2)/denom2 + &
1287 ka3*d_mat(3, 1)*d_mat(3, 2)/denom3
1290 deriv = 0.25_dp*deriv
1292 END FUNCTION angle_second_deriv
subroutine cp_eval_at(gopt_env, x, f, gradient, master, final_evaluation, para_env)
evaluete the potential energy and its gradients using an array with same dimension as the particle_se...
represent a simple array based list of the given type
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.
Routines for Geometry optimization using BFGS algorithm.
recursive subroutine, public geoopt_bfgs(force_env, gopt_param, globenv, geo_section, gopt_env, x0)
Main driver for BFGS geometry optimizations.
Handles all functions related to the CELL.
subroutine, public fix_atom_control(force_env, w)
allows for fix atom constraints
methods related to the blacs parallel environment
subroutine, public cp_blacs_env_release(blacs_env)
releases the given blacs_env
subroutine, public cp_blacs_env_create(blacs_env, para_env, blacs_grid_layout, blacs_repeatable, row_major, grid_2d)
allocates and initializes a type that represent a blacs context
Routines to handle the external control of CP2K.
subroutine, public external_control(should_stop, flag, globenv, target_time, start_time, force_check)
External manipulations during a run : when the <PROJECT_NAME>.EXIT_$runtype command is sent the progr...
Utility routines to open and close files. Tracking of preconnections.
subroutine, public open_file(file_name, file_status, file_form, file_action, file_position, file_pad, unit_number, debug, skip_get_unit_number, file_access)
Opens the requested file using a free unit number.
subroutine, public close_file(unit_number, file_status, keep_preconnection)
Close an open file given by its logical unit number. Optionally, keep the file and unit preconnected.
basic linear algebra operations for full matrices
subroutine, public cp_fm_column_scale(matrixa, scaling)
scales column i of matrix a with scaling(i)
subroutine, public cp_fm_transpose(matrix, matrixt)
transposes a matrix matrixt = matrix ^ T
used for collecting some of the diagonalization schemes available for cp_fm_type. cp_fm_power also mo...
subroutine, public choose_eigv_solver(matrix, eigenvectors, eigenvalues, info)
Choose the Eigensolver depending on which library is available ELPA seems to be unstable for small sy...
represent the structure of a full matrix
subroutine, public cp_fm_struct_create(fmstruct, para_env, context, nrow_global, ncol_global, nrow_block, ncol_block, descriptor, first_p_pos, local_leading_dimension, template_fmstruct, square_blocks, force_block)
allocates and initializes a full matrix structure
subroutine, public cp_fm_struct_release(fmstruct)
releases a full matrix structure
represent a full matrix distributed on many processors
subroutine, public cp_fm_get_info(matrix, name, nrow_global, ncol_global, nrow_block, ncol_block, nrow_local, ncol_local, row_indices, col_indices, local_data, context, nrow_locals, ncol_locals, matrix_struct, para_env)
returns all kind of information about the full matrix
subroutine, public cp_fm_write_unformatted(fm, unit)
...
subroutine, public cp_fm_read_unformatted(fm, unit)
...
subroutine, public cp_fm_set_all(matrix, alpha, beta)
set all elements of a matrix to the same value, and optionally the diagonal to a different one
subroutine, public cp_fm_create(matrix, matrix_struct, name, use_sp)
creates a new full matrix with the given structure
various routines to log and control the output. The idea is that decisions about where to log should ...
type(cp_logger_type) function, pointer, public cp_get_default_logger()
returns the default logger
routines to handle the output, The idea is to remove the decision of wheter to output and what to out...
integer function, public cp_print_key_unit_nr(logger, basis_section, print_key_path, extension, middle_name, local, log_filename, ignore_should_output, file_form, file_position, file_action, file_status, do_backup, on_file, is_new_file, mpi_io, fout)
...
subroutine, public cp_print_key_finished_output(unit_nr, logger, basis_section, print_key_path, local, ignore_should_output, on_file, mpi_io)
should be called after you finish working with a unit obtained with cp_print_key_unit_nr,...
integer, parameter, public cp_p_file
subroutine, public cp_iterate(iteration_info, last, iter_nr, increment, iter_nr_out)
adds one to the actual iteration
integer function, public cp_print_key_should_output(iteration_info, basis_section, print_key_path, used_print_key, first_time)
returns what should be done with the given property if btest(res,cp_p_store) then the property should...
types that represent a subsys, i.e. a part of the system
subroutine, public cp_subsys_get(subsys, ref_count, atomic_kinds, atomic_kind_set, particles, particle_set, local_particles, molecules, molecule_set, molecule_kinds, molecule_kind_set, local_molecules, para_env, colvar_p, shell_particles, core_particles, gci, multipoles, natom, nparticle, ncore, nshell, nkind, atprop, virial, results, cell)
returns information about various attributes of the given subsys
Interface for the force calculations.
recursive subroutine, public force_env_get(force_env, in_use, fist_env, qs_env, meta_env, fp_env, subsys, para_env, potential_energy, additional_potential, kinetic_energy, harmonic_shell, kinetic_shell, cell, sub_force_env, qmmm_env, qmmmx_env, eip_env, pwdft_env, globenv, input, force_env_section, method_name_id, root_section, mixed_env, nnp_env, embed_env, ipi_env)
returns various attributes about the force environment
Define type storing the global information of a run. Keep the amount of stored data small....
contains a functional that calculates the energy and its derivatives for the geometry optimizer
subroutine, public print_geo_opt_header(gopt_env, output_unit, label)
...
subroutine, public gopt_f_io_init(gopt_env, output_unit, opt_energy, wildcard, its, used_time)
Handles the Output during an optimization run.
recursive subroutine, public gopt_f_io_finalize(gopt_env, force_env, x0, conv, its, root_section, para_env, master, output_unit)
Handles the Output at the end of an optimization run.
subroutine, public gopt_f_io(gopt_env, force_env, root_section, its, opt_energy, output_unit, eold, emin, wildcard, gopt_param, ndf, dx, xi, conv, pred, rat, step, rad, used_time)
Handles the Output during an optimization run.
subroutine, public print_geo_opt_nc(gopt_env, output_unit)
...
subroutine, public gopt_f_ii(its, output_unit)
Prints iteration step of the optimization procedure on screen.
contains a functional that calculates the energy and its derivatives for the geometry optimizer
contains typo and related routines to handle parameters controlling the GEO_OPT module
Defines the basic variable types.
integer, parameter, public dp
integer, parameter, public default_path_length
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.
basic linear algebra operations for full matrixes
represent a simple array based list of the given type
Space Group Symmetry Type Module (version 1.0, Ferbruary 12, 2021)
Space Group Symmetry Module (version 1.0, January 16, 2020)
subroutine, public print_spgr(spgr)
routine prints Space Group Information.
subroutine, public spgr_apply_rotations_coord(spgr, coord)
routine applies the rotation matrices to the coordinates.
subroutine, public identify_space_group(subsys, geo_section, gopt_env, iunit)
routine indentifies the space group and finds rotation matrices.
subroutine, public spgr_apply_rotations_force(spgr, force)
routine applies the rotation matrices to the forces.
represent a list of objects
Type defining parameters related to the simulation cell.
represent a blacs multidimensional parallel environment (for the mpi corrispective see cp_paratypes/m...
keeps the information about the structure of a full matrix
type of a logger, at the moment it contains just a print level starting at which level it should be l...
represents a system: atoms, molecules, their pos,vel,...
wrapper to abstract the force evaluation of the various methods
contains the initially parsed file and the initial parallel environment
calculates the potential energy of a system, and its derivatives
stores all the informations relevant to an mpi environment
represent a list of objects