35 use,
intrinsic :: iso_fortran_env
69 integer(int64) :: type
72 real(real64) :: line_tol
73 real(real64) :: fire_mass
74 integer :: fire_integrator
75 real(real64) :: tolgrad
78 integer :: what2minimize
82 type(ions_t),
pointer :: ions
83 type(hamiltonian_elec_t),
pointer :: hm
84 type(electrons_t),
pointer :: syst
85 class(mesh_t),
pointer :: mesh
86 type(states_elec_t),
pointer :: st
88 integer :: periodic_dim
90 integer :: fixed_atom = 0
92 real(real64),
allocatable :: cell_force(:, :)
93 logical :: symmetrize = .false.
94 real(real64),
allocatable :: initial_length(:)
95 real(real64),
allocatable :: initial_rlattice(:, :)
96 real(real64),
allocatable :: inv_initial_rlattice(:, :)
97 real(real64) :: pressure
99 logical :: poscar_output = .false.
103 type(geom_opt_t),
save :: g_opt
105 integer,
parameter :: &
106 MINWHAT_ENERGY = 1, &
109 integer,
parameter :: &
118 class(*),
intent(inout) :: system
119 logical,
intent(inout) :: from_scratch
125 message(1) =
"CalculationMode = go not implemented for multi-system calculations"
136 type(electrons_t),
target,
intent(inout) :: sys
137 logical,
intent(inout) :: fromscratch
140 real(real64),
allocatable :: coords(:)
141 real(real64) :: energy
143 real(real64),
allocatable :: mass(:)
144 integer :: iatom, imass
145 type(restart_t) :: restart_load
146 logical :: known_lower_bound
150 if (sys%space%periodic_dim == 1 .or. sys%space%periodic_dim == 2)
then
151 message(1) =
"Geometry optimization not allowed for systems periodic in 1D and 2D, "
152 message(2) =
"as in those cases the total energy is not correct."
157 if (sys%hm%pcm%run_pcm)
then
161 if (sys%kpoints%use_symmetries)
then
168 if (.not. fromscratch)
then
171 call states_elec_load(restart_load, sys%namespace, sys%space, sys%st, sys%gr, sys%kpoints, ierr)
173 call restart_load%end()
175 message(1) =
"Unable to read wavefunctions: Starting from scratch."
181 call scf_init(g_opt%scfv, sys%namespace, sys%gr, sys%ions, sys%st, sys%mc, sys%hm, sys%space)
184 if (.not. g_opt%scfv%calc_stress)
then
185 message(1) =
"In order to optimize the cell, one needs to set SCFCalculateStress = yes."
190 if (fromscratch)
then
191 call lcao_run(sys%namespace, sys%space, sys%gr, sys%ions, sys%ext_partners, sys%st, sys%ks, sys%hm, &
192 lmm_r = g_opt%scfv%lmm_r, known_lower_bound=known_lower_bound)
196 message(1) =
'Info: Setting up Hamiltonian.'
198 call v_ks_h_setup(sys%namespace, sys%space, sys%gr, sys%ions, sys%ext_partners, sys%st, sys%ks, sys%hm)
202 g_opt%symmetrize = sys%kpoints%use_symmetries .or. sys%st%symmetrize_density
205 safe_allocate(coords(1:g_opt%size))
208 if (sys%st%pack_states .and. sys%hm%apply_packed())
call sys%st%pack()
211 select case (g_opt%method)
213 call minimize_multidim_nograd(g_opt%method, g_opt%size, coords, g_opt%step,&
214 g_opt%toldr, g_opt%max_iter, &
218 safe_allocate(mass(1:g_opt%size))
219 mass = g_opt%fire_mass
221 do iatom = 1, sys%ions%natoms
222 if (g_opt%fixed_atom == iatom) cycle
223 if (g_opt%ions%fixed(iatom)) cycle
224 if (g_opt%fire_mass <=
m_zero) mass(imass:imass + 2) = sys%ions%mass(iatom)
229 call minimize_fire(g_opt%size, g_opt%ions%space%dim, coords, g_opt%step, g_opt%tolgrad, &
231 safe_deallocate_a(mass)
234 call minimize_multidim(g_opt%method, g_opt%size, coords, g_opt%step ,&
235 g_opt%line_tol , g_opt%tolgrad, g_opt%toldr, g_opt%max_iter, &
239 if (ierr == 1025)
then
241 message(1) =
"Reached maximum number of iterations allowed by GOMaxIter."
244 message(1) =
"Error occurred during the GSL minimization procedure:"
249 if (sys%st%pack_states .and. sys%hm%apply_packed())
call sys%st%unpack()
253 message(1) =
"Writing final coordinates to min.xyz"
256 call g_opt%ions%write_xyz(
'./min')
258 safe_deallocate_a(coords)
261 call g_opt%scfv%criterion_list%empty()
268 subroutine init_(fromscratch)
269 logical,
intent(inout) :: fromscratch
271 logical :: center, does_exist
272 integer :: iter, iatom, idir
273 character(len=100) :: filename
274 real(real64) :: default_toldr
275 real(real64) :: default_step
280 if (sys%space%is_periodic())
then
308 write(
message(1),
'(a)')
'Input: [GOType = '
309 if (
bitand(g_opt%type, go_ions) /= 0)
then
313 if (len_trim(
message(1)) > 16)
then
319 if (len_trim(
message(1)) > 16)
then
328 message(1) =
"Cell and volume optimization cannot be used simultaneously."
342 message(1) =
"Cell dynamics not supported on GPUs."
348 do iatom = 1, sys%ions%natoms
349 select type(spec=>sys%ions%atom(iatom)%species)
351 write(
message(1),
'(a)')
"Geometry optimization for all-electron potential is not implemented."
361 g_opt%ions => sys%ions
365 g_opt%dim = sys%space%dim
366 g_opt%periodic_dim = sys%space%periodic_dim
370 if (
bitand(g_opt%type, go_ions) /= 0)
then
371 g_opt%size = g_opt%dim * g_opt%ions%natoms
376 g_opt%size = g_opt%size + (g_opt%periodic_dim +1) * g_opt%periodic_dim / 2
377 safe_allocate(g_opt%cell_force(1:g_opt%periodic_dim, 1:g_opt%periodic_dim))
382 g_opt%size = g_opt%size + g_opt%periodic_dim
383 safe_allocate(g_opt%cell_force(1:g_opt%periodic_dim, 1:1))
385 safe_allocate(g_opt%initial_length(1:g_opt%periodic_dim))
386 do idir = 1, g_opt%periodic_dim
387 g_opt%initial_length(idir) = norm2(g_opt%ions%latt%rlattice(1:g_opt%periodic_dim, idir))
393 safe_allocate(g_opt%initial_rlattice(1:g_opt%periodic_dim, 1:g_opt%periodic_dim))
394 g_opt%initial_rlattice(1:g_opt%periodic_dim, 1:g_opt%periodic_dim) &
395 = g_opt%ions%latt%rlattice(1:g_opt%periodic_dim, 1:g_opt%periodic_dim)
396 safe_allocate(g_opt%inv_initial_rlattice(1:g_opt%periodic_dim, 1:g_opt%periodic_dim))
397 g_opt%inv_initial_rlattice(:, :) = g_opt%initial_rlattice(:, :)
398 call lalg_inverse(g_opt%periodic_dim, g_opt%inv_initial_rlattice,
'dir')
401 if(g_opt%ions%space%is_periodic())
then
405 assert(g_opt%size > 0)
421 g_opt%size = g_opt%size - g_opt%dim
426 do iatom = 1, g_opt%ions%natoms
427 if (g_opt%ions%fixed(iatom))
then
428 g_opt%size = g_opt%size - g_opt%dim
506 default_toldr = 0.001_real64
508 default_toldr = -
m_one
525 call parse_variable(sys%namespace,
'GOStep', default_step, g_opt%step)
540 call parse_variable(sys%namespace,
'GOLineTol', 0.1_real64, g_opt%line_tol)
550 call parse_variable(sys%namespace,
'GOMaxIter', 200, g_opt%max_iter)
551 if (g_opt%max_iter <= 0)
then
552 message(1) =
"GOMaxIter has to be larger than 0"
589 call parse_variable(sys%namespace,
'GOFireIntegrator', option__gofireintegrator__verlet, g_opt%fire_integrator)
610 call parse_variable(sys%namespace,
'GOObjective', minwhat_energy, g_opt%what2minimize)
671 if (g_opt%ions%natoms /= xyz%n)
then
672 write(
message(1),
'(a,i4,a,i4)')
'I need exactly ', g_opt%ions%natoms,
' constrains, but I found ', xyz%n
676 do iatom = 1, g_opt%ions%natoms
677 where(abs(xyz%atom(iatom)%x) <=
m_epsilon)
678 g_opt%ions%atom(iatom)%c =
m_zero
680 g_opt%ions%atom(iatom)%c =
m_one
687 if (g_opt%fixed_atom > 0)
then
691 do iatom = 1, g_opt%ions%natoms
692 g_opt%ions%atom(iatom)%c =
m_zero
697 call io_rm(
"geom/optimization.log", sys%namespace)
699 call io_rm(
"work-geom.xyz", sys%namespace)
701 if (.not. fromscratch)
then
702 inquire(file =
'./last.xyz', exist = does_exist)
703 if (.not. does_exist) fromscratch = .
true.
706 if (.not. fromscratch)
call g_opt%ions%read_xyz(
'./last')
711 write(filename,
'(a,i4.4,a)')
"geom/go.", iter,
".xyz"
712 inquire(file = trim(filename), exist = does_exist)
714 call io_rm(trim(filename), sys%namespace)
734 call g_opt%scfv%restart_dump%end()
742 safe_deallocate_a(g_opt%cell_force)
753 subroutine calc_point(size, coords, objective, getgrad, df)
754 integer,
intent(in) :: size
755 real(real64),
intent(in) :: coords(size)
756 real(real64),
intent(inout) :: objective
757 integer,
intent(in) :: getgrad
758 real(real64),
intent(inout) :: df(size)
760 integer :: iatom, idir, jdir
761 real(real64),
dimension(g_opt%periodic_dim, g_opt%periodic_dim) :: stress, strain, right_stretch, rotation, sym_stress
766 assert(
size == g_opt%size)
774 if (g_opt%fixed_atom /= 0)
then
775 call g_opt%ions%translate(g_opt%ions%center())
780 call g_opt%ions%fold_atoms_into_cell()
783 do iatom = 1, g_opt%ions%natoms
784 if (.not. g_opt%syst%gr%box%contains_point(g_opt%syst%ions%pos(:, iatom)))
then
785 if (g_opt%syst%space%periodic_dim /= g_opt%syst%space%dim)
then
789 write(
message(1),
'(a,i5,a)')
"Atom ", iatom,
" has moved outside the box during the geometry optimization."
795 call g_opt%ions%write_xyz(
'./work-geom', append = .
true.)
802 g_opt%syst%space, g_opt%syst%hm%psolver, g_opt%syst%hm%kpoints, &
803 g_opt%syst%mc, g_opt%syst%st%qtot, g_opt%ions%latt)
807 g_opt%ions, g_opt%syst%ext_partners, g_opt%st)
808 call density_calc(g_opt%st, g_opt%syst%gr, g_opt%st%rho)
809 call v_ks_calc(g_opt%syst%ks, g_opt%syst%namespace, g_opt%syst%space, g_opt%hm, g_opt%st, &
810 g_opt%ions,g_opt%syst%ext_partners, calc_eigenval = .
true.)
811 call energy_calc_total(g_opt%syst%namespace, g_opt%syst%space, g_opt%hm, g_opt%syst%gr, g_opt%st, g_opt%syst%ext_partners)
814 call scf_run(g_opt%scfv, g_opt%syst%namespace, g_opt%syst%space, g_opt%syst%mc, g_opt%syst%gr, &
815 g_opt%ions, g_opt%syst%ext_partners, &
816 g_opt%st, g_opt%syst%ks, g_opt%hm, outp = g_opt%syst%outp, verbosity =
verb_compact, restart_dump=g_opt%scfv%restart_dump)
819 if (g_opt%ions%force_total_enforce)
then
835 stress = -g_opt%syst%st%stress_tensors%total(1:g_opt%periodic_dim, 1:g_opt%periodic_dim)
839 strain = matmul(g_opt%ions%latt%rlattice(1:g_opt%periodic_dim,1:g_opt%periodic_dim), g_opt%inv_initial_rlattice)
841 call lalg_inverse(g_opt%periodic_dim, right_stretch,
'dir')
842 rotation = matmul(strain, right_stretch)
845 sym_stress = matmul(transpose(rotation), matmul(stress, rotation))
846 sym_stress =
m_half*(sym_stress + transpose(sym_stress))
848 do idir = 1, g_opt%periodic_dim
849 sym_stress(idir, idir) = sym_stress(idir, idir) - g_opt%pressure/g_opt%periodic_dim
851 g_opt%cell_force = sym_stress * g_opt%ions%latt%rcell_volume
853 g_opt%cell_force = matmul(g_opt%cell_force, right_stretch)
858 stress = g_opt%syst%st%stress_tensors%total(1:g_opt%periodic_dim, 1:g_opt%periodic_dim)
859 do idir = 1, g_opt%periodic_dim
860 g_opt%cell_force(idir, 1) = -(g_opt%pressure/g_opt%periodic_dim + stress(idir, idir)) * g_opt%ions%latt%rcell_volume
866 do idir = 1, g_opt%periodic_dim
868 jdir = 1, g_opt%periodic_dim)
870 call messages_info(1+g_opt%periodic_dim, namespace=g_opt%ions%namespace, debug_only=.
true.)
872 do idir = 1, ubound(g_opt%cell_force, 2)
874 jdir = 1, g_opt%periodic_dim)
876 call messages_info(1+g_opt%periodic_dim, namespace=g_opt%ions%namespace, debug_only=.
true.)
881 if (getgrad == 1)
call to_grad(g_opt, df)
885 do iatom = 1, g_opt%ions%natoms
886 if (g_opt%ions%fixed(iatom)) cycle
887 objective = objective + sum(g_opt%ions%tot_force(:, iatom)**2)
890 do idir = 1, g_opt%periodic_dim
891 objective = objective + sum(g_opt%cell_force(:, idir)**2)
895 objective = objective + sum(g_opt%cell_force(:,1)**2)
897 objective =
sqrt(objective)
899 objective = g_opt%hm%energy%total
913 real(real64) :: coords(size)
914 real(real64) :: objective
917 real(real64),
allocatable :: df(:)
921 assert(
size == g_opt%size)
924 safe_allocate(df(1:size))
927 call calc_point(
size, coords, objective, getgrad, df)
928 safe_deallocate_a(df)
936 subroutine write_iter_info(geom_iter, size, energy, maxdx, maxdf, coords)
937 integer,
intent(in) :: geom_iter
938 integer,
intent(in) :: size
939 real(real64),
intent(in) :: energy, maxdx, maxdf
940 real(real64),
intent(in) :: coords(size)
942 character(len=256) :: c_geom_iter, title, c_forces_iter
947 write(c_geom_iter,
'(a,i4.4)')
"go.", geom_iter
949 call io_mkdir(
'geom', g_opt%ions%namespace)
950 call g_opt%ions%write_xyz(
'geom/'//trim(c_geom_iter), comment = trim(title))
951 call g_opt%ions%write_xyz(
'./last')
953 if(g_opt%periodic_dim > 0)
then
954 call g_opt%ions%write_xyz(
'geom/'//trim(c_geom_iter), comment =
'Reduced coordinates', reduce_coordinates = .
true.)
956 g_opt%ions%pos, g_opt%ions%atom, g_opt%syst%gr, g_opt%syst%namespace)
959 if (g_opt%syst%outp%what(option__output__forces))
then
960 write(c_forces_iter,
'(a,i4.4)')
"forces.", geom_iter
961 if (
bitand(g_opt%syst%outp%how(option__output__forces), option__outputformat__bild) /= 0)
then
962 call g_opt%ions%write_bild_forces_file(
'forces', trim(c_forces_iter))
965 g_opt%ions%pos, g_opt%ions%atom, g_opt%syst%gr, g_opt%syst%namespace, total_forces=g_opt%ions%tot_force)
970 iunit =
io_open(trim(
'geom/optimization.log'), g_opt%syst%namespace, &
971 action =
'write', position =
'append')
973 if (geom_iter == 1)
then
975 write(iunit,
'(a10,5(5x,a20),a)')
'# iter',
'energy [' // trim(
units_abbrev(
units_out%energy)) //
']', &
980 ' alpha, beta, gamma [degrees]'
982 write(iunit,
'(a10,3(5x,a20))')
'# iter',
'energy [' // trim(
units_abbrev(
units_out%energy)) //
']', &
996 g_opt%ions%latt%alpha, g_opt%ions%latt%beta, g_opt%ions%latt%gamma
1009 call messages_write(
"++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++", new_line = .
true.)
1011 call messages_write(
"+++++++++++++++++++++ MINIMIZATION ITER #:")
1018 if (g_opt%periodic_dim == 0)
then
1029 call messages_write(maxdf, fmt =
"f16.10,1x", print_units = .false., new_line = .
true.)
1033 call messages_write(maxdx, fmt =
"f16.10,1x", print_units = .false., new_line = .
true.)
1036 call messages_write(
"++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++", new_line = .
true.)
1037 call messages_write(
"++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++", new_line = .
true.)
1049 real(real64),
intent(out) :: coords(:)
1051 integer :: iatom, idir, jdir, icoord
1052 real(real64) :: tmp_pos(gopt%dim), strain(g_opt%periodic_dim,g_opt%periodic_dim)
1058 if (
bitand(g_opt%type, go_ions) /= 0)
then
1059 do iatom = 1, gopt%ions%natoms
1060 if (gopt%fixed_atom == iatom) cycle
1061 if (gopt%ions%fixed(iatom)) cycle
1062 tmp_pos = gopt%ions%pos(1:gopt%dim, iatom)
1063 if (gopt%fixed_atom > 0) tmp_pos = tmp_pos - gopt%ions%pos(1:gopt%dim, gopt%fixed_atom)
1064 tmp_pos = gopt%ions%latt%cart_to_red(tmp_pos)
1065 do idir = 1, gopt%dim
1066 coords(icoord) = tmp_pos(idir)
1075 strain = matmul(gopt%ions%latt%rlattice, g_opt%inv_initial_rlattice)
1076 do idir = 1, g_opt%periodic_dim
1077 do jdir = idir, g_opt%periodic_dim
1078 coords(icoord) = strain(idir, jdir)
1086 do idir = 1, g_opt%periodic_dim
1087 coords(icoord) = norm2(gopt%ions%latt%rlattice(1:g_opt%periodic_dim, idir))/g_opt%initial_length(idir)
1098 subroutine to_grad(gopt, grad)
1100 real(real64),
intent(out) :: grad(:)
1102 integer :: iatom, idir, jdir, icoord
1103 real(real64) :: tmp_force(1:gopt%dim)
1109 if (
bitand(g_opt%type, go_ions) /= 0)
then
1110 do iatom = 1, gopt%ions%natoms
1111 if (gopt%fixed_atom == iatom) cycle
1112 if (gopt%ions%fixed(iatom)) cycle
1113 do idir = 1, gopt%dim
1114 if (abs(gopt%ions%atom(iatom)%c(idir)) <=
m_epsilon)
then
1115 tmp_force(idir) = -gopt%ions%tot_force(idir, iatom)
1119 if (gopt%fixed_atom > 0)
then
1120 tmp_force(idir) = tmp_force(idir) + gopt%ions%tot_force(idir, gopt%fixed_atom)
1123 tmp_force = gopt%ions%latt%cart_to_red(tmp_force)
1124 do idir = 1, gopt%dim
1125 grad(icoord) = tmp_force(idir)
1133 do idir = 1, g_opt%periodic_dim
1134 do jdir = idir, g_opt%periodic_dim
1135 grad(icoord) = -g_opt%cell_force(idir, jdir)
1143 do idir = 1, g_opt%periodic_dim
1144 grad(icoord) = -g_opt%cell_force(idir, 1)
1157 real(real64),
intent(in) :: coords(:)
1159 integer :: iatom, idir, jdir, icoord
1160 real(real64) :: tmp_pos(gopt%dim, gopt%ions%natoms), strain(g_opt%periodic_dim,g_opt%periodic_dim)
1168 if (
bitand(g_opt%type, go_ions) /= 0)
then
1169 do iatom = 1, gopt%ions%natoms
1170 if (gopt%fixed_atom == iatom) cycle
1171 if (gopt%ions%fixed(iatom)) cycle
1172 do idir = 1, gopt%dim
1173 tmp_pos(idir, iatom) = coords(icoord)
1178 do iatom = 1, gopt%ions%natoms
1179 tmp_pos(:, iatom) = gopt%ions%latt%cart_to_red(gopt%ions%pos(:, iatom))
1185 do idir = 1, g_opt%periodic_dim
1186 do jdir = idir, g_opt%periodic_dim
1187 strain(idir, jdir) = coords(icoord)
1195 gopt%ions%latt%rlattice = matmul(strain, g_opt%initial_rlattice)
1200 do idir = 1, g_opt%periodic_dim
1201 gopt%ions%latt%rlattice(1:g_opt%periodic_dim, idir) = coords(icoord) &
1202 * gopt%initial_rlattice(1:g_opt%periodic_dim, idir)
1209 call g_opt%syst%gr%symmetrizer%symmetrize_lattice_vectors(g_opt%periodic_dim, g_opt%initial_rlattice, &
1210 gopt%ions%latt%rlattice, gopt%symmetrize)
1211 call gopt%ions%update_lattice_vectors(gopt%ions%latt, gopt%symmetrize)
1215 if (
bitand(g_opt%type, go_ions) /= 0)
then
1217 do iatom = 1, gopt%ions%natoms
1218 if (gopt%fixed_atom == iatom) cycle
1219 if (gopt%ions%fixed(iatom)) cycle
1220 tmp_pos(:, iatom) = gopt%ions%latt%red_to_cart(tmp_pos(:, iatom))
1221 do idir = 1, gopt%dim
1222 if (abs(gopt%ions%atom(iatom)%c(idir)) <=
m_epsilon)
then
1223 gopt%ions%pos(idir, iatom) = tmp_pos(idir, iatom)
1226 if (gopt%fixed_atom > 0)
then
1227 gopt%ions%pos(:, iatom) = gopt%ions%pos(:, iatom) + gopt%ions%pos(:, gopt%fixed_atom)
1231 do iatom = 1, gopt%ions%natoms
1232 gopt%ions%pos(:, iatom) = gopt%ions%latt%red_to_cart(tmp_pos(:, iatom))
1236 if (gopt%symmetrize)
then
1237 call gopt%ions%symmetrize_atomic_coord()
1240 if (
debug%info)
then
1241 call gopt%ions%print_spacegroup()
1250 integer,
intent(in) :: geom_iter
1251 integer,
intent(in) :: size
1252 real(real64),
intent(in) :: energy, maxdx
1253 real(real64),
intent(in) :: coords(size)
subroutine init_(fromscratch)
pure logical function, public accel_is_enabled()
type(debug_t), save, public debug
This module implements a calculator for the density and defines related functions.
subroutine, public density_calc(st, gr, density, istin)
Computes the density from the orbitals in st.
subroutine, public energy_calc_total(namespace, space, hm, gr, st, ext_partners, iunit, full)
This subroutine calculates the total energy of the system. Basically, it adds up the KS eigenvalues,...
subroutine, public forces_set_total_to_zero(ions, force)
subroutine, public geom_opt_run(system, from_scratch)
subroutine calc_point_ng(size, coords, objective)
Same as calc_point, but without the gradients. No intents here is unfortunately required because the ...
subroutine to_grad(gopt, grad)
Transfer data from the forces to the work array for the gradients (grad)
integer, parameter go_cell
integer, parameter minwhat_forces
subroutine write_iter_info_ng(geom_iter, size, energy, maxdx, coords)
Same as write_iter_info, but without the gradients.
subroutine write_iter_info(geom_iter, size, energy, maxdx, maxdf, coords)
Output the information after each iteration of the geometry optimization.
subroutine calc_point(size, coords, objective, getgrad, df)
Note: you might think it would be better to change the arguments with '(size)' below to '(:)'....
subroutine to_coords(gopt, coords)
Transfer the data from the data structures to the work array (coords)
integer, parameter go_volume
subroutine from_coords(gopt, coords)
Transfer the data from the work array (coords) to the actual data structures.
subroutine geom_opt_run_legacy(sys, fromscratch)
real(real64), parameter, public m_zero
real(real64), parameter, public m_epsilon
real(real64), parameter, public m_half
real(real64), parameter, public m_one
subroutine, public hamiltonian_elec_epot_generate(this, namespace, space, gr, ions, ext_partners, st, time)
subroutine, public write_xsf_geometry_file(dir, fname, space, latt, pos, atoms, mesh, namespace, total_forces)
subroutine, public io_close(iunit, grp)
subroutine, public io_rm(fname, namespace)
subroutine, public io_mkdir(fname, namespace, parents)
integer function, public io_open(file, namespace, action, status, form, position, die, recl, grp)
subroutine, public electrons_lattice_vectors_update(namespace, gr, space, psolver, kpoints, mc, qtot, new_latt)
subroutine, public ion_dynamics_box_update(namespace, gr, space, new_latt)
real(real64) function, dimension(1:n, 1:n), public lalg_remove_rotation(n, A)
Remove rotation from affine transformation A by computing the polar decomposition and discarding the ...
subroutine, public lcao_run(namespace, space, gr, ions, ext_partners, st, ks, hm, st_start, lmm_r, known_lower_bound)
System information (time, memory, sysname)
subroutine, public loct_strerror(errno, res)
This module is intended to contain "only mathematical" functions and procedures.
This module defines the meshes, which are used in Octopus.
subroutine, public messages_not_implemented(feature, namespace)
subroutine, public messages_warning(no_lines, all_nodes, namespace)
subroutine, public messages_obsolete_variable(namespace, name, rep)
subroutine, public messages_new_line()
character(len=256), dimension(max_lines), public message
to be output by fatal, warning
subroutine, public messages_fatal(no_lines, only_root_writes, namespace)
subroutine, public messages_input_error(namespace, var, details, row, column)
subroutine, public messages_experimental(name, namespace)
subroutine, public messages_info(no_lines, iunit, debug_only, stress, all_nodes, namespace)
integer, parameter, public minmethod_nmsimplex
integer, parameter, public minmethod_fire
type(mpi_grp_t), public mpi_world
This module implements the basic mulsisystem class, a container system for other systems.
logical function, public parse_is_defined(namespace, name)
integer, parameter, public read_coords_err
for read_coords_info::file_type
subroutine, public read_coords_init(gf)
subroutine, public read_coords_end(gf)
subroutine, public read_coords_read(what, gf, space, namespace)
integer, parameter, public restart_gs
integer, parameter, public restart_type_dump
integer, parameter, public restart_type_load
pure subroutine, public scf_set_lower_bound_is_known(scf, known_lower_bound)
Set the flag lower_bound_is_known.
subroutine, public scf_print_mem_use(namespace)
subroutine, public scf_mix_clear(scf)
integer, parameter, public verb_compact
subroutine, public scf_init(scf, namespace, gr, ions, st, mc, hm, space)
subroutine, public scf_end(scf)
subroutine, public scf_run(scf, namespace, space, mc, gr, ions, ext_partners, st, ks, hm, outp, verbosity, iters_done, restart_dump)
Legacy version of the SCF code.
subroutine, public states_elec_deallocate_wfns(st)
Deallocates the KS wavefunctions defined within a states_elec_t structure.
subroutine, public states_elec_allocate_wfns(st, mesh, wfs_type, skip, packed)
Allocates the KS wavefunctions defined within a states_elec_t structure.
This module handles reading and writing restart information for the states_elec_t.
subroutine, public states_elec_load(restart, namespace, space, st, mesh, kpoints, ierr, iter, lr, lowest_missing, label, verbose, skip)
returns in ierr: <0 => Fatal error, or nothing read =0 => read all wavefunctions >0 => could only rea...
brief This module defines the class unit_t which is used by the unit_systems_oct_m module.
character(len=20) pure function, public units_abbrev(this)
This module defines the unit system, used for input and output.
type(unit_t), public unit_femtosecond
Time in femtoseconds.
type(unit_t), public unit_amu
Mass in atomic mass units (AKA Dalton).
type(unit_system_t), public units_out
type(unit_system_t), public units_inp
the units systems for reading and writing
subroutine, public v_ks_calc(ks, namespace, space, hm, st, ions, ext_partners, calc_eigenval, time, calc_energy, calc_current, force_semilocal)
subroutine, public v_ks_h_setup(namespace, space, gr, ions, ext_partners, st, ks, hm, calc_eigenval, calc_current)
An abstract type for all electron species.
Class describing the electron system.
Container class for lists of system_oct_m::system_t.