Octopus
unfold.F90
Go to the documentation of this file.
1!! Copyright (C) 2018-2019 M. S. Mrudul, N. Tancogne-Dejean
2!!
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
21#include "global.h"
22
23
24program oct_unfold
25 use batch_oct_m
28 use comm_oct_m
30 use cube_oct_m
32 use debug_oct_m
34 use fft_oct_m
38 use global_oct_m
39 use grid_oct_m
40 use io_oct_m
43 use, intrinsic :: iso_fortran_env
47 use loct_oct_m
48 use math_oct_m
49 use mesh_oct_m
52 use mpi_oct_m
56 use parser_oct_m
60 use space_oct_m
64 use unit_oct_m
66 use utils_oct_m
68 use v_ks_oct_m
69 use xc_oct_m
70
71 implicit none
72
73 type(electrons_t), pointer :: sys
74 integer :: ik, nkpoints
75 type(restart_t) :: restart
76 type(cube_t) :: zcube
77 type(cube_function_t) :: cf
78
79 type(lattice_vectors_t) :: pc
80 integer :: ierr, run_mode, file_gvec
81 type(block_t) :: blk
82 integer :: nhighsympoints, nsegments
83 integer :: icol, idir, ncols
84
85 integer, allocatable :: resolution(:)
86 real(real64), allocatable :: highsympoints(:,:), coord_along_path(:)
87 type(kpoints_grid_t) :: path_kpoints_grid
88
89
90 ! the usual initializations
91 call global_init()
92 call parser_init()
93
94 call messages_init()
95
96 call io_init()
98
99 call print_header()
100 call messages_print_with_emphasis(msg="Unfolding Band-structure", namespace=global_namespace)
102
103 call messages_experimental("oct-unfold utility")
106
107 call calc_mode_par%set_parallelization(p_strategy_states, default = .false.)
109 call sys%init_parallelization(mpi_world)
110
111 if (sys%space%periodic_dim == 0) then
112 message(1) = "oct-unfold can only be used for periodic systems."
113 call messages_fatal(1)
114 end if
115
116 if (sys%st%parallel_in_states) then
117 call messages_not_implemented("oct-unfold with states parallelization")
118 end if
120 if (sys%st%d%ispin == spinors) then
121 call messages_not_implemented("oct-unfold for spinors")
122 end if
123
124
125 !%Variable UnfoldMode
126 !%Type flag
127 !%Default none
128 !%Section Utilities::oct-unfold
129 !%Description
130 !% Specifies which stage of the unfolding tool to use
131 !%Option unfold_setup bit(1)
132 !% Writes the list of k-points corresponding to the path specified by <tt>UnfoldKPointPath</tt>.
133 !% This list of k-point (unfold_kpt.dat) must be used for an unocc calculation of the supercell,
134 !% adding the line "include 'unfold_kpt.dat'" to the inp file and removing the KPointGrid information.
135 !%Option unfold_run bit(2)
136 !% Perform the actual unfolding, based on the states obtained from the previous unocc run.
137 !%End
138 call parse_variable(global_namespace, 'UnfoldMode', 0, run_mode)
139 if (.not. varinfo_valid_option('UnfoldMode', run_mode)) then
140 call messages_input_error(global_namespace, "UnfoldMode must be set to a value different from 0.")
141 end if
142
143 !%Variable UnfoldLatticeParameters
144 !%Type block
145 !%Section Utilities::oct-unfold
146 !%Description
147 !% The lattice parameters of the primitive cell, on which unfolding is performed.
148 !% See the LatticeParameters variable for a more detailed description.
149 !%End
150
151 !%Variable UnfoldLatticeVectors
152 !%Type block
153 !%Default simple cubic
154 !%Section Utilities::oct-unfold
155 !%Description
156 !% Lattice vectors of the primitive cell on which the unfolding is performed.
157 !% See the LatticeVectors variable for a more detailed description.
158 !%End
159 pc = lattice_vectors_t(global_namespace, sys%space, variable_prefix='Unfold')
160
161 !%Variable UnfoldKPointsPath
162 !%Type block
163 !%Section Utilities::oct-unfold
164 !%Description
165 !% Specifies the k-point path for which the unfolding need to be done.
166 !% The syntax is identical to <tt>KPointsPath</tt>.
167 !%End
168 if (parse_block(global_namespace, 'UnfoldKPointsPath', blk) /= 0) then
169 write(message(1),'(a)') 'Error while reading UnfoldPointsPath.'
170 call messages_fatal(1)
171 end if
172
173 ! There is one high symmetry k-point per line
174 nsegments = parse_block_cols(blk, 0)
175 nhighsympoints = parse_block_n(blk) - 1
176 if (nhighsympoints /= nsegments+1) then
177 write(message(1),'(a,i3,a,i3)') 'The first row of UnfoldPointsPath is not compatible with the number of specified k-points.'
178 call messages_fatal(1)
179 end if
180
181 safe_allocate(resolution(1:nsegments))
182 do icol = 1, nsegments
183 call parse_block_integer(blk, 0, icol-1, resolution(icol))
184 end do
185 !Total number of points in the segment
186 nkpoints = sum(resolution) + 1
187
188 safe_allocate(highsympoints(1:sys%space%dim, 1:nhighsympoints))
189 do ik = 1, nhighsympoints
190 !Sanity check
191 ncols = parse_block_cols(blk, ik)
192 if (ncols /= sys%space%dim) then
193 write(message(1),'(a,i8,a,i3)') 'UnfoldPointsPath row ', ik, ' has ', ncols, ' columns but must have ', sys%space%dim
194 call messages_fatal(1)
195 end if
196
197 do idir = 1, sys%space%dim
198 call parse_block_float(blk, ik, idir-1, highsympoints(idir, ik))
199 end do
200 end do
201
202 call parse_block_end(blk)
203
204 call kpoints_grid_init(sys%space%dim, path_kpoints_grid, nkpoints, 1)
205 ! For the output of band-structures
206 safe_allocate(coord_along_path(1:nkpoints))
207
208 call kpoints_path_generate(sys%space%dim, pc, nkpoints, nsegments, resolution, &
209 highsympoints, path_kpoints_grid%point, coord_along_path)
210
211 safe_deallocate_a(resolution)
212 safe_deallocate_a(highsympoints)
213
214 !We convert the k-point to the reduced coordinate of the supercell
215 do ik = 1, path_kpoints_grid%npoints
216 call kpoints_to_reduced(sys%kpoints%latt, path_kpoints_grid%point(:, ik), path_kpoints_grid%red_point(:, ik))
217 end do
218
219 call kpoints_fold_to_1bz(path_kpoints_grid, pc)
220
221 if (run_mode == option__unfoldmode__unfold_setup) then
222
223 call unfold_setup()
224
225 else if (run_mode == option__unfoldmode__unfold_run) then
226
227 !Sanity check
228 file_gvec = io_open('unfold_gvec.dat', global_namespace, action='read')
229 read(file_gvec, *)
230 read(file_gvec, *) ik
231 if (ik /= path_kpoints_grid%npoints) then
232 message(1) = 'There is an inconsistency between unfold_gvec.dat and the input file'
233 call messages_fatal(1)
234 end if
235 call io_close(file_gvec)
236
237 call states_elec_allocate_wfns(sys%st, sys%gr)
238
239 call restart%init(global_namespace, restart_unocc, restart_type_load, sys%mc, ierr, mesh=sys%gr, exact=.true.)
240 if (ierr == 0) then
241 call states_elec_load(restart, global_namespace, sys%space, sys%st, sys%gr, sys%kpoints, ierr, label = ": unfold")
242 end if
243 if (ierr /= 0) then
244 message(1) = 'Unable to read unocc wavefunctions.'
245 call messages_fatal(1)
246 end if
247 call restart%end()
248
249 call cube_init(zcube, sys%gr%idx%ll, global_namespace, sys%space, sys%gr%spacing, &
250 sys%gr%coord_system, fft_type = fft_complex, dont_optimize = .true.)
251 call cube_init_cube_map(zcube, sys%gr)
252
253 call zcube_function_alloc_rs(zcube, cf)
254 call cube_function_alloc_fs(zcube, cf)
255
256 call wfs_extract_spec_fn(sys%space, sys%st, sys%gr, zcube, cf)
257
258 call cube_function_free_fs(zcube, cf)
259 call zcube_function_free_rs(zcube, cf)
260 call cube_end(zcube)
261
262 else
263 message(1) = "Unsupported or incorrect value of UnfoldMode."
264 call messages_fatal(1)
265 end if
266
267 safe_deallocate_a(coord_along_path)
268
269 call kpoints_grid_end(path_kpoints_grid)
270
271 safe_deallocate_p(sys)
272 call fft_all_end()
274 call io_end()
275 call print_date("Calculation ended on ")
276 call messages_end()
277 call parser_end()
278 call global_end()
279
280
281
282contains
283 !-----------------------------------------------------------------
284 subroutine unfold_setup()
285 integer :: file_gvec, file_kpts, idir
286 integer :: gvec(sys%space%dim)
287
288 push_sub(unfold_setup)
289
290 if (mpi_world%is_root()) then
291 file_gvec = io_open('unfold_gvec.dat', global_namespace, action='write')
292 file_kpts = io_open('unfold_kpt.dat', global_namespace, action='write')
293 write(file_kpts,'(a)') '%KpointsReduced'
294 write(file_gvec,'(a)') '#Created by oct-unfold'
295 write(file_gvec,'(i5)') path_kpoints_grid%npoints
296
297 !We convert the k-point to the reduce coordinate of the supercell
298 do ik = 1, path_kpoints_grid%npoints
299 gvec(:) = nint(path_kpoints_grid%red_point(:, ik) + m_half * 1e-7_real64)
300 write(file_kpts,'(a3)', advance='no') ' 1.'
301 write(file_kpts,'(*(a3,f12.8))') &
302 (' | ', path_kpoints_grid%red_point(idir, ik) - gvec(idir), idir = 1, sys%space%dim)
303 write(file_gvec,'(*(i3))') (gvec(idir), idir = 1, sys%space%dim)
304 end do
305 write(file_kpts,'(a)') '%'
306 call io_close(file_gvec)
307 call io_close(file_kpts)
308 end if
309
310 pop_sub(unfold_setup)
311 end subroutine unfold_setup
312
313 !--------------------------------------------------------------------
314 subroutine wfs_extract_spec_fn(space, st, gr, zcube, cf)
315 class(space_t), intent(in) :: space
316 type(states_elec_t), intent(in) :: st
317 type(grid_t), intent(in) :: gr
318 type(cube_t), intent(inout) :: zcube
319 type(cube_function_t), intent(inout) :: cf
320
321 real(real64), allocatable :: pkm(:,:), ake(:,:), eigs(:)
322 complex(real64), allocatable :: zpsi(:), field_g(:)
323 integer :: file_ake, iq, ist, idim, nenergy
324 integer :: ig, ix, iy, iz, ik, ie, gmin, gmax
325 real(real64) :: eigmin, eigmax, de, norm
326 real(real64), parameter :: tol = 1e-7_real64
327 integer, parameter :: nextend = 10
328 real(real64) :: vec_pc(space%dim), vec_sc(space%dim)
329 type(fourier_shell_t) :: shell
330 character(len=MAX_PATH_LEN) :: filename
331 real(real64), allocatable :: gvec_abs(:,:)
332 logical, allocatable :: g_select(:)
333
334 push_sub(wfs_extract_spec_fn)
335
336 safe_allocate(zpsi(1:gr%np))
337
338 !%Variable UnfoldEnergyStep
339 !%Type float
340 !%Default 0
341 !%Section Utilities::oct-unfold
342 !%Description
343 !% Specifies the energy resolution for the unfolded band structure.
344 !% If you specify 0, the resolution will be set to be 1/1000 points between <tt>UnfoldMinEnergy</tt>
345 !% and <tt>UnfoldMaxEnergy</tt>
346 !%End
347 call parse_variable(global_namespace, 'UnfoldEnergyStep', m_zero, de)
348 if (de < m_zero) then
349 message(1) = "UnfoldEnergyStep must be positive"
350 call messages_fatal(1)
351 end if
352
353 !%Variable UnfoldMinEnergy
354 !%Type float
355 !%Section Utilities::oct-unfold
356 !%Description
357 !% Specifies the start of the energy range for the unfolded band structure.
358 !% The default value correspond to the samllest eigenvalue.
359 !%End
360 call parse_variable(global_namespace, 'UnfoldMinEnergy', minval(st%eigenval(:, :)), eigmin)
361
362 !%Variable UnfoldMaxEnergy
363 !%Type float
364 !%Section Utilities::oct-unfold
365 !%Description
366 !% Specifies the end of the energy range for the unfolded band structure.
367 !% The default value correspond to the largest eigenvalue.
368 !%End
369 call parse_variable(global_namespace, 'UnfoldMaxEnergy', maxval(st%eigenval(:, :)), eigmax)
370
371 if (abs(de) <= m_epsilon) then
372 de = (eigmax - eigmin) / 1000_real64
373 end if
374
375 !We increase a bit the energy range
376 nenergy = floor((eigmax - eigmin + 2 * nextend * de) / de)
377 safe_allocate(eigs(1:nenergy))
378 do ie = 1, nenergy
379 eigs(ie) = eigmin - nextend * de + (ie - 1) * de
380 end do
381
382 safe_allocate(gvec_abs(1:sys%space%periodic_dim, 1:sys%kpoints%reduced%npoints))
383 gvec_abs = 0
384 file_gvec = io_open('./unfold_gvec.dat', global_namespace, action='read')
385 read(file_gvec,*)
386 read(file_gvec,*)
387 do ik = 1, sys%kpoints%reduced%npoints
388 read(file_gvec,*) vec_sc(1:space%dim)
389 call kpoints_to_absolute(sys%kpoints%latt, vec_sc, gvec_abs(:, ik))
390 end do
391 call io_close(file_gvec)
392
393 if (mpi_world%is_root()) call loct_progress_bar(-1, (st%d%kpt%end - st%d%kpt%start + 1) * st%nst)
394
395 safe_allocate(ake(1:nenergy, 1:st%nik))
396 ake(:, :) = m_zero
397
398 safe_allocate(pkm(st%d%kpt%start:st%d%kpt%end, 1:st%nst))
399 pkm(:, :) = m_zero
400 do ik = st%d%kpt%start, st%d%kpt%end
401 iq = st%d%get_kpoint_index(ik)
402
403 call fourier_shell_init(shell, global_namespace, space, zcube, gr, kk = sys%kpoints%reduced%red_point(:, iq))
404
405 gmin = minval(shell%red_gvec(:,:))
406 gmax = maxval(shell%red_gvec(:,:))
407
408 safe_allocate(g_select(1:shell%ngvectors))
409 g_select(:) = .false.
410
411 select case (sys%space%periodic_dim)
412 case (3)
413 do ig = 1, shell%ngvectors
414 call kpoints_to_absolute(sys%kpoints%latt, real(shell%red_gvec(:,ig), real64), vec_sc(:))
415 do ix = gmin, gmax
416 do iy = gmin, gmax
417 do iz = gmin, gmax
418 vec_pc(1:3) = ix * pc%klattice(1:3,1) + iy * pc%klattice(1:3,2) + iz * pc%klattice(1:3,3)
419 if (abs(vec_sc(1) - vec_pc(1) - gvec_abs(1, iq)) < tol &
420 .and. abs(vec_sc(2) - vec_pc(2)-gvec_abs(2, iq)) < tol &
421 .and. abs(vec_sc(3) - vec_pc(3)-gvec_abs(3, iq)) < tol) then
422 g_select(ig) = .true.
423 end if
424 end do !iz
425 end do !iy
426 end do !ix
427 end do !ig
428
429 case (2)
430
431 do ig = 1, shell%ngvectors
432 call kpoints_to_absolute(sys%kpoints%latt, real(shell%red_gvec(:,ig), real64), vec_sc(:))
433 do ix = gmin, gmax
434 do iy = gmin, gmax
435 vec_pc(1:2) = ix * pc%klattice(1:2,1) + iy * pc%klattice(1:2,2)
436 if (abs(vec_sc(1) - vec_pc(1) - gvec_abs(1, iq)) < tol &
437 .and. abs(vec_sc(2) - vec_pc(2) - gvec_abs(2, iq)) < tol) then
438 g_select(ig) = .true.
439 end if
440 end do !ix
441 end do !ix
442 end do !ig
443
444 case default
445 call messages_not_implemented("Unfolding for periodic dimensions other than 2 or 3")
446 end select
447
448 if (gr%mpi_grp%is_root()) then
449 write(filename,"(a13,i3.3,a4)") "./static/ake_",ik,".dat"
450 file_ake = io_open(trim(filename), global_namespace, action='write')
451 write(file_ake, '(a)') '#Energy Ak(E)'
452 write(file_ake, '(a, i5)') '#Number of points in energy window ', nenergy
453 end if
454
455 do ist = 1, st%nst
456 !loop over states
457 do idim = 1, st%d%dim
458 ! Getting wavefunctions
459 ! for the moment we treat all functions as complex
460 call states_elec_get_state(st, gr, idim, ist, ik, zpsi)
461
462 call zmesh_to_cube(gr, zpsi, zcube, cf)
463
464 !Fourier transform from real-space to fourier space
465 call zcube_function_rs2fs(zcube, cf)
466
467 ! Normalisation
468 safe_allocate(field_g(1:shell%ngvectors))
469 norm = m_zero
470 do ig = 1, shell%ngvectors
471 field_g(ig) = cf%fs(shell%coords(1, ig), shell%coords(2, ig), shell%coords(3, ig))
472 norm = norm + abs(field_g(ig))**2
473 end do
474 field_g(:) = field_g(:) / sqrt(norm)
475
476 !Finding sub-g and calculating the Projection Pkm
477 do ig = 1, shell%ngvectors
478 if (.not. g_select(ig)) cycle
479 pkm(ik,ist) = pkm(ik,ist) + abs(field_g(ig))**2
480 end do
481
482 safe_deallocate_a(field_g)
483 end do !idim
484
485 !ist loop end
486 if (mpi_world%is_root()) then
487 call loct_progress_bar((ik - st%d%kpt%start) * st%nst + ist, &
488 (st%d%kpt%end - st%d%kpt%start + 1) * st%nst)
489 end if
490 end do !ist
491
492 ! Calculating the spectral function
493 !TODO: We could implement here a different broadening
494 do ist = 1, st%nst
495 do ie = 1, nenergy
496 ake(ie, ik) = ake(ie, ik) + pkm(ik, ist) * (m_three * de / m_pi) / &
497 ((eigs(ie) - st%eigenval(ist, ik))**2 + (m_three * de)**2)
498 end do
499 end do
500
501 ! writing Spectral-Function
502 do ie = 1, nenergy
503 write(file_ake, '(1es19.12,1x,1es19.12)') eigs(ie), ake(ie, ik)
504 end do
505
506 if (gr%mpi_grp%is_root()) call io_close(file_ake)
507
508 call fourier_shell_end(shell)
509 safe_deallocate_a(g_select)
510
511 end do !ik
512
513 if (st%d%kpt%parallel) then
514 call comm_allreduce(st%st_kpt_mpi_grp, ake)
515 end if
516
517 if (mpi_world%is_root()) then
518 file_ake = io_open("static/ake.dat", global_namespace, action='write')
519 write(file_ake, '(a)') '#Energy Ak(E)'
520 write(file_ake, '(a, i5)') '#Number of points in energy window ', nenergy
521 do ik = 1, nkpoints
522 do ie = 1, nenergy
523 write(file_ake,fmt ='(1es19.12,1x,1es19.12,1x,1es19.12)') coord_along_path(ik), &
524 eigs(ie), ake(ie, ik)
525 end do
526 end do
527
528 call io_close(file_ake)
529 end if
530
531 safe_deallocate_a(eigs)
532 safe_deallocate_a(ake)
533
534 safe_deallocate_a(gvec_abs)
535 safe_deallocate_a(pkm)
536 safe_deallocate_a(zpsi)
537 pop_sub(wfs_extract_spec_fn)
538
539 end subroutine wfs_extract_spec_fn
540 !------------------------------------------------------------
541
542end program oct_unfold
543!! Local Variables:
544!! mode: f90
545!! coding: utf-8
546!! End:
double floor(double __x) __attribute__((__nothrow__
This module implements batches of mesh functions.
Definition: batch.F90:135
This module implements common operations on batches of mesh functions.
Definition: batch_ops.F90:118
This module handles the calculation mode.
type(calc_mode_par_t), public calc_mode_par
Singleton instance of parallel calculation mode.
integer, parameter, public p_strategy_states
parallelization in states
subroutine, public zmesh_to_cube(mesh, mf, cube, cf)
Convert a function from the mesh to the cube.
subroutine, public zcube_function_free_rs(cube, cf)
Deallocates the real space grid.
subroutine, public zcube_function_alloc_rs(cube, cf, in_device, force_alloc)
Allocates locally the real space grid, if PFFT library is not used. Otherwise, it assigns the PFFT re...
subroutine, public cube_init(cube, nn, namespace, space, spacing, coord_system, fft_type, fft_library, dont_optimize, nn_out, mpi_grp, need_partition, tp_enlarge, blocksize)
Definition: cube.F90:204
subroutine, public cube_end(cube)
Definition: cube.F90:387
subroutine, public cube_init_cube_map(cube, mesh)
Definition: cube.F90:824
integer, parameter, public spinors
Fast Fourier Transform module. This module provides a single interface that works with different FFT ...
Definition: fft.F90:120
subroutine, public fft_all_init(namespace)
initialize the table
Definition: fft.F90:280
subroutine, public fft_all_end()
delete all plans
Definition: fft.F90:391
integer, parameter, public fft_complex
Definition: fft.F90:180
subroutine, public fourier_shell_init(this, namespace, space, cube, mesh, kk)
subroutine, public fourier_shell_end(this)
subroutine, public cube_function_free_fs(cube, cf)
Deallocates the Fourier space grid.
subroutine, public zcube_function_rs2fs(cube, cf)
The following routines convert the function between real space and Fourier space Note that the dimens...
subroutine, public cube_function_alloc_fs(cube, cf, force_alloc)
Allocates locally the Fourier space grid, if PFFT library is not used. Otherwise, it assigns the PFFT...
subroutine, public global_end()
Finalise parser varinfo file, and MPI.
Definition: global.F90:387
real(real64), parameter, public m_zero
Definition: global.F90:190
real(real64), parameter, public m_pi
some mathematical constants
Definition: global.F90:188
real(real64), parameter, public m_epsilon
Definition: global.F90:206
subroutine, public global_init(communicator)
Initialise Octopus.
Definition: global.F90:330
real(real64), parameter, public m_half
Definition: global.F90:196
real(real64), parameter, public m_three
Definition: global.F90:193
This module implements the underlying real-space grid.
Definition: grid.F90:119
Definition: io.F90:116
subroutine, public io_init(defaults)
If the argument defaults is present and set to true, then the routine will not try to read anything f...
Definition: io.F90:165
subroutine, public io_close(iunit, grp)
Definition: io.F90:466
subroutine, public io_end()
Definition: io.F90:270
integer function, public io_open(file, namespace, action, status, form, position, die, recl, grp)
Definition: io.F90:401
subroutine, public kpoints_path_generate(dim, latt, nkpoints, nsegments, resolution, highsympoints, kpoints, coord)
Generate the k-point along a path.
Definition: kpoints.F90:1245
subroutine, public kpoints_fold_to_1bz(grid, latt)
Definition: kpoints.F90:1421
subroutine, public kpoints_grid_end(this)
Definition: kpoints.F90:242
subroutine, public kpoints_to_reduced(latt, kin, kout)
Definition: kpoints.F90:1046
subroutine, public kpoints_to_absolute(latt, kin, kout)
Definition: kpoints.F90:1033
subroutine, public kpoints_grid_init(dim, this, npoints, nshifts)
Definition: kpoints.F90:221
This module is intended to contain "only mathematical" functions and procedures.
Definition: math.F90:117
This module defines various routines, operating on mesh functions.
This module defines the meshes, which are used in Octopus.
Definition: mesh.F90:120
subroutine, public messages_end()
Definition: messages.F90:279
subroutine, public messages_print_with_emphasis(msg, iunit, namespace)
Definition: messages.F90:904
subroutine, public messages_not_implemented(feature, namespace)
Definition: messages.F90:1097
character(len=512), private msg
Definition: messages.F90:167
subroutine, public messages_init(output_dir)
Definition: messages.F90:226
subroutine, public print_date(str)
Definition: messages.F90:989
character(len=256), dimension(max_lines), public message
to be output by fatal, warning
Definition: messages.F90:162
subroutine, public messages_fatal(no_lines, only_root_writes, namespace)
Definition: messages.F90:416
subroutine, public messages_input_error(namespace, var, details, row, column)
Definition: messages.F90:697
subroutine, public messages_experimental(name, namespace)
Definition: messages.F90:1069
This module contains some common usage patterns of MPI routines.
Definition: mpi_lib.F90:117
type(mpi_grp_t), public mpi_world
Definition: mpi.F90:272
This module handles the communicators for the various parallelization strategies.
Definition: multicomm.F90:147
type(namespace_t), public global_namespace
Definition: namespace.F90:134
subroutine, public parser_init()
Initialise the Octopus parser.
Definition: parser.F90:453
subroutine, public parser_end()
End the Octopus parser.
Definition: parser.F90:484
integer function, public parse_block(namespace, name, blk, check_varinfo_)
Definition: parser.F90:621
subroutine, public profiling_end(namespace)
Definition: profiling.F90:415
subroutine, public profiling_init(namespace)
Create profiling subdirectory.
Definition: profiling.F90:257
integer, parameter, public restart_type_load
Definition: restart.F90:183
integer, parameter, public restart_unocc
Definition: restart.F90:156
subroutine, public states_elec_allocate_wfns(st, mesh, wfs_type, skip, packed)
Allocates the KS wavefunctions defined within a states_elec_t structure.
This module handles reading and writing restart information for the states_elec_t.
subroutine, public states_elec_load(restart, namespace, space, st, mesh, kpoints, ierr, iter, lr, lowest_missing, label, verbose, skip)
returns in ierr: <0 => Fatal error, or nothing read =0 => read all wavefunctions >0 => could only rea...
brief This module defines the class unit_t which is used by the unit_systems_oct_m module.
Definition: unit.F90:134
This module defines the unit system, used for input and output.
subroutine, public unit_system_init(namespace)
This module is intended to contain simple general-purpose utility functions and procedures.
Definition: utils.F90:120
subroutine, public print_header()
This subroutine prints the logo followed by information about the compilation and the system....
Definition: utils.F90:304
Definition: xc.F90:116
Class describing the electron system.
Definition: electrons.F90:220
Description of the grid, containing information on derivatives, stencil, and symmetries.
Definition: grid.F90:171
The states_elec_t class contains all electronic wave functions.
int true(void)
subroutine unfold_setup()
Definition: unfold.F90:380
subroutine wfs_extract_spec_fn(space, st, gr, zcube, cf)
Definition: unfold.F90:410
program oct_unfold
Definition: unfold.F90:119