Octopus
ions.F90
Go to the documentation of this file.
1!! Copyright (C) 2002-2006 M. Marques, A. Castro, A. Rubio, G. Bertsch
2!! Copyright (C) 2021 M. Oliveira
3!!
4!! This program is free software; you can redistribute it and/or modify
5!! it under the terms of the GNU General Public License as published by
6!! the Free Software Foundation; either version 2, or (at your option)
7!! any later version.
8!!
9!! This program is distributed in the hope that it will be useful,
10!! but WITHOUT ANY WARRANTY; without even the implied warranty of
11!! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
12!! GNU General Public License for more details.
13!!
14!! You should have received a copy of the GNU General Public License
15!! along with this program; if not, write to the Free Software
16!! Foundation, Inc., 51 Franklin Street, Fifth Floor, Boston, MA
17!! 02110-1301, USA.
18!!
19
20#include "global.h"
21
22module ions_oct_m
23 use atom_oct_m
26 use iso_c_binding
27 use debug_oct_m
29 use global_oct_m
33 use io_oct_m
35 use, intrinsic :: iso_fortran_env
39 use math_oct_m
42 use mpi_oct_m
44 use parser_oct_m
48 use space_oct_m
51 use spglib_f08
55 use unit_oct_m
58
59 implicit none
60
61 private
62 public :: ions_t
63
64 type, extends(charged_particles_t) :: ions_t
65 ! Components are public by default
66
67 type(lattice_vectors_t) :: latt
68
69 integer :: natoms
70 type(atom_t), allocatable :: atom(:)
71
72 type(symmetries_t) :: symm
73
74 type(distributed_t) :: atoms_dist
75
76 integer, allocatable :: map_symm_atoms(:,:)
77 integer, allocatable :: inv_map_symm_atoms(:,:)
78
79
81 integer :: nspecies
82 class(species_wrapper_t), allocatable :: species(:)
83 logical :: only_user_def
84 logical, private :: species_time_dependent
85
86 logical :: force_total_enforce
87 type(ion_interaction_t) :: ion_interaction
88
90 logical, private :: apply_global_force
91 type(tdf_t), private :: global_force_function
92 contains
93 procedure :: copy => ions_copy
94 generic :: assignment(=) => copy
95 procedure :: partition => ions_partition
96 procedure :: init_interaction => ions_init_interaction
97 procedure :: initialize => ions_initialize
98 procedure :: update_quantity => ions_update_quantity
99 procedure :: init_interaction_as_partner => ions_init_interaction_as_partner
100 procedure :: copy_quantities_to_interaction => ions_copy_quantities_to_interaction
101 procedure :: fold_atoms_into_cell => ions_fold_atoms_into_cell
102 procedure :: min_distance => ions_min_distance
103 procedure :: has_time_dependent_species => ions_has_time_dependent_species
104 procedure :: val_charge => ions_val_charge
105 procedure :: dipole => ions_dipole
106 procedure :: translate => ions_translate
107 procedure :: rotate => ions_rotate
108 procedure :: global_force => ions_global_force
109 procedure :: write_xyz => ions_write_xyz
110 procedure :: read_xyz => ions_read_xyz
111 procedure :: write_crystal => ions_write_crystal
112 procedure :: write_bild_forces_file => ions_write_bild_forces_file
113 procedure :: write_vtk_geometry => ions_write_vtk_geometry
114 procedure :: update_lattice_vectors => ions_update_lattice_vectors
115 procedure :: symmetrize_atomic_coord => ions_symmetrize_atomic_coord
116 procedure :: generate_mapping_symmetric_atoms => ions_generate_mapping_symmetric_atoms
117 procedure :: print_spacegroup => ions_print_spacegroup
118 final :: ions_finalize
119 end type ions_t
120
121 interface ions_t
122 procedure ions_constructor
123 end interface ions_t
124
125contains
126
127 ! ---------------------------------------------------------
128 function ions_constructor(namespace, print_info, latt_inp) result(ions)
129 type(namespace_t), intent(in) :: namespace
130 logical, optional, intent(in) :: print_info
131 type(lattice_vectors_t), optional, intent(out) :: latt_inp
132 class(ions_t), pointer :: ions
133
134 type(read_coords_info) :: xyz
135 integer :: ia, ierr, idir
136 character(len=100) :: function_name
137 real(real64) :: mindist
138 real(real64), allocatable :: factor(:)
139 integer, allocatable :: site_type(:)
140 logical, allocatable :: spherical_site(:)
141 real(real64), parameter :: threshold = 1e-5_real64
142 type(species_factory_t) :: factory
143
144 push_sub(ions_constructor)
145
146 allocate(ions)
147
148 ions%namespace = namespace
149
150 ions%space = space_t(namespace)
151
152 call species_factory_init(factory, namespace)
153
154 ! initialize geometry
155 call read_coords_init(xyz)
156
157 ! load positions of the atoms
158 call read_coords_read('Coordinates', xyz, ions%space, namespace)
159
160 if (xyz%n < 1) then
161 message(1) = "Coordinates have not been defined."
162 call messages_fatal(1, namespace=namespace)
163 end if
164
165 ! Initialize parent class
166 call charged_particles_init(ions, xyz%n)
168 ! copy information from xyz to ions
169 ions%natoms = xyz%n
170 safe_allocate(ions%atom(1:ions%natoms))
171 do ia = 1, ions%natoms
172 call atom_init(ions%atom(ia), ions%space%dim, xyz%atom(ia)%label)
173 ions%pos(:,ia) = xyz%atom(ia)%x(1:ions%space%dim)
174 if (bitand(xyz%flags, xyz_flags_move) /= 0) then
175 ions%fixed(ia) = .not. xyz%atom(ia)%move
176 end if
177 end do
178
179 if (allocated(xyz%latvec)) then
180 ! Build lattice vectors from the XSF input
181 ions%latt = lattice_vectors_t(namespace, ions%space, xyz%latvec)
182 else
183 ! Build lattice vectors from input file
184 ions%latt = lattice_vectors_t(namespace, ions%space)
185 end if
187 ! Convert coordinates to Cartesian in case we have reduced coordinates
188 if (xyz%source == read_coords_reduced) then
189 do ia = 1, ions%natoms
190 ions%pos(:, ia) = ions%latt%red_to_cart(ions%pos(:, ia))
191 end do
192 end if
197 call ions_init_species(ions, factory, print_info=print_info)
198 call distributed_nullify(ions%atoms_dist, ions%natoms)
200 call messages_obsolete_variable(namespace, 'PDBClassical')
202 if (present(latt_inp)) then
203 ! The lattice as read from the input might be needed by some other part of the code, so we save it
204 latt_inp = ions%latt
205 end if
207 ! Now that we have processed the atomic coordinates, we renormalize the
208 ! lattice parameters along the non-periodic dimensions
209 if (ions%space%has_mixed_periodicity()) then
210 safe_allocate(factor(ions%space%dim))
211 do idir = 1, ions%space%periodic_dim
212 factor(idir) = m_one
213 end do
214 do idir = ions%space%periodic_dim + 1, ions%space%dim
215 factor(idir) = m_one/norm2(ions%latt%rlattice(1:ions%space%dim, idir))
216 end do
217 call ions%latt%scale(factor)
218 safe_deallocate_a(factor)
219 end if
220
221 ! Set the masses and charges. This needs to be done after initializing the species.
222 do ia = 1, ions%natoms
223 ions%mass(ia) = ions%atom(ia)%species%get_mass()
224 ions%charge(ia) = ions%atom(ia)%species%get_zval()
225 end do
226
227 ! Check that atoms are not too close
228 if (ions%natoms > 1) then
229 mindist = ions_min_distance(ions, real_atoms_only = .false.)
230 if (mindist < threshold) then
231 write(message(1), '(a)') "Some of the atoms seem to sit too close to each other."
232 write(message(2), '(a)') "Please review your input files and the output geometry (in 'static/')."
233 write(message(3), '(a, f12.6, 1x, a)') "Minimum distance = ", &
234 units_from_atomic(units_out%length, mindist), trim(units_abbrev(units_out%length))
235 call messages_warning(3, namespace=namespace)
236
237 ! then write out the geometry, whether asked for or not in Output variable
238 call io_mkdir(static_dir, namespace)
239 call ions%write_xyz(trim(static_dir)//'/geometry')
240 end if
241
242 if (ions_min_distance(ions, real_atoms_only = .true.) < threshold) then
243 message(1) = "It cannot be correct to run with physical atoms so close."
244 call messages_fatal(1, namespace=namespace)
245 end if
246 end if
247
248 !Initialize symmetries
249 safe_allocate(spherical_site(1:ions%natoms))
250 safe_allocate(site_type(1:ions%natoms))
251 do ia = 1, ions%natoms
252 select type(spec => ions%atom(ia)%species)
253 type is(jellium_slab_t)
254 spherical_site(ia) = .false.
256 spherical_site(ia) = .false.
257 type is(species_from_file_t)
258 spherical_site(ia) = .false.
260 spherical_site(ia) = .false.
261 class default
262 spherical_site(ia) = .true.
263 end select
264
265 site_type(ia) = ions%atom(ia)%species%get_index()
266 end do
267
268 ions%symm = symmetries_t(ions%namespace, ions%space, ions%latt, ions%natoms, ions%pos, site_type, spherical_site)
269
270 safe_deallocate_a(spherical_site)
271 safe_deallocate_a(site_type)
272
273 ! Generate the mapping of symmetric atoms
274 call ions%generate_mapping_symmetric_atoms()
275
276 call ion_interaction_init(ions%ion_interaction, namespace, ions%space, ions%natoms)
277
278 !%Variable ForceTotalEnforce
279 !%Type logical
280 !%Default no
281 !%Section Hamiltonian
282 !%Description
283 !% (Experimental) If this variable is set to "yes", then the sum
284 !% of the total forces will be enforced to be zero.
285 !%End
286 call parse_variable(namespace, 'ForceTotalEnforce', .false., ions%force_total_enforce)
287 if (ions%force_total_enforce) call messages_experimental('ForceTotalEnforce', namespace=namespace)
288
289 !%Variable TDGlobalForce
290 !%Type string
291 !%Section Time-Dependent
292 !%Description
293 !% If this variable is set, a global time-dependent force will be
294 !% applied to the ions in the x direction during a time-dependent
295 !% run. This variable defines the base name of the force, that
296 !% should be defined in the <tt>TDFunctions</tt> block. This force
297 !% does not affect the electrons directly.
298 !%End
299
300 if (parse_is_defined(namespace, 'TDGlobalForce')) then
301
302 ions%apply_global_force = .true.
303
304 call parse_variable(namespace, 'TDGlobalForce', 'none', function_name)
305 call tdf_read(ions%global_force_function, namespace, trim(function_name), ierr)
306
307 if (ierr /= 0) then
308 call messages_write("You have enabled the GlobalForce option but Octopus could not find")
309 call messages_write("the '"//trim(function_name)//"' function in the TDFunctions block.")
310 call messages_fatal(namespace=namespace)
311 end if
312
313 else
314
315 ions%apply_global_force = .false.
316
317 end if
318
319 call species_factory_end(factory)
320
321 pop_sub(ions_constructor)
322 end function ions_constructor
323
324 ! ---------------------------------------------------------
325 subroutine ions_init_species(ions, factory, print_info)
326 type(ions_t), intent(inout) :: ions
327 type(species_factory_t), intent(in) :: factory
328 logical, optional, intent(in) :: print_info
329
330 logical :: print_info_, spec_user_defined
331 integer :: i, j, k, ispin
332 class(species_t), pointer :: spec
333
334 push_sub(ions_init_species)
335
336 print_info_ = .true.
337 if (present(print_info)) then
338 print_info_ = print_info
339 end if
340 ! First, count the species
341 ions%nspecies = 0
342 atoms1: do i = 1, ions%natoms
343 do j = 1, i - 1
344 if (atom_same_species(ions%atom(j), ions%atom(i))) cycle atoms1
345 end do
346 ions%nspecies = ions%nspecies + 1
347 end do atoms1
348
349 ! Allocate the species structure.
350 allocate(ions%species(1:ions%nspecies))
351
352 ! Now, read the data.
353 k = 0
354 ions%only_user_def = .true.
355 atoms2: do i = 1, ions%natoms
356 do j = 1, i - 1
357 if (atom_same_species(ions%atom(j), ions%atom(i))) cycle atoms2
358 end do
359 k = k + 1
360 ions%species(k)%s => factory%create_from_input(ions%namespace, atom_get_label(ions%atom(j)), k)
361 ! these are the species which do not represent atoms
362 select type(spec => ions%species(k)%s)
363 class is(jellium_t)
364
365 class default
366 ions%only_user_def = .false.
367 end select
368
369 select type(spec => ions%species(k)%s)
370 type is(pseudopotential_t)
371 if (ions%space%dim /= 3) then
372 message(1) = "Pseudopotentials may only be used with Dimensions = 3."
373 call messages_fatal(1, namespace=ions%namespace)
374 end if
375
376 type is(jellium_slab_t)
377 if (ions%space%is_periodic() .and. ions%space%periodic_dim /= 2) then
378 message(1) = "Periodic jelium slab can only be used if PeriodicDim = 2"
379 call messages_fatal(1, namespace=ions%namespace)
380 end if
381 end select
382
383 end do atoms2
384
385 ! Reads the spin components. This is read here, as well as in states_init,
386 ! to be able to pass it to the pseudopotential initializations subroutine.
387 call parse_variable(ions%namespace, 'SpinComponents', 1, ispin)
388 if (.not. varinfo_valid_option('SpinComponents', ispin)) call messages_input_error(ions%namespace, 'SpinComponents')
389 ispin = min(2, ispin)
390
391 if (print_info_) then
392 call messages_print_with_emphasis(msg="Species", namespace=ions%namespace)
393 end if
394 do i = 1, ions%nspecies
395 spec => ions%species(i)%s
396 call spec%build(ions%namespace, ispin, ions%space%dim, print_info=print_info_)
397 end do
398 if (print_info_) then
399 call messages_print_with_emphasis(namespace=ions%namespace)
400 end if
401
402 !%Variable SpeciesTimeDependent
403 !%Type logical
404 !%Default no
405 !%Section System::Species
406 !%Description
407 !% When this variable is set, the potential defined in the block <tt>Species</tt> is calculated
408 !% and applied to the Hamiltonian at each time step. You must have at least one <tt>species_user_defined</tt>
409 !% type of species to use this.
410 !%End
411 call parse_variable(ions%namespace, 'SpeciesTimeDependent', .false., ions%species_time_dependent)
412 ! we must have at least one user defined species in order to have time dependency
413 do i = 1,ions%nspecies
414 select type(spec=>ions%species(i)%s)
416 spec_user_defined = .true.
417 end select
418 end do
419 if (ions%species_time_dependent .and. .not. spec_user_defined) then
420 call messages_input_error(ions%namespace, 'SpeciesTimeDependent')
421 end if
422
423 ! assign species
424 do i = 1, ions%natoms
425 do j = 1, ions%nspecies
426 if (atom_same_species(ions%atom(i), ions%species(j)%s)) then
427 call atom_set_species(ions%atom(i), ions%species(j)%s)
428 exit
429 end if
430 end do
431 end do
432
433 pop_sub(ions_init_species)
434 end subroutine ions_init_species
435
436 !--------------------------------------------------------------
437 subroutine ions_copy(ions_out, ions_in)
438 class(ions_t), intent(out) :: ions_out
439 class(ions_t), intent(in) :: ions_in
440
441 push_sub(ions_copy)
442
443 call charged_particles_copy(ions_out, ions_in)
444
445 ions_out%latt = ions_in%latt
446
447 ions_out%natoms = ions_in%natoms
448 safe_allocate(ions_out%atom(1:ions_out%natoms))
449 ions_out%atom = ions_in%atom
450
451 ions_out%nspecies = ions_in%nspecies
452 allocate(ions_out%species(1:ions_out%nspecies))
453 ions_out%species = ions_in%species
454
455 ions_out%only_user_def = ions_in%only_user_def
456
457 call distributed_copy(ions_in%atoms_dist, ions_out%atoms_dist)
458
459 safe_allocate(ions_out%map_symm_atoms(1:ions_in%natoms, 1:ions_in%symm%nops))
460 ions_out%map_symm_atoms = ions_in%map_symm_atoms
461 safe_allocate(ions_out%inv_map_symm_atoms(1:ions_in%natoms, 1:ions_in%symm%nops))
462 ions_out%inv_map_symm_atoms = ions_in%inv_map_symm_atoms
463
464
465 pop_sub(ions_copy)
466 end subroutine ions_copy
467
468 ! ---------------------------------------------------------
469 subroutine ions_partition(this, mc)
470 class(ions_t), intent(inout) :: this
471 type(multicomm_t), intent(in) :: mc
472
473 push_sub(ions_partition)
474
475 call distributed_init(this%atoms_dist, this%natoms, mc%group_comm(p_strategy_states), "atoms")
476
477 call ion_interaction_init_parallelization(this%ion_interaction, this%natoms, mc)
478
479 pop_sub(ions_partition)
480 end subroutine ions_partition
481
482 ! ---------------------------------------------------------
483 subroutine ions_init_interaction(this, interaction)
484 class(ions_t), target, intent(inout) :: this
485 class(interaction_t), intent(inout) :: interaction
486
487 push_sub(ions_init_interaction)
488
489 select type (interaction)
490 class default
491 call charged_particles_init_interaction(this, interaction)
492 end select
493
494 pop_sub(ions_init_interaction)
495 end subroutine ions_init_interaction
496
497 ! ---------------------------------------------------------
498 subroutine ions_initialize(this)
499 class(ions_t), intent(inout) :: this
500
501 push_sub(ions_initialize)
502
503 pop_sub(ions_initialize)
504 end subroutine ions_initialize
505
506 ! ---------------------------------------------------------
507 subroutine ions_update_quantity(this, iq)
508 class(ions_t), intent(inout) :: this
509 integer, intent(in) :: iq
510
511 push_sub(ions_update_quantity)
512
513 ! We are only allowed to update quantities that can be updated on demand
514 assert(this%quantities(iq)%updated_on_demand)
515
516 select case (iq)
517 case default
518 ! Other quantities should be handled by the parent class
520 end select
521
522 pop_sub(ions_update_quantity)
523 end subroutine ions_update_quantity
524
525 ! ---------------------------------------------------------
526 subroutine ions_init_interaction_as_partner(partner, interaction)
527 class(ions_t), intent(in) :: partner
528 class(interaction_surrogate_t), intent(inout) :: interaction
529
531
532 select type (interaction)
533 class default
534 call charged_particles_init_interaction_as_partner(partner, interaction)
535 end select
536
539
540 ! ---------------------------------------------------------
541 subroutine ions_copy_quantities_to_interaction(partner, interaction)
542 class(ions_t), intent(inout) :: partner
543 class(interaction_surrogate_t), intent(inout) :: interaction
544
546
547 select type (interaction)
548 class default
549 ! Other interactions should be handled by the parent class
550 call charged_particles_copy_quantities_to_interaction(partner, interaction)
551 end select
552
555
556 ! ---------------------------------------------------------
557 subroutine ions_fold_atoms_into_cell(this)
558 class(ions_t), intent(inout) :: this
559
560 integer :: iatom
561
563
564 do iatom = 1, this%natoms
565 this%pos(:, iatom) = this%latt%fold_into_cell(this%pos(:, iatom))
566 end do
567
569 end subroutine ions_fold_atoms_into_cell
570
571 ! ---------------------------------------------------------
572 real(real64) function ions_min_distance(this, real_atoms_only) result(rmin)
573 class(ions_t), intent(in) :: this
574 logical, optional, intent(in) :: real_atoms_only
575
576 integer :: iatom, jatom, idir
577 real(real64) :: xx(this%space%dim)
578 logical :: real_atoms_only_
579 class(species_t), pointer :: species
580
581 if (this%natoms == 1 .and. .not. this%space%is_periodic()) then
582 rmin = m_huge
583 return
584 end if
585
586 push_sub(ions_min_distance)
587
588 real_atoms_only_ = optional_default(real_atoms_only, .false.)
589
590 rmin = m_huge
591 do iatom = 1, this%natoms
592 call atom_get_species(this%atom(iatom), species)
593 select type(species)
594 class is(jellium_t)
595 if (real_atoms_only_) cycle
596 end select
597 do jatom = iatom + 1, this%natoms
598 call atom_get_species(this%atom(jatom), species)
599 select type(species)
600 class is(jellium_t)
601 if (real_atoms_only_) cycle
602 end select
603 xx = abs(this%pos(:, iatom) - this%pos(:, jatom))
604 if (this%space%is_periodic()) then
605 xx = this%latt%cart_to_red(xx)
606 do idir = 1, this%space%periodic_dim
607 xx(idir) = xx(idir) - floor(xx(idir) + m_half)
608 end do
609 xx = this%latt%red_to_cart(xx)
610 end if
611 rmin = min(norm2(xx), rmin)
612 end do
613 end do
614
615 if (.not. (this%only_user_def .and. real_atoms_only_)) then
616 ! what if the nearest neighbors are periodic images?
617 do idir = 1, this%space%periodic_dim
618 rmin = min(rmin, norm2(this%latt%rlattice(:,idir)))
619 end do
620 end if
621
622 ! To avoid numerical instabilities, we round this to 6 digits only
623 if(rmin < huge(rmin)/1e6_real64) then
624 rmin = anint(rmin*1e6_real64)*1.0e-6_real64
625 end if
626
627 pop_sub(ions_min_distance)
628 end function ions_min_distance
629
630 ! ---------------------------------------------------------
631 logical function ions_has_time_dependent_species(this) result(time_dependent)
632 class(ions_t), intent(in) :: this
633
635
636 time_dependent = this%species_time_dependent
637
640
641 ! ---------------------------------------------------------
642 real(real64) function ions_val_charge(this, mask) result(val_charge)
643 class(ions_t), intent(in) :: this
644 logical, optional, intent(in) :: mask(:)
645
646 push_sub(ions_val_charge)
647
648 if (present(mask)) then
649 val_charge = -sum(this%charge, mask=mask)
650 else
651 val_charge = -sum(this%charge)
652 end if
653
654 pop_sub(ions_val_charge)
655 end function ions_val_charge
656
657 ! ---------------------------------------------------------
658 function ions_dipole(this, mask) result(dipole)
659 class(ions_t), intent(in) :: this
660 logical, optional, intent(in) :: mask(:)
661 real(real64) :: dipole(this%space%dim)
662
663 integer :: ia
664
665 push_sub(ions_dipole)
666
667 dipole = m_zero
668 do ia = 1, this%natoms
669 if (present(mask)) then
670 if (.not. mask(ia)) cycle
671 end if
672 dipole = dipole + this%charge(ia)*this%pos(:, ia)
673 end do
674 dipole = p_proton_charge*dipole
675
676 pop_sub(ions_dipole)
677 end function ions_dipole
678
679 ! ---------------------------------------------------------
680 subroutine ions_translate(this, xx)
681 class(ions_t), intent(inout) :: this
682 real(real64), intent(in) :: xx(this%space%dim)
683
684 integer :: iatom
685
686 push_sub(ions_translate)
687
688 do iatom = 1, this%natoms
689 this%pos(:, iatom) = this%pos(:, iatom) - xx
690 end do
691
692 pop_sub(ions_translate)
693 end subroutine ions_translate
694
695 ! ---------------------------------------------------------
696 subroutine ions_rotate(this, from, from2, to)
697 class(ions_t), intent(inout) :: this
698 real(real64), intent(in) :: from(this%space%dim)
699 real(real64), intent(in) :: from2(this%space%dim)
700 real(real64), intent(in) :: to(this%space%dim)
701
702 integer :: iatom
703 real(real64) :: m1(3, 3), m2(3, 3)
704 real(real64) :: m3(3, 3), f2(3), per(3)
705 real(real64) :: alpha, r
706
707 push_sub(ions_rotate)
708
709 if (this%space%dim /= 3) then
710 call messages_not_implemented("ions_rotate in other than 3 dimensions", namespace=this%namespace)
711 end if
712
713 ! initialize matrices
714 m1 = diagonal_matrix(3, m_one)
715
716 ! rotate the to-axis to the z-axis
717 if (abs(to(2)) > 1d-150) then
718 alpha = atan2(to(2), to(1))
719 call rotate(m1, alpha, 3)
720 end if
721 alpha = atan2(norm2(to(1:2)), to(3))
722 call rotate(m1, -alpha, 2)
723
724 ! get perpendicular to z and from
725 f2 = matmul(m1, from)
726 per(1) = -f2(2)
727 per(2) = f2(1)
728 per(3) = m_zero
729 r = norm2(per)
730 if (r > m_zero) then
731 per = per/r
732 else
733 per(2) = m_one
734 end if
736 ! rotate perpendicular axis to the y-axis
737 m2 = diagonal_matrix(3, m_one)
738 alpha = atan2(per(1), per(2))
739 call rotate(m2, -alpha, 3)
740
741 ! rotate from => to (around the y-axis)
742 m3 = diagonal_matrix(3, m_one)
743 alpha = acos(min(sum(from*to), m_one))
744 call rotate(m3, -alpha, 2)
745
746 ! join matrices
747 m2 = matmul(transpose(m2), matmul(m3, m2))
748
749 ! rotate around the z-axis to get the second axis
750 per = matmul(m2, matmul(m1, from2))
751 alpha = atan2(per(1), per(2))
752 call rotate(m2, -alpha, 3) ! second axis is now y
753
754 ! get combined transformation
755 m1 = matmul(transpose(m1), matmul(m2, m1))
756
757 ! now transform the coordinates
758 ! it is written in this way to avoid what I consider a bug in the Intel compiler
759 do iatom = 1, this%natoms
760 f2 = this%pos(:, iatom)
761 this%pos(:, iatom) = matmul(m1, f2)
762 end do
763
764 pop_sub(ions_rotate)
765 contains
766
767 ! ---------------------------------------------------------
768 subroutine rotate(m, angle, dir)
769 real(real64), intent(inout) :: m(3, 3)
770 real(real64), intent(in) :: angle
771 integer, intent(in) :: dir
772
773 real(real64) :: aux(3, 3), ca, sa
774
775 push_sub(ions_rotate.rotate)
776
777 ca = cos(angle)
778 sa = sin(angle)
779
780 aux = m_zero
781 select case (dir)
782 case (1)
783 aux(1, 1) = m_one
784 aux(2, 2) = ca
785 aux(3, 3) = ca
786 aux(2, 3) = sa
787 aux(3, 2) = -sa
788 case (2)
789 aux(2, 2) = m_one
790 aux(1, 1) = ca
791 aux(3, 3) = ca
792 aux(1, 3) = sa
793 aux(3, 1) = -sa
794 case (3)
795 aux(3, 3) = m_one
796 aux(1, 1) = ca
797 aux(2, 2) = ca
798 aux(1, 2) = sa
799 aux(2, 1) = -sa
800 end select
801
802 m = matmul(aux, m)
803
804 pop_sub(ions_rotate.rotate)
805 end subroutine rotate
806
807 end subroutine ions_rotate
808
809 ! ---------------------------------------------------------
810 function ions_global_force(this, time) result(force)
811 class(ions_t), intent(in) :: this
812 real(real64), intent(in) :: time
813 real(real64) :: force(this%space%dim)
814
815 push_sub(ions_global_force)
816
817 force = m_zero
818
819 if (this%apply_global_force) then
820 force(1) = units_to_atomic(units_inp%force, tdf(this%global_force_function, time))
821 end if
822
823 pop_sub(ions_global_force)
824 end function ions_global_force
825
826 ! ---------------------------------------------------------
827 subroutine ions_write_xyz(this, fname, append, comment, reduce_coordinates)
828 class(ions_t), intent(in) :: this
829 character(len=*), intent(in) :: fname
830 logical, optional, intent(in) :: append
831 character(len=*), optional, intent(in) :: comment
832 logical, optional, intent(in) :: reduce_coordinates
833
834 integer :: iatom, idim, iunit
835 character(len=6) position
836 character(len=19) :: frmt
837 real(real64) :: red(this%space%dim)
838
839 if (.not. mpi_grp_is_root(mpi_world)) return
840
841 push_sub(ions_write_xyz)
842
843 position = 'asis'
844 if (present(append)) then
845 if (append) position = 'append'
846 end if
847 if(.not.optional_default(reduce_coordinates, .false.)) then
848 iunit = io_open(trim(fname)//'.xyz', this%namespace, action='write', position=position)
849 else
850 iunit = io_open(trim(fname)//'.xyz_red', this%namespace, action='write', position=position)
851 end if
852
853 write(iunit, '(i4)') this%natoms
854 if (present(comment)) then
855 write(iunit, '(1x,a)') comment
856 else
857 write(iunit, '(1x,a,a)') 'units: ', trim(units_abbrev(units_out%length_xyz_file))
858 end if
859
860 write(unit=frmt, fmt="(a5,i2.2,a4,i2.2,a6)") "(6x,a", label_len, ",2x,", this%space%dim,"f12.6)"
861 do iatom = 1, this%natoms
862 if(.not.optional_default(reduce_coordinates, .false.)) then
863 write(unit=iunit, fmt=frmt) this%atom(iatom)%label, &
864 (units_from_atomic(units_out%length_xyz_file, this%pos(idim, iatom)), idim=1, this%space%dim)
865 else
866 red = this%latt%cart_to_red(this%pos(:, iatom))
867 write(unit=iunit, fmt=frmt) this%atom(iatom)%label, (red(idim), idim=1, this%space%dim)
868 end if
869 end do
870 call io_close(iunit)
871
872 pop_sub(ions_write_xyz)
873 end subroutine ions_write_xyz
874
875 ! ---------------------------------------------------------
876 subroutine ions_read_xyz(this, fname, comment)
877 class(ions_t), intent(inout) :: this
878 character(len=*), intent(in) :: fname
879 character(len=*), optional, intent(in) :: comment
880
881 integer :: iatom, idir, iunit
882 character(len=19) :: frmt, dum
883 real(real64) :: tmp(this%space%dim)
884
885 push_sub(ions_read_xyz)
886
887 iunit = io_open(trim(fname)//'.xyz', this%namespace, action='read', position='rewind')
888
889 read(iunit, '(i4)') this%natoms
890 if (present(comment)) then
891 read(iunit, *)
892 else
893 read(iunit, *)
894 end if
895 write(unit=frmt, fmt="(a5,i2.2,a4,i2.2,a6)") "(6x,a", label_len, ",2x,", this%space%dim, "f12.6)"
896 do iatom = 1, this%natoms
897 read(unit=iunit, fmt=frmt) dum, (tmp(idir), idir=1, this%space%dim)
898
899 this%pos(:, iatom) = units_to_atomic(units_out%length_xyz_file, tmp)
900 end do
901 call io_close(iunit)
902
904 end subroutine ions_read_xyz
905
906 ! ----------------------------------------------------------------
909 subroutine ions_write_crystal(this, dir)
910 class(ions_t), intent(in) :: this
911 character(len=*), intent(in) :: dir
912
913 type(lattice_iterator_t) :: latt_iter
914 real(real64) :: radius, pos(this%space%dim)
915 integer :: iatom, icopy, iunit
916
917 push_sub(ions_write_crystal)
918
919 radius = maxval(m_half*norm2(this%latt%rlattice(:,1:this%space%periodic_dim), dim=1))*(m_one + m_epsilon)
920 latt_iter = lattice_iterator_t(this%latt, radius)
921
922 if (mpi_grp_is_root(mpi_world)) then
923
924 iunit = io_open(trim(dir)//'/crystal.xyz', this%namespace, action='write')
925
926 write(iunit, '(i9)') this%natoms*latt_iter%n_cells
927 write(iunit, '(a)') '#generated by Octopus'
928
929 do iatom = 1, this%natoms
930 do icopy = 1, latt_iter%n_cells
931 pos = units_from_atomic(units_out%length, this%pos(:, iatom) + latt_iter%get(icopy))
932 write(iunit, '(a, 99f12.6)') this%atom(iatom)%label, pos
933 end do
934 end do
935
936 call io_close(iunit)
937 end if
938
939 pop_sub(ions_write_crystal)
940 end subroutine ions_write_crystal
941
942 ! ---------------------------------------------------------
943 subroutine ions_write_bild_forces_file(this, dir, fname)
944 class(ions_t), intent(in) :: this
945 character(len=*), intent(in) :: dir, fname
946
947 integer :: iunit, iatom, idir
948 real(real64) :: force(this%space%dim), center(this%space%dim)
949 character(len=20) frmt
950
951 if (.not. mpi_grp_is_root(mpi_world)) return
952
954
955 call io_mkdir(dir, this%namespace)
956 iunit = io_open(trim(dir)//'/'//trim(fname)//'.bild', this%namespace, action='write', &
957 position='asis')
958
959 write(frmt,'(a,i0,a)')'(a,2(', this%space%dim,'f16.6,1x))'
960
961 write(iunit, '(a)')'.comment : force vectors in ['//trim(units_abbrev(units_out%force))//']'
962 write(iunit, *)
963 write(iunit, '(a)')'.color red'
964 write(iunit, *)
965 do iatom = 1, this%natoms
966 center = units_from_atomic(units_out%length, this%pos(:, iatom))
967 force = units_from_atomic(units_out%force, this%tot_force(:, iatom))
968 write(iunit, '(a,1x,i4,1x,a2,1x,a6,1x,f10.6,a)') '.comment :', iatom, trim(this%atom(iatom)%label), &
969 'force:', norm2(force), '['//trim(units_abbrev(units_out%force))//']'
970 write(iunit,fmt=trim(frmt)) '.arrow', (center(idir), idir = 1, this%space%dim), &
971 (center(idir) + force(idir), idir = 1, this%space%dim)
972 write(iunit,*)
973 end do
974
975 call io_close(iunit)
976
978 end subroutine ions_write_bild_forces_file
979
980 ! -----------------------------------------------------
981 subroutine ions_write_vtk_geometry(this, filename, ascii)
982 class(ions_t), intent(in) :: this
983 character(len=*), intent(in) :: filename
984 logical, optional, intent(in) :: ascii
985
986 integer :: iunit, iatom, ierr
987 logical :: ascii_
988 real(real64), allocatable :: data(:, :)
989 integer, allocatable :: idata(:, :)
990 character(len=MAX_PATH_LEN) :: fullname
991
993
994 assert(this%space%dim == 3)
995
996 ascii_ = optional_default(ascii, .true.)
997
998 fullname = trim(filename)//".vtk"
999
1000 iunit = io_open(trim(fullname), this%namespace, action='write')
1001
1002 write(iunit, '(1a)') '# vtk DataFile Version 3.0 '
1003 write(iunit, '(6a)') 'Generated by octopus ', trim(conf%version), ' - git: ', &
1004 trim(conf%git_commit), " configuration: ", trim(conf%config_time)
1005
1006 if (ascii_) then
1007 write(iunit, '(1a)') 'ASCII'
1008 else
1009 write(iunit, '(1a)') 'BINARY'
1010 end if
1011
1012 write(iunit, '(1a)') 'DATASET POLYDATA'
1013
1014 write(iunit, '(a,i9,a)') 'POINTS ', this%natoms, ' double'
1015
1016 if (ascii_) then
1017 do iatom = 1, this%natoms
1018 write(iunit, '(3f12.6)') this%pos(1:3, iatom)
1019 end do
1020 else
1021 call io_close(iunit)
1022 safe_allocate(data(1:3, 1:this%natoms))
1023 do iatom = 1, this%natoms
1024 data(1:3, iatom) = this%pos(1:3, iatom)
1025 end do
1026 call io_binary_write(io_workpath(fullname, this%namespace), i4_to_i8(3*this%natoms), data, &
1027 ierr, nohead = .true., fendian = io_binary_is_little_endian())
1028 safe_deallocate_a(data)
1029 iunit = io_open(trim(fullname), this%namespace, action='write', position = 'append')
1030 write(iunit, '(1a)') ''
1031 end if
1032
1033 write(iunit, '(a,2i9)') 'VERTICES ', this%natoms, 2*this%natoms
1034
1035 if (ascii_) then
1036 do iatom = 1, this%natoms
1037 write(iunit, '(2i9)') 1, iatom - 1
1038 end do
1039 else
1040 call io_close(iunit)
1041 safe_allocate(idata(1:2, 1:this%natoms))
1042 do iatom = 1, this%natoms
1043 idata(1, iatom) = 1
1044 idata(2, iatom) = iatom - 1
1045 end do
1046 call io_binary_write(io_workpath(fullname, this%namespace), i4_to_i8(2*this%natoms), idata, &
1047 ierr, nohead = .true., fendian = io_binary_is_little_endian())
1048 safe_deallocate_a(idata)
1049 iunit = io_open(trim(fullname), this%namespace, action='write', position = 'append')
1050 write(iunit, '(1a)') ''
1051 end if
1052
1053 write(iunit, '(a,i9)') 'POINT_DATA', this%natoms
1054 write(iunit, '(a)') 'SCALARS element integer'
1055 write(iunit, '(a)') 'LOOKUP_TABLE default'
1056
1057 if (ascii_) then
1058 do iatom = 1, this%natoms
1059 write(iunit, '(i9)') nint(this%atom(iatom)%species%get_z())
1060 end do
1061 else
1062 call io_close(iunit)
1063
1064 safe_allocate(idata(1:this%natoms, 1))
1065
1066 do iatom = 1, this%natoms
1067 idata(iatom, 1) = nint(this%atom(iatom)%species%get_z())
1068 end do
1069
1070 call io_binary_write(io_workpath(fullname, this%namespace), i4_to_i8(this%natoms), idata, &
1071 ierr, nohead = .true., fendian = io_binary_is_little_endian())
1072
1073 safe_deallocate_a(idata)
1075 iunit = io_open(trim(fullname), this%namespace, action='write', position = 'append')
1076 write(iunit, '(1a)') ''
1077 end if
1078
1079 call io_close(iunit)
1080
1082 end subroutine ions_write_vtk_geometry
1083
1084 ! ---------------------------------------------------------
1085 subroutine ions_finalize(ions)
1086 type(ions_t), intent(inout) :: ions
1087
1088 integer :: i
1089
1090 push_sub(ions_finalize)
1091
1092 call distributed_end(ions%atoms_dist)
1093
1094 call ion_interaction_end(ions%ion_interaction)
1095
1096 safe_deallocate_a(ions%atom)
1097 ions%natoms=0
1098
1099 if(allocated(ions%species)) then
1100 do i = 1, ions%nspecies
1101 !SAFE_ DEALLOCATE_P(ions%species(i)%s)
1102 if(associated(ions%species(i)%s)) deallocate(ions%species(i)%s)
1103 end do
1104 deallocate(ions%species)
1105 end if
1106 ions%nspecies=0
1107
1108 call charged_particles_end(ions)
1109
1110 safe_deallocate_a(ions%map_symm_atoms)
1111 safe_deallocate_a(ions%inv_map_symm_atoms)
1112
1113
1114 pop_sub(ions_finalize)
1115 end subroutine ions_finalize
1116
1117 !-------------------------------------------------------------------
1120 subroutine ions_update_lattice_vectors(ions, latt, symmetrize)
1121 class(ions_t), intent(inout) :: ions
1122 type(lattice_vectors_t), intent(in) :: latt
1123 logical, intent(in) :: symmetrize
1124
1126
1127 ! Update the lattice vectors
1128 call ions%latt%update(latt%rlattice)
1129
1130 ! Regenerate symmetries in Cartesian space
1131 if (symmetrize) then
1132 call symmetries_update_lattice_vectors(ions%symm, latt, ions%space%dim)
1133 end if
1134
1136 end subroutine ions_update_lattice_vectors
1137
1138 !-------------------------------------------------------------------
1145 class(ions_t), intent(inout) :: ions
1146
1147 integer :: iatom, iop, iatom_symm, dim4symms
1148 real(real64) :: ratom(ions%space%dim)
1149
1151
1152 safe_allocate(ions%map_symm_atoms(1:ions%natoms, 1:ions%symm%nops + ions%symm%nops_nonsymmorphic))
1153 safe_allocate(ions%inv_map_symm_atoms(1:ions%natoms, 1:ions%symm%nops + ions%symm%nops_nonsymmorphic))
1154
1155 ! In the 4D case, symmetries are only defined in 3D, see symmetries.F90
1156 dim4symms = min(3, ions%space%dim)
1157 ratom = m_zero
1158
1159 do iop = 1, ions%symm%nops
1160 do iatom = 1, ions%natoms
1161 !We find the atom that correspond to this one, once symmetry is applied
1162 ratom(1:dim4symms) = symm_op_apply_inv_cart(ions%symm%ops(iop), ions%pos(:, iatom))
1163
1164 ratom(:) = ions%latt%fold_into_cell(ratom(:))
1165
1166 ! find iatom_symm
1167 do iatom_symm = 1, ions%natoms
1168 if (all(abs(ratom(:) - ions%pos(:, iatom_symm)) < symprec)) exit
1169 end do
1170
1171 if (iatom_symm > ions%natoms) then
1172 write(message(1),'(a,i6)') 'Internal error: could not find symmetric partner for atom number', iatom
1173 write(message(2),'(a,i3,a)') 'with symmetry operation number ', iop, '.'
1174 call messages_fatal(2, namespace=ions%namespace)
1175 end if
1176
1177 ions%map_symm_atoms(iatom, iop) = iatom_symm
1178 ions%inv_map_symm_atoms(iatom_symm, iop) = iatom
1179 end do
1180 end do
1181
1182 ! Also build a map for non-symmorphic operations
1183 do iop = 1, ions%symm%nops_nonsymmorphic
1184 do iatom = 1, ions%natoms
1185 !We find the atom that correspond to this one, once symmetry is applied
1186 ratom(1:dim4symms) = symm_op_apply_inv_cart(ions%symm%non_symmorphic_ops(iop), ions%pos(:, iatom))
1187
1188 ratom(:) = ions%latt%fold_into_cell(ratom(:))
1189
1190 ! find iatom_symm
1191 do iatom_symm = 1, ions%natoms
1192 if (all(abs(ratom(:) - ions%pos(:, iatom_symm)) < symprec)) exit
1193 end do
1194
1195 if (iatom_symm > ions%natoms) then
1196 write(message(1),'(a,i6)') 'Internal error: could not find symmetric partner for atom number', iatom
1197 write(message(2),'(a,i3,a)') 'with symmetry operation number ', iop, '.'
1198 call messages_fatal(2, namespace=ions%namespace)
1199 end if
1200
1201 ions%map_symm_atoms(iatom, ions%symm%nops+iop) = iatom_symm
1202 ions%inv_map_symm_atoms(iatom_symm, ions%symm%nops+iop) = iatom
1203 end do
1204 end do
1205
1206
1209
1210 !-------------------------------------------------------------------
1214 subroutine ions_symmetrize_atomic_coord(ions)
1215 class(ions_t), intent(inout) :: ions
1216
1217 integer :: iatom, iop, iatom_sym
1218 real(real64) :: ratom(ions%space%dim)
1219 real(real64), allocatable :: new_pos(:,:)
1220
1222
1223 safe_allocate(new_pos(1:ions%space%dim, 1:ions%natoms))
1224
1225 do iatom = 1, ions%natoms
1226 new_pos(:, iatom) = m_zero
1227
1228 ! Symmorphic operations
1229 do iop = 1, ions%symm%nops
1230 iatom_sym = ions%inv_map_symm_atoms(iatom, iop)
1231 ratom = symm_op_apply_inv_cart(ions%symm%ops(iop), ions%pos(:, iatom_sym))
1232 ratom = ions%latt%fold_into_cell(ratom)
1233 new_pos(:, iatom) = new_pos(:, iatom) + ratom
1234 end do
1235
1236 ! Non-symmorphic operations
1237 do iop = 1, ions%symm%nops_nonsymmorphic
1238 iatom_sym = ions%inv_map_symm_atoms(iatom, iop + ions%symm%nops)
1239 ratom = symm_op_apply_inv_cart(ions%symm%non_symmorphic_ops(iop), ions%pos(:, iatom_sym))
1240 ratom = ions%latt%fold_into_cell(ratom)
1241 new_pos(:, iatom) = new_pos(:, iatom) + ratom
1242 end do
1243
1244 new_pos(:, iatom) = new_pos(:, iatom) / (ions%symm%nops + ions%symm%nops_nonsymmorphic)
1245 end do
1246
1247
1249 end subroutine ions_symmetrize_atomic_coord
1250
1252 subroutine ions_print_spacegroup(ions)
1253 class(ions_t), intent(inout) :: ions
1254
1255 type(spglibdataset) :: spg_dataset
1256 character(len=11) :: symbol = ""
1257 integer, allocatable :: site_type(:)
1258 integer :: space_group, ia
1259
1260 if(.not. ions%space%is_periodic()) return
1261
1262 push_sub(ions_print_spacegroup)
1263
1264 safe_allocate(site_type(1:ions%natoms))
1265 do ia = 1, ions%natoms
1266 site_type(ia) = ions%atom(ia)%species%get_index()
1267 end do
1268
1269 spg_dataset = symmetries_get_spg_dataset(ions%namespace, ions%space, ions%latt, ions%natoms, ions%pos, site_type)
1270
1271 safe_deallocate_a(site_type)
1272
1273 if (spg_dataset%spglib_error /= 0) then
1274 pop_sub(ions_print_spacegroup)
1275 return
1276 end if
1277
1278 space_group = spg_dataset%spacegroup_number
1279 symbol = spg_dataset%international_symbol
1280
1281 write(message(1),'(a, i4)') 'Info: Space group No. ', space_group
1282 write(message(2),'(2a)') 'Info: International: ', trim(symbol)
1283 call messages_info(2, namespace=ions%namespace)
1284
1285 pop_sub(ions_print_spacegroup)
1286 end subroutine ions_print_spacegroup
1287
1288end module ions_oct_m
1289
1290!! Local Variables:
1291!! mode: f90
1292!! coding: utf-8
1293!! End:
double acos(double __x) __attribute__((__nothrow__
double sin(double __x) __attribute__((__nothrow__
double cos(double __x) __attribute__((__nothrow__
double atan2(double __y, double __x) __attribute__((__nothrow__
double floor(double __x) __attribute__((__nothrow__
subroutine rotate(m, angle, dir)
Definition: ions.F90:862
pure character(len=len_trim(adjustl(this%label))) function, public atom_get_label(this)
Definition: atom.F90:236
subroutine, public atom_init(this, dim, label, species)
Definition: atom.F90:149
subroutine, public atom_get_species(this, species)
Definition: atom.F90:258
subroutine, public atom_set_species(this, species)
Definition: atom.F90:246
This module handles the calculation mode.
integer, parameter, public p_strategy_states
parallelization in states
subroutine, public charged_particles_copy(this, cp_in)
subroutine, public charged_particles_init_interaction_as_partner(partner, interaction)
subroutine, public charged_particles_update_quantity(this, iq)
subroutine, public charged_particles_init_interaction(this, interaction)
subroutine, public charged_particles_copy_quantities_to_interaction(partner, interaction)
subroutine, public charged_particles_init(this, np)
The init routine is a module level procedure This has the advantage that different classes can have d...
subroutine, public distributed_nullify(this, total)
subroutine, public distributed_init(this, total, comm, tag, scalapack_compat)
Distribute N instances across M processes of communicator comm
subroutine, public distributed_copy(in, out)
@Brief Create a copy of a distributed instance
real(real64), parameter, public m_huge
Definition: global.F90:205
character(len= *), parameter, public static_dir
Definition: global.F90:251
real(real64), parameter, public m_half
Definition: global.F90:193
real(real64), parameter, public m_one
Definition: global.F90:188
This module defines the abstract interaction_t class, and some auxiliary classes for interactions.
Definition: io.F90:114
subroutine, public io_mkdir(fname, namespace, parents)
Definition: io.F90:354
subroutine, public ion_interaction_init_parallelization(this, natoms, mc)
subroutine, public ion_interaction_init(this, namespace, space, natoms)
subroutine ions_init_interaction(this, interaction)
Definition: ions.F90:577
subroutine ions_update_lattice_vectors(ions, latt, symmetrize)
Regenerate the ions information after update of the lattice vectors.
Definition: ions.F90:1214
class(ions_t) function, pointer ions_constructor(namespace, print_info, latt_inp)
Definition: ions.F90:222
subroutine ions_fold_atoms_into_cell(this)
Definition: ions.F90:651
real(real64) function, dimension(this%space%dim) ions_global_force(this, time)
Definition: ions.F90:904
subroutine ions_copy(ions_out, ions_in)
Definition: ions.F90:531
subroutine ions_generate_mapping_symmetric_atoms(ions)
Given the symmetries of the system, we create a mapping that tell us for each atom and symmetry,...
Definition: ions.F90:1238
subroutine ions_write_xyz(this, fname, append, comment, reduce_coordinates)
Definition: ions.F90:921
subroutine ions_init_species(ions, factory, print_info)
Definition: ions.F90:419
subroutine ions_finalize(ions)
Definition: ions.F90:1179
subroutine ions_initialize(this)
Definition: ions.F90:592
subroutine ions_read_xyz(this, fname, comment)
Definition: ions.F90:970
subroutine ions_write_vtk_geometry(this, filename, ascii)
Definition: ions.F90:1075
subroutine ions_update_quantity(this, iq)
Definition: ions.F90:601
subroutine ions_rotate(this, from, from2, to)
Definition: ions.F90:790
subroutine ions_translate(this, xx)
Definition: ions.F90:774
subroutine ions_symmetrize_atomic_coord(ions)
Symmetrizes atomic coordinates by applying all symmetries.
Definition: ions.F90:1308
subroutine ions_print_spacegroup(ions)
Prints the spacegroup of the system for periodic systems.
Definition: ions.F90:1346
real(real64) function ions_min_distance(this, real_atoms_only)
Definition: ions.F90:666
real(real64) function, dimension(this%space%dim) ions_dipole(this, mask)
Definition: ions.F90:752
subroutine ions_write_bild_forces_file(this, dir, fname)
Definition: ions.F90:1037
subroutine ions_write_crystal(this, dir)
This subroutine creates a crystal by replicating the geometry and writes the result to dir.
Definition: ions.F90:1003
logical function ions_has_time_dependent_species(this)
Definition: ions.F90:725
subroutine ions_partition(this, mc)
Definition: ions.F90:563
subroutine ions_init_interaction_as_partner(partner, interaction)
Definition: ions.F90:620
subroutine ions_copy_quantities_to_interaction(partner, interaction)
Definition: ions.F90:635
real(real64) function ions_val_charge(this, mask)
Definition: ions.F90:736
This module is intended to contain "only mathematical" functions and procedures.
Definition: math.F90:115
subroutine, public messages_print_with_emphasis(msg, iunit, namespace)
Definition: messages.F90:930
character(len=512), private msg
Definition: messages.F90:165
subroutine, public messages_warning(no_lines, all_nodes, namespace)
Definition: messages.F90:543
subroutine, public messages_obsolete_variable(namespace, name, rep)
Definition: messages.F90:1057
character(len=256), dimension(max_lines), public message
to be output by fatal, warning
Definition: messages.F90:160
subroutine, public messages_fatal(no_lines, only_root_writes, namespace)
Definition: messages.F90:420
subroutine, public messages_input_error(namespace, var, details, row, column)
Definition: messages.F90:723
subroutine, public messages_experimental(name, namespace)
Definition: messages.F90:1097
This module handles the communicators for the various parallelization strategies.
Definition: multicomm.F90:145
logical function, public parse_is_defined(namespace, name)
Definition: parser.F90:502
integer, parameter, public read_coords_reduced
subroutine, public read_coords_init(gf)
integer, parameter, public xyz_flags_move
subroutine, public read_coords_end(gf)
subroutine, public read_coords_read(what, gf, space, namespace)
subroutine, public species_factory_init(factory, namespace)
subroutine, public species_factory_end(factory)
subroutine, public tdf_read(f, namespace, function_name, ierr)
This function initializes "f" from the TDFunctions block.
Definition: tdfunction.F90:218
brief This module defines the class unit_t which is used by the unit_systems_oct_m module.
Definition: unit.F90:132
character(len=20) pure function, public units_abbrev(this)
Definition: unit.F90:223
This module defines the unit system, used for input and output.
type(unit_system_t), public units_out
abstract interaction class
surrogate interaction class to avoid circular dependencies between modules.
Stores all communicators and groups.
Definition: multicomm.F90:206
An abstract class for species. Derived classes include jellium, all electron, and pseudopotential spe...
Definition: species.F90:143
int true(void)