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_with_profile(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_with_profile(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_with_profile(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_with_profile(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, label)
508 class(ions_t), intent(inout) :: this
509 character(len=*), intent(in) :: label
510
511 push_sub(ions_update_quantity)
512
513 select case (label)
514 case default
515 ! Other quantities should be handled by the parent class
516 call charged_particles_update_quantity(this, label)
517 end select
518
519 pop_sub(ions_update_quantity)
520 end subroutine ions_update_quantity
521
522 ! ---------------------------------------------------------
523 subroutine ions_init_interaction_as_partner(partner, interaction)
524 class(ions_t), intent(in) :: partner
525 class(interaction_surrogate_t), intent(inout) :: interaction
526
528
529 select type (interaction)
530 class default
531 call charged_particles_init_interaction_as_partner(partner, interaction)
532 end select
533
536
537 ! ---------------------------------------------------------
538 subroutine ions_copy_quantities_to_interaction(partner, interaction)
539 class(ions_t), intent(inout) :: partner
540 class(interaction_surrogate_t), intent(inout) :: interaction
541
543
544 select type (interaction)
545 class default
546 ! Other interactions should be handled by the parent class
547 call charged_particles_copy_quantities_to_interaction(partner, interaction)
548 end select
549
552
553 ! ---------------------------------------------------------
554 subroutine ions_fold_atoms_into_cell(this)
555 class(ions_t), intent(inout) :: this
556
557 integer :: iatom
558
560
561 do iatom = 1, this%natoms
562 this%pos(:, iatom) = this%latt%fold_into_cell(this%pos(:, iatom))
563 end do
564
566 end subroutine ions_fold_atoms_into_cell
567
568 ! ---------------------------------------------------------
569 real(real64) function ions_min_distance(this, real_atoms_only) result(rmin)
570 class(ions_t), intent(in) :: this
571 logical, optional, intent(in) :: real_atoms_only
572
573 integer :: iatom, jatom, idir
574 real(real64) :: xx(this%space%dim)
575 logical :: real_atoms_only_
576 class(species_t), pointer :: species
577
578 if (this%natoms == 1 .and. .not. this%space%is_periodic()) then
579 rmin = m_huge
580 return
581 end if
582
583 push_sub(ions_min_distance)
584
585 real_atoms_only_ = optional_default(real_atoms_only, .false.)
586
587 rmin = m_huge
588 do iatom = 1, this%natoms
589 call atom_get_species(this%atom(iatom), species)
590 select type(species)
591 class is(jellium_t)
592 if (real_atoms_only_) cycle
593 end select
594 do jatom = iatom + 1, this%natoms
595 call atom_get_species(this%atom(jatom), species)
596 select type(species)
597 class is(jellium_t)
598 if (real_atoms_only_) cycle
599 end select
600 xx = abs(this%pos(:, iatom) - this%pos(:, jatom))
601 if (this%space%is_periodic()) then
602 xx = this%latt%cart_to_red(xx)
603 do idir = 1, this%space%periodic_dim
604 xx(idir) = xx(idir) - floor(xx(idir) + m_half)
605 end do
606 xx = this%latt%red_to_cart(xx)
607 end if
608 rmin = min(norm2(xx), rmin)
609 end do
610 end do
611
612 if (.not. (this%only_user_def .and. real_atoms_only_)) then
613 ! what if the nearest neighbors are periodic images?
614 do idir = 1, this%space%periodic_dim
615 rmin = min(rmin, norm2(this%latt%rlattice(:,idir)))
616 end do
617 end if
618
619 ! To avoid numerical instabilities, we round this to 6 digits only
620 if(rmin < huge(rmin)/1e6_real64) then
621 rmin = anint(rmin*1e6_real64)*1.0e-6_real64
622 end if
623
624 pop_sub(ions_min_distance)
625 end function ions_min_distance
626
627 ! ---------------------------------------------------------
628 logical function ions_has_time_dependent_species(this) result(time_dependent)
629 class(ions_t), intent(in) :: this
630
632
633 time_dependent = this%species_time_dependent
634
637
638 ! ---------------------------------------------------------
639 real(real64) function ions_val_charge(this, mask) result(val_charge)
640 class(ions_t), intent(in) :: this
641 logical, optional, intent(in) :: mask(:)
642
643 push_sub(ions_val_charge)
644
645 if (present(mask)) then
646 val_charge = -sum(this%charge, mask=mask)
647 else
648 val_charge = -sum(this%charge)
649 end if
650
651 pop_sub(ions_val_charge)
652 end function ions_val_charge
653
654 ! ---------------------------------------------------------
655 function ions_dipole(this, mask) result(dipole)
656 class(ions_t), intent(in) :: this
657 logical, optional, intent(in) :: mask(:)
658 real(real64) :: dipole(this%space%dim)
659
660 integer :: ia
661
662 push_sub(ions_dipole)
663
664 dipole = m_zero
665 do ia = 1, this%natoms
666 if (present(mask)) then
667 if (.not. mask(ia)) cycle
668 end if
669 dipole = dipole + this%charge(ia)*this%pos(:, ia)
670 end do
671 dipole = p_proton_charge*dipole
672
673 pop_sub(ions_dipole)
674 end function ions_dipole
675
676 ! ---------------------------------------------------------
677 subroutine ions_translate(this, xx)
678 class(ions_t), intent(inout) :: this
679 real(real64), intent(in) :: xx(this%space%dim)
680
681 integer :: iatom
682
683 push_sub(ions_translate)
684
685 do iatom = 1, this%natoms
686 this%pos(:, iatom) = this%pos(:, iatom) - xx
687 end do
688
689 pop_sub(ions_translate)
690 end subroutine ions_translate
691
692 ! ---------------------------------------------------------
693 subroutine ions_rotate(this, from, from2, to)
694 class(ions_t), intent(inout) :: this
695 real(real64), intent(in) :: from(this%space%dim)
696 real(real64), intent(in) :: from2(this%space%dim)
697 real(real64), intent(in) :: to(this%space%dim)
698
699 integer :: iatom
700 real(real64) :: m1(3, 3), m2(3, 3)
701 real(real64) :: m3(3, 3), f2(3), per(3)
702 real(real64) :: alpha, r
703
704 push_sub(ions_rotate)
705
706 if (this%space%dim /= 3) then
707 call messages_not_implemented("ions_rotate in other than 3 dimensions", namespace=this%namespace)
708 end if
709
710 ! initialize matrices
711 m1 = diagonal_matrix(3, m_one)
712
713 ! rotate the to-axis to the z-axis
714 if (abs(to(2)) > 1d-150) then
715 alpha = atan2(to(2), to(1))
716 call rotate(m1, alpha, 3)
717 end if
718 alpha = atan2(norm2(to(1:2)), to(3))
719 call rotate(m1, -alpha, 2)
720
721 ! get perpendicular to z and from
722 f2 = matmul(m1, from)
723 per(1) = -f2(2)
724 per(2) = f2(1)
725 per(3) = m_zero
726 r = norm2(per)
727 if (r > m_zero) then
728 per = per/r
729 else
730 per(2) = m_one
731 end if
733 ! rotate perpendicular axis to the y-axis
734 m2 = diagonal_matrix(3, m_one)
735 alpha = atan2(per(1), per(2))
736 call rotate(m2, -alpha, 3)
737
738 ! rotate from => to (around the y-axis)
739 m3 = diagonal_matrix(3, m_one)
740 alpha = acos(min(sum(from*to), m_one))
741 call rotate(m3, -alpha, 2)
742
743 ! join matrices
744 m2 = matmul(transpose(m2), matmul(m3, m2))
745
746 ! rotate around the z-axis to get the second axis
747 per = matmul(m2, matmul(m1, from2))
748 alpha = atan2(per(1), per(2))
749 call rotate(m2, -alpha, 3) ! second axis is now y
750
751 ! get combined transformation
752 m1 = matmul(transpose(m1), matmul(m2, m1))
753
754 ! now transform the coordinates
755 ! it is written in this way to avoid what I consider a bug in the Intel compiler
756 do iatom = 1, this%natoms
757 f2 = this%pos(:, iatom)
758 this%pos(:, iatom) = matmul(m1, f2)
759 end do
760
761 pop_sub(ions_rotate)
762 contains
763
764 ! ---------------------------------------------------------
765 subroutine rotate(m, angle, dir)
766 real(real64), intent(inout) :: m(3, 3)
767 real(real64), intent(in) :: angle
768 integer, intent(in) :: dir
769
770 real(real64) :: aux(3, 3), ca, sa
771
772 push_sub(ions_rotate.rotate)
773
774 ca = cos(angle)
775 sa = sin(angle)
776
777 aux = m_zero
778 select case (dir)
779 case (1)
780 aux(1, 1) = m_one
781 aux(2, 2) = ca
782 aux(3, 3) = ca
783 aux(2, 3) = sa
784 aux(3, 2) = -sa
785 case (2)
786 aux(2, 2) = m_one
787 aux(1, 1) = ca
788 aux(3, 3) = ca
789 aux(1, 3) = sa
790 aux(3, 1) = -sa
791 case (3)
792 aux(3, 3) = m_one
793 aux(1, 1) = ca
794 aux(2, 2) = ca
795 aux(1, 2) = sa
796 aux(2, 1) = -sa
797 end select
798
799 m = matmul(aux, m)
800
801 pop_sub(ions_rotate.rotate)
802 end subroutine rotate
803
804 end subroutine ions_rotate
805
806 ! ---------------------------------------------------------
807 function ions_global_force(this, time) result(force)
808 class(ions_t), intent(in) :: this
809 real(real64), intent(in) :: time
810 real(real64) :: force(this%space%dim)
811
812 push_sub(ions_global_force)
813
814 force = m_zero
815
816 if (this%apply_global_force) then
817 force(1) = units_to_atomic(units_inp%force, tdf(this%global_force_function, time))
818 end if
819
820 pop_sub(ions_global_force)
821 end function ions_global_force
822
823 ! ---------------------------------------------------------
824 subroutine ions_write_xyz(this, fname, append, comment, reduce_coordinates)
825 class(ions_t), intent(in) :: this
826 character(len=*), intent(in) :: fname
827 logical, optional, intent(in) :: append
828 character(len=*), optional, intent(in) :: comment
829 logical, optional, intent(in) :: reduce_coordinates
830
831 integer :: iatom, idim, iunit
832 character(len=6) position
833 character(len=19) :: frmt
834 real(real64) :: red(this%space%dim)
835
836 if (.not. mpi_grp_is_root(mpi_world)) return
837
838 push_sub(ions_write_xyz)
839
840 position = 'asis'
841 if (present(append)) then
842 if (append) position = 'append'
843 end if
844 if(.not.optional_default(reduce_coordinates, .false.)) then
845 iunit = io_open(trim(fname)//'.xyz', this%namespace, action='write', position=position)
846 else
847 iunit = io_open(trim(fname)//'.xyz_red', this%namespace, action='write', position=position)
848 end if
849
850 write(iunit, '(i4)') this%natoms
851 if (present(comment)) then
852 write(iunit, '(1x,a)') comment
853 else
854 write(iunit, '(1x,a,a)') 'units: ', trim(units_abbrev(units_out%length_xyz_file))
855 end if
856
857 write(unit=frmt, fmt="(a5,i2.2,a4,i2.2,a6)") "(6x,a", label_len, ",2x,", this%space%dim,"f12.6)"
858 do iatom = 1, this%natoms
859 if(.not.optional_default(reduce_coordinates, .false.)) then
860 write(unit=iunit, fmt=frmt) this%atom(iatom)%label, &
861 (units_from_atomic(units_out%length_xyz_file, this%pos(idim, iatom)), idim=1, this%space%dim)
862 else
863 red = this%latt%cart_to_red(this%pos(:, iatom))
864 write(unit=iunit, fmt=frmt) this%atom(iatom)%label, (red(idim), idim=1, this%space%dim)
865 end if
866 end do
867 call io_close(iunit)
868
869 pop_sub(ions_write_xyz)
870 end subroutine ions_write_xyz
871
872 ! ---------------------------------------------------------
873 subroutine ions_read_xyz(this, fname, comment)
874 class(ions_t), intent(inout) :: this
875 character(len=*), intent(in) :: fname
876 character(len=*), optional, intent(in) :: comment
877
878 integer :: iatom, idir, iunit
879 character(len=19) :: frmt, dum
880 real(real64) :: tmp(this%space%dim)
881
882 push_sub(ions_read_xyz)
883
884 iunit = io_open(trim(fname)//'.xyz', this%namespace, action='read', position='rewind')
885
886 read(iunit, '(i4)') this%natoms
887 if (present(comment)) then
888 read(iunit, *)
889 else
890 read(iunit, *)
891 end if
892 write(unit=frmt, fmt="(a5,i2.2,a4,i2.2,a6)") "(6x,a", label_len, ",2x,", this%space%dim, "f12.6)"
893 do iatom = 1, this%natoms
894 read(unit=iunit, fmt=frmt) dum, (tmp(idir), idir=1, this%space%dim)
895
896 this%pos(:, iatom) = units_to_atomic(units_out%length_xyz_file, tmp)
897 end do
898 call io_close(iunit)
899
901 end subroutine ions_read_xyz
902
903 ! ----------------------------------------------------------------
906 subroutine ions_write_crystal(this, dir)
907 class(ions_t), intent(in) :: this
908 character(len=*), intent(in) :: dir
909
910 type(lattice_iterator_t) :: latt_iter
911 real(real64) :: radius, pos(this%space%dim)
912 integer :: iatom, icopy, iunit
913
914 push_sub(ions_write_crystal)
915
916 radius = maxval(m_half*norm2(this%latt%rlattice(:,1:this%space%periodic_dim), dim=1))*(m_one + m_epsilon)
917 latt_iter = lattice_iterator_t(this%latt, radius)
918
919 if (mpi_grp_is_root(mpi_world)) then
920
921 iunit = io_open(trim(dir)//'/crystal.xyz', this%namespace, action='write')
922
923 write(iunit, '(i9)') this%natoms*latt_iter%n_cells
924 write(iunit, '(a)') '#generated by Octopus'
925
926 do iatom = 1, this%natoms
927 do icopy = 1, latt_iter%n_cells
928 pos = units_from_atomic(units_out%length, this%pos(:, iatom) + latt_iter%get(icopy))
929 write(iunit, '(a, 99f12.6)') this%atom(iatom)%label, pos
930 end do
931 end do
932
933 call io_close(iunit)
934 end if
935
936 pop_sub(ions_write_crystal)
937 end subroutine ions_write_crystal
938
939 ! ---------------------------------------------------------
940 subroutine ions_write_bild_forces_file(this, dir, fname)
941 class(ions_t), intent(in) :: this
942 character(len=*), intent(in) :: dir, fname
943
944 integer :: iunit, iatom, idir
945 real(real64) :: force(this%space%dim), center(this%space%dim)
946 character(len=20) frmt
947
948 if (.not. mpi_grp_is_root(mpi_world)) return
949
951
952 call io_mkdir(dir, this%namespace)
953 iunit = io_open(trim(dir)//'/'//trim(fname)//'.bild', this%namespace, action='write', &
954 position='asis')
955
956 write(frmt,'(a,i0,a)')'(a,2(', this%space%dim,'f16.6,1x))'
957
958 write(iunit, '(a)')'.comment : force vectors in ['//trim(units_abbrev(units_out%force))//']'
959 write(iunit, *)
960 write(iunit, '(a)')'.color red'
961 write(iunit, *)
962 do iatom = 1, this%natoms
963 center = units_from_atomic(units_out%length, this%pos(:, iatom))
964 force = units_from_atomic(units_out%force, this%tot_force(:, iatom))
965 write(iunit, '(a,1x,i4,1x,a2,1x,a6,1x,f10.6,a)') '.comment :', iatom, trim(this%atom(iatom)%label), &
966 'force:', norm2(force), '['//trim(units_abbrev(units_out%force))//']'
967 write(iunit,fmt=trim(frmt)) '.arrow', (center(idir), idir = 1, this%space%dim), &
968 (center(idir) + force(idir), idir = 1, this%space%dim)
969 write(iunit,*)
970 end do
971
972 call io_close(iunit)
973
975 end subroutine ions_write_bild_forces_file
976
977 ! -----------------------------------------------------
978 subroutine ions_write_vtk_geometry(this, filename, ascii)
979 class(ions_t), intent(in) :: this
980 character(len=*), intent(in) :: filename
981 logical, optional, intent(in) :: ascii
982
983 integer :: iunit, iatom, ierr
984 logical :: ascii_
985 real(real64), allocatable :: data(:, :)
986 integer, allocatable :: idata(:, :)
987 character(len=MAX_PATH_LEN) :: fullname
988
990
991 assert(this%space%dim == 3)
992
993 ascii_ = optional_default(ascii, .true.)
994
995 fullname = trim(filename)//".vtk"
996
997 iunit = io_open(trim(fullname), this%namespace, action='write')
998
999 write(iunit, '(1a)') '# vtk DataFile Version 3.0 '
1000 write(iunit, '(6a)') 'Generated by octopus ', trim(conf%version), ' - git: ', &
1001 trim(conf%git_commit), " configuration: ", trim(conf%config_time)
1002
1003 if (ascii_) then
1004 write(iunit, '(1a)') 'ASCII'
1005 else
1006 write(iunit, '(1a)') 'BINARY'
1007 end if
1008
1009 write(iunit, '(1a)') 'DATASET POLYDATA'
1010
1011 write(iunit, '(a,i9,a)') 'POINTS ', this%natoms, ' double'
1012
1013 if (ascii_) then
1014 do iatom = 1, this%natoms
1015 write(iunit, '(3f12.6)') this%pos(1:3, iatom)
1016 end do
1017 else
1018 call io_close(iunit)
1019 safe_allocate(data(1:3, 1:this%natoms))
1020 do iatom = 1, this%natoms
1021 data(1:3, iatom) = this%pos(1:3, iatom)
1022 end do
1023 call io_binary_write(io_workpath(fullname, this%namespace), i4_to_i8(3*this%natoms), data, &
1024 ierr, nohead = .true., fendian = io_binary_is_little_endian())
1025 safe_deallocate_a(data)
1026 iunit = io_open(trim(fullname), this%namespace, action='write', position = 'append')
1027 write(iunit, '(1a)') ''
1028 end if
1029
1030 write(iunit, '(a,2i9)') 'VERTICES ', this%natoms, 2*this%natoms
1031
1032 if (ascii_) then
1033 do iatom = 1, this%natoms
1034 write(iunit, '(2i9)') 1, iatom - 1
1035 end do
1036 else
1037 call io_close(iunit)
1038 safe_allocate(idata(1:2, 1:this%natoms))
1039 do iatom = 1, this%natoms
1040 idata(1, iatom) = 1
1041 idata(2, iatom) = iatom - 1
1042 end do
1043 call io_binary_write(io_workpath(fullname, this%namespace), i4_to_i8(2*this%natoms), idata, &
1044 ierr, nohead = .true., fendian = io_binary_is_little_endian())
1045 safe_deallocate_a(idata)
1046 iunit = io_open(trim(fullname), this%namespace, action='write', position = 'append')
1047 write(iunit, '(1a)') ''
1048 end if
1049
1050 write(iunit, '(a,i9)') 'POINT_DATA', this%natoms
1051 write(iunit, '(a)') 'SCALARS element integer'
1052 write(iunit, '(a)') 'LOOKUP_TABLE default'
1053
1054 if (ascii_) then
1055 do iatom = 1, this%natoms
1056 write(iunit, '(i9)') nint(this%atom(iatom)%species%get_z())
1057 end do
1058 else
1059 call io_close(iunit)
1060
1061 safe_allocate(idata(1:this%natoms, 1))
1062
1063 do iatom = 1, this%natoms
1064 idata(iatom, 1) = nint(this%atom(iatom)%species%get_z())
1065 end do
1066
1067 call io_binary_write(io_workpath(fullname, this%namespace), i4_to_i8(this%natoms), idata, &
1068 ierr, nohead = .true., fendian = io_binary_is_little_endian())
1069
1070 safe_deallocate_a(idata)
1072 iunit = io_open(trim(fullname), this%namespace, action='write', position = 'append')
1073 write(iunit, '(1a)') ''
1074 end if
1075
1076 call io_close(iunit)
1077
1079 end subroutine ions_write_vtk_geometry
1080
1081 ! ---------------------------------------------------------
1082 subroutine ions_finalize(ions)
1083 type(ions_t), intent(inout) :: ions
1084
1085 integer :: i
1086
1087 push_sub(ions_finalize)
1088
1089 call distributed_end(ions%atoms_dist)
1090
1091 call ion_interaction_end(ions%ion_interaction)
1092
1093 safe_deallocate_a(ions%atom)
1094 ions%natoms=0
1095
1096 if(allocated(ions%species)) then
1097 do i = 1, ions%nspecies
1098 !SAFE_ DEALLOCATE_P(ions%species(i)%s)
1099 if(associated(ions%species(i)%s)) deallocate(ions%species(i)%s)
1100 end do
1101 deallocate(ions%species)
1102 end if
1103 ions%nspecies=0
1104
1105 call charged_particles_end(ions)
1106
1107 safe_deallocate_a(ions%map_symm_atoms)
1108 safe_deallocate_a(ions%inv_map_symm_atoms)
1109
1110
1111 pop_sub(ions_finalize)
1112 end subroutine ions_finalize
1113
1114 !-------------------------------------------------------------------
1117 subroutine ions_update_lattice_vectors(ions, latt, symmetrize)
1118 class(ions_t), intent(inout) :: ions
1119 type(lattice_vectors_t), intent(in) :: latt
1120 logical, intent(in) :: symmetrize
1121
1123
1124 ! Update the lattice vectors
1125 call ions%latt%update(latt%rlattice)
1126
1127 ! Regenerate symmetries in Cartesian space
1128 if (symmetrize) then
1129 call symmetries_update_lattice_vectors(ions%symm, latt, ions%space%dim)
1130 end if
1131
1133 end subroutine ions_update_lattice_vectors
1134
1135 !-------------------------------------------------------------------
1142 class(ions_t), intent(inout) :: ions
1143
1144 integer :: iatom, iop, iatom_symm, dim4symms
1145 real(real64) :: ratom(ions%space%dim)
1146
1148
1149 safe_allocate(ions%map_symm_atoms(1:ions%natoms, 1:ions%symm%nops + ions%symm%nops_nonsymmorphic))
1150 safe_allocate(ions%inv_map_symm_atoms(1:ions%natoms, 1:ions%symm%nops + ions%symm%nops_nonsymmorphic))
1151
1152 ! In the 4D case, symmetries are only defined in 3D, see symmetries.F90
1153 dim4symms = min(3, ions%space%dim)
1154 ratom = m_zero
1155
1156 do iop = 1, ions%symm%nops
1157 do iatom = 1, ions%natoms
1158 !We find the atom that correspond to this one, once symmetry is applied
1159 ratom(1:dim4symms) = symm_op_apply_inv_cart(ions%symm%ops(iop), ions%pos(:, iatom))
1160
1161 ratom(:) = ions%latt%fold_into_cell(ratom(:))
1162
1163 ! find iatom_symm
1164 do iatom_symm = 1, ions%natoms
1165 if (all(abs(ratom(:) - ions%pos(:, iatom_symm)) < symprec)) exit
1166 end do
1167
1168 if (iatom_symm > ions%natoms) then
1169 write(message(1),'(a,i6)') 'Internal error: could not find symmetric partner for atom number', iatom
1170 write(message(2),'(a,i3,a)') 'with symmetry operation number ', iop, '.'
1171 call messages_fatal(2, namespace=ions%namespace)
1172 end if
1173
1174 ions%map_symm_atoms(iatom, iop) = iatom_symm
1175 ions%inv_map_symm_atoms(iatom_symm, iop) = iatom
1176 end do
1177 end do
1178
1179 ! Also build a map for non-symmorphic operations
1180 do iop = 1, ions%symm%nops_nonsymmorphic
1181 do iatom = 1, ions%natoms
1182 !We find the atom that correspond to this one, once symmetry is applied
1183 ratom(1:dim4symms) = symm_op_apply_inv_cart(ions%symm%non_symmorphic_ops(iop), ions%pos(:, iatom))
1184
1185 ratom(:) = ions%latt%fold_into_cell(ratom(:))
1186
1187 ! find iatom_symm
1188 do iatom_symm = 1, ions%natoms
1189 if (all(abs(ratom(:) - ions%pos(:, iatom_symm)) < symprec)) exit
1190 end do
1191
1192 if (iatom_symm > ions%natoms) then
1193 write(message(1),'(a,i6)') 'Internal error: could not find symmetric partner for atom number', iatom
1194 write(message(2),'(a,i3,a)') 'with symmetry operation number ', iop, '.'
1195 call messages_fatal(2, namespace=ions%namespace)
1196 end if
1197
1198 ions%map_symm_atoms(iatom, ions%symm%nops+iop) = iatom_symm
1199 ions%inv_map_symm_atoms(iatom_symm, ions%symm%nops+iop) = iatom
1200 end do
1201 end do
1202
1203
1206
1207 !-------------------------------------------------------------------
1211 subroutine ions_symmetrize_atomic_coord(ions)
1212 class(ions_t), intent(inout) :: ions
1213
1214 integer :: iatom, iop, iatom_sym
1215 real(real64) :: ratom(ions%space%dim)
1216 real(real64), allocatable :: new_pos(:,:)
1217
1219
1220 safe_allocate(new_pos(1:ions%space%dim, 1:ions%natoms))
1221
1222 do iatom = 1, ions%natoms
1223 new_pos(:, iatom) = m_zero
1224
1225 ! Symmorphic operations
1226 do iop = 1, ions%symm%nops
1227 iatom_sym = ions%inv_map_symm_atoms(iatom, iop)
1228 ratom = symm_op_apply_inv_cart(ions%symm%ops(iop), ions%pos(:, iatom_sym))
1229 ratom = ions%latt%fold_into_cell(ratom)
1230 new_pos(:, iatom) = new_pos(:, iatom) + ratom
1231 end do
1232
1233 ! Non-symmorphic operations
1234 do iop = 1, ions%symm%nops_nonsymmorphic
1235 iatom_sym = ions%inv_map_symm_atoms(iatom, iop + ions%symm%nops)
1236 ratom = symm_op_apply_inv_cart(ions%symm%non_symmorphic_ops(iop), ions%pos(:, iatom_sym))
1237 ratom = ions%latt%fold_into_cell(ratom)
1238 new_pos(:, iatom) = new_pos(:, iatom) + ratom
1239 end do
1240
1241 new_pos(:, iatom) = new_pos(:, iatom) / (ions%symm%nops + ions%symm%nops_nonsymmorphic)
1242 end do
1243
1244
1246 end subroutine ions_symmetrize_atomic_coord
1247
1249 subroutine ions_print_spacegroup(ions)
1250 class(ions_t), intent(inout) :: ions
1251
1252 type(spglibdataset) :: spg_dataset
1253 character(len=11) :: symbol = ""
1254 integer, allocatable :: site_type(:)
1255 integer :: space_group, ia
1256
1257 if(.not. ions%space%is_periodic()) return
1258
1259 push_sub(ions_print_spacegroup)
1260
1261 safe_allocate(site_type(1:ions%natoms))
1262 do ia = 1, ions%natoms
1263 site_type(ia) = ions%atom(ia)%species%get_index()
1264 end do
1265
1266 spg_dataset = symmetries_get_spg_dataset(ions%namespace, ions%space, ions%latt, ions%natoms, ions%pos, site_type)
1267
1268 safe_deallocate_a(site_type)
1269
1270 if (spg_dataset%spglib_error /= 0) then
1271 pop_sub(ions_print_spacegroup)
1272 return
1273 end if
1274
1275 space_group = spg_dataset%spacegroup_number
1276 symbol = spg_dataset%international_symbol
1277
1278 write(message(1),'(a, i4)') 'Info: Space group No. ', space_group
1279 write(message(2),'(2a)') 'Info: International: ', trim(symbol)
1280 call messages_info(2, namespace=ions%namespace)
1281
1282 pop_sub(ions_print_spacegroup)
1283 end subroutine ions_print_spacegroup
1284
1285end module ions_oct_m
1286
1287!! Local Variables:
1288!! mode: f90
1289!! coding: utf-8
1290!! 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:859
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, label)
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:206
character(len= *), parameter, public static_dir
Definition: global.F90:252
real(real64), parameter, public m_half
Definition: global.F90:194
real(real64), parameter, public m_one
Definition: global.F90:189
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:311
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:1211
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:648
real(real64) function, dimension(this%space%dim) ions_global_force(this, time)
Definition: ions.F90:901
subroutine ions_copy(ions_out, ions_in)
Definition: ions.F90:531
subroutine ions_update_quantity(this, label)
Definition: ions.F90:601
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:1235
subroutine ions_write_xyz(this, fname, append, comment, reduce_coordinates)
Definition: ions.F90:918
subroutine ions_init_species(ions, factory, print_info)
Definition: ions.F90:419
subroutine ions_finalize(ions)
Definition: ions.F90:1176
subroutine ions_initialize(this)
Definition: ions.F90:592
subroutine ions_read_xyz(this, fname, comment)
Definition: ions.F90:967
subroutine ions_write_vtk_geometry(this, filename, ascii)
Definition: ions.F90:1072
subroutine ions_rotate(this, from, from2, to)
Definition: ions.F90:787
subroutine ions_translate(this, xx)
Definition: ions.F90:771
subroutine ions_symmetrize_atomic_coord(ions)
Symmetrizes atomic coordinates by applying all symmetries.
Definition: ions.F90:1305
subroutine ions_print_spacegroup(ions)
Prints the spacegroup of the system for periodic systems.
Definition: ions.F90:1343
real(real64) function ions_min_distance(this, real_atoms_only)
Definition: ions.F90:663
real(real64) function, dimension(this%space%dim) ions_dipole(this, mask)
Definition: ions.F90:749
subroutine ions_write_bild_forces_file(this, dir, fname)
Definition: ions.F90:1034
subroutine ions_write_crystal(this, dir)
This subroutine creates a crystal by replicating the geometry and writes the result to dir.
Definition: ions.F90:1000
logical function ions_has_time_dependent_species(this)
Definition: ions.F90:722
subroutine ions_partition(this, mc)
Definition: ions.F90:563
subroutine ions_init_interaction_as_partner(partner, interaction)
Definition: ions.F90:617
subroutine ions_copy_quantities_to_interaction(partner, interaction)
Definition: ions.F90:632
real(real64) function ions_val_charge(this, mask)
Definition: ions.F90:733
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:920
character(len=512), private msg
Definition: messages.F90:165
subroutine, public messages_warning(no_lines, all_nodes, namespace)
Definition: messages.F90:537
subroutine, public messages_obsolete_variable(namespace, name, rep)
Definition: messages.F90:1045
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:414
subroutine, public messages_input_error(namespace, var, details, row, column)
Definition: messages.F90:713
subroutine, public messages_experimental(name, namespace)
Definition: messages.F90:1085
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)