36 use,
intrinsic :: iso_fortran_env
97 integer,
public,
parameter :: &
98 POISSON_DIRECT_SUM = -1, &
110 type(derivatives_t),
pointer,
public :: der
112 integer,
public :: kernel
113 type(cube_t),
public :: cube
114 type(mesh_cube_parallel_map_t),
public :: mesh_cube_map
115 type(poisson_mg_solver_t) :: mg
116 type(poisson_fft_t),
public :: fft_solver
117 real(real64),
public :: poisson_soft_coulomb_param
118 logical :: all_nodes_default
119 type(poisson_corr_t) :: corrector
120 type(poisson_isf_t) :: isf_solver
121 type(poisson_psolver_t) :: psolver_solver
122 type(poisson_no_t) :: no_solver
124 logical,
public :: is_dressed = .false.
125 type(photon_mode_t),
public :: photons
127 type(MPI_Comm) :: intercomm
128 type(mpi_grp_t) :: local_grp
133 integer,
parameter :: &
140 subroutine poisson_init(this, namespace, space, der, mc, stencil, qtot, label, solver, verbose, force_serial, force_cmplx)
141 type(poisson_t),
intent(inout) :: this
142 class(space_t),
intent(in) :: space
143 type(namespace_t),
intent(in) :: namespace
144 type(derivatives_t),
target,
intent(in) :: der
145 type(multicomm_t),
intent(in) :: mc
146 type(stencil_t),
intent(in) :: stencil
147 real(real64),
optional,
intent(in) :: qtot
148 character(len=*),
optional,
intent(in) :: label
149 integer,
optional,
intent(in) :: solver
150 logical,
optional,
intent(in) :: verbose
151 logical,
optional,
intent(in) :: force_serial
152 logical,
optional,
intent(in) :: force_cmplx
154 logical :: need_cube, isf_data_is_parallel
155 integer :: default_solver, default_kernel, box(space%dim), fft_type, fft_library
156 real(real64) :: fft_alpha
157 character(len=60) :: str
166 if (
present(label)) str = trim(label)
188 call parse_variable(namespace,
'DressedOrbitals', .false., this%is_dressed)
190 if (this%is_dressed)
then
191 assert(
present(qtot))
196 if(.not.
allocated(this%photons%pol_dipole))
then
199 if (this%photons%nmodes > 1)
then
204 this%all_nodes_default = .false.
260 if (space%dim == 3 .and. .not. space%is_periodic()) default_solver =
poisson_isf
266 if (space%dim > 3) default_solver =
poisson_no
268 if (der%mesh%use_curvilinear)
then
269 select case (space%dim)
271 default_solver = poisson_direct_sum
273 default_solver = poisson_direct_sum
279 if (this%is_dressed) default_solver = poisson_direct_sum
281 if (.not.
present(solver))
then
282 call parse_variable(namespace,
'PoissonSolver', default_solver, this%method)
288 select case (this%method)
289 case (poisson_direct_sum)
292 str =
"fast Fourier transform"
294 str =
"conjugate gradients"
296 str =
"conjugate gradients, corrected"
300 str =
"interpolating scaling functions"
302 str =
"interpolating scaling functions (from BigDFT)"
304 str =
"no Poisson solver - Hartree set to 0"
306 write(
message(1),
'(a,a,a)')
"The chosen Poisson solver is '", trim(str),
"'"
310 if (space%dim > 3 .and. this%method /=
poisson_no)
then
311 call messages_input_error(namespace,
'PoissonSolver',
'Currently no Poisson solver is available for Dimensions > 3')
348 select case (space%dim)
350 if (.not. space%is_periodic())
then
356 if (space%periodic_dim == 2)
then
358 else if (space%is_periodic())
then
359 default_kernel = space%periodic_dim
364 default_kernel = space%periodic_dim
367 call parse_variable(namespace,
'PoissonFFTKernel', default_kernel, this%kernel)
377 message(1) =
'PoissonFFTKernel=multipole_correction is not supported on GPUs'
378 message(2) =
'Using FFTW to compute the FFTs on the CPU'
385 if (.not.
present(solver))
then
386 if (space%is_periodic() .and. this%method == poisson_direct_sum)
then
387 message(1) =
'A periodic system may not use the direct_sum Poisson solver.'
392 message(1) =
'A periodic system may not use the cg_corrected Poisson solver.'
396 if (space%is_periodic() .and. this%method ==
poisson_cg)
then
397 message(1) =
'A periodic system may not use the cg Poisson solver.'
402 message(1) =
'A periodic system may not use the multigrid Poisson solver.'
406 select case (space%dim)
409 select case (space%periodic_dim)
411 if ((this%method /=
poisson_fft) .and. (this%method /= poisson_direct_sum))
then
412 message(1) =
'A finite 1D system may only use fft or direct_sum Poisson solvers.'
417 message(1) =
'A periodic 1D system may only use the fft Poisson solver.'
422 if (der%mesh%use_curvilinear .and. this%method /= poisson_direct_sum)
then
423 message(1) =
'If curvilinear coordinates are used in 1D, then the only working'
424 message(2) =
'Poisson solver is direct_sum.'
430 if ((this%method /=
poisson_fft) .and. (this%method /= poisson_direct_sum))
then
431 message(1) =
'A 2D system may only use fft or direct_sum solvers.'
435 if (der%mesh%use_curvilinear .and. (this%method /= poisson_direct_sum))
then
436 message(1) =
'If curvilinear coordinates are used in 2D, then the only working'
437 message(2) =
'Poisson solver is direct_sum.'
443 if (space%is_periodic() .and. this%method ==
poisson_isf)
then
444 call messages_write(
'The ISF solver can only be used for finite systems.')
448 if (space%is_periodic() .and. this%method ==
poisson_fft .and. &
449 this%kernel /= space%periodic_dim .and. this%kernel >= 0 .and. this%kernel <= 3)
then
450 write(
message(1),
'(a,i1,a)')
'The system is periodic in ', space%periodic_dim ,
' dimension(s),'
451 write(
message(2),
'(a,i1,a)')
'but Poisson solver is set for ', this%kernel,
' dimensions.'
456 write(
message(1),
'(a,i1,a)')
'PoissonFFTKernel = multipole_correction cannot be used for periodic systems.'
461 message(1) =
'If curvilinear coordinates are used, then the only working'
462 message(2) =
'Poisson solver are cg_corrected and multigrid.'
469 select type (box => der%mesh%box)
472 message(1) =
'When using the "minimum" box shape and the "cg_corrected"'
473 message(2) =
'Poisson solver, we have observed "sometimes" some non-'
474 message(3) =
'negligible error. You may want to check that the "fft" or "cg"'
475 message(4) =
'solver are providing, in your case, the same results.'
484#if !(defined HAVE_PSOLVER)
485 message(1) =
"The PSolver Poisson solver cannot be used since the code was not compiled with the PSolver library."
501 box(:) = der%mesh%idx%ll(:)
511 call parse_variable(namespace,
'PoissonSolverPSolverParallelData', .
true., isf_data_is_parallel)
539 write(
message(1),
'(a,f12.5,a)')
"Input: '", fft_alpha, &
540 "' is not a valid DoubleFFTParameter"
541 message(2) =
'1.0 <= DoubleFFTParameter <= 3.0'
545 if (space%dim /= 3 .and. fft_library ==
fftlib_pfft)
then
549 select case (space%dim)
552 select case (this%kernel)
556 box = der%mesh%idx%ll
560 select case (this%kernel)
563 box(1:2) = maxval(box)
567 box(:) = der%mesh%idx%ll(:)
571 select case (this%kernel)
577 box(2) = maxval(box(2:3))
578 box(3) = maxval(box(2:3))
580 box(:) = der%mesh%idx%ll(:)
591 call cube_init(this%cube, box, namespace, space, der%mesh%spacing, &
592 der%mesh%coord_system, fft_type = fft_type, &
593 need_partition=.not.der%mesh%parallel_in_domains)
595 if (this%cube%parallel_in_domains .and. this%method ==
poisson_fft)
then
600 if (this%is_dressed .and. .not. this%method == poisson_direct_sum)
then
601 write(
message(1),
'(a)')
'Dressed Orbital calculation currently only working with direct sum Poisson solver.'
620 select case (this%method)
648 if (this%cube%parallel_in_domains)
then
654 if (this%is_dressed)
then
657 this%is_dressed = .false.
667 complex(real64),
contiguous,
intent(inout) :: pot(:)
668 complex(real64),
contiguous,
intent(in) :: rho(:)
669 logical,
optional,
intent(in) :: all_nodes
672 real(real64),
allocatable :: aux1(:), aux2(:)
674 logical :: all_nodes_value
683 if (
present(kernel))
then
684 assert(.not. any(abs(kernel%qq(:))>1e-8_real64))
689 safe_allocate(aux1(1:der%mesh%np))
690 safe_allocate(aux2(1:der%mesh%np))
692 aux1(1:der%mesh%np) = real(rho(1:der%mesh%np), real64)
693 aux2(1:der%mesh%np) = real(pot(1:der%mesh%np), real64)
694 call dpoisson_solve(this, namespace, aux2, aux1, all_nodes=all_nodes_value, kernel=kernel)
695 pot(1:der%mesh%np) = aux2(1:der%mesh%np)
698 aux1(1:der%mesh%np) = aimag(rho(1:der%mesh%np))
699 aux2(1:der%mesh%np) = aimag(pot(1:der%mesh%np))
700 call dpoisson_solve(this, namespace, aux2, aux1, all_nodes=all_nodes_value, kernel=kernel)
701 pot(1:der%mesh%np) = pot(1:der%mesh%np) +
m_zi*aux2(1:der%mesh%np)
703 safe_deallocate_a(aux1)
704 safe_deallocate_a(aux2)
713 subroutine zpoisson_solve(this, namespace, pot, rho, all_nodes, kernel, reset)
716 complex(real64),
contiguous,
intent(inout) :: pot(:)
717 complex(real64),
contiguous,
intent(in) :: rho(:)
718 logical,
optional,
intent(in) :: all_nodes
720 logical,
optional,
intent(in) :: reset
722 logical :: all_nodes_value
728 assert(ubound(pot, dim = 1) == this%der%mesh%np_part .or. ubound(pot, dim = 1) == this%der%mesh%np)
729 assert(ubound(rho, dim = 1) == this%der%mesh%np_part .or. ubound(rho, dim = 1) == this%der%mesh%np)
734 pot(1:this%der%mesh%np) =
m_zero
738 .and. .not. this%is_dressed)
then
744 call zpoisson_fft_solve(this%fft_solver, this%der%mesh, this%cube, pot, rho, this%mesh_cube_map, kernel=kernel)
762 type(
batch_t),
intent(inout) :: potb
763 type(
batch_t),
intent(inout) :: rhob
764 logical,
optional,
intent(in) :: all_nodes
771 assert(potb%nst_linear == rhob%nst_linear)
772 assert(potb%type() == rhob%type())
775 do ii = 1, potb%nst_linear
776 call dpoisson_solve(this, namespace, potb%dff_linear(:, ii), rhob%dff_linear(:, ii), all_nodes, kernel=kernel)
779 do ii = 1, potb%nst_linear
780 call zpoisson_solve(this, namespace, potb%zff_linear(:, ii), rhob%zff_linear(:, ii), all_nodes, kernel=kernel)
794 subroutine dpoisson_solve(this, namespace, pot, rho, all_nodes, kernel, reset)
797 real(real64),
contiguous,
intent(inout) :: pot(:)
798 real(real64),
contiguous,
intent(in) :: rho(:)
802 logical,
optional,
intent(in) :: all_nodes
804 logical,
optional,
intent(in) :: reset
807 real(real64),
allocatable :: rho_corrected(:), vh_correction(:)
808 logical :: all_nodes_value
815 assert(ubound(pot, dim = 1) == der%mesh%np_part .or. ubound(pot, dim = 1) == der%mesh%np)
816 assert(ubound(rho, dim = 1) == der%mesh%np_part .or. ubound(rho, dim = 1) == der%mesh%np)
822 pot(1:der%mesh%np) =
m_zero
827 if (
present(kernel))
then
831 select case (this%method)
832 case (poisson_direct_sum)
833 if ((this%is_dressed .and. this%der%dim - 1 > 3) .or. this%der%dim > 3)
then
834 message(1) =
"Direct sum Poisson solver only available for 1, 2, or 3 dimensions."
840 call poisson_cg1(namespace, der, this%corrector, pot, rho)
843 safe_allocate(rho_corrected(1:der%mesh%np))
844 safe_allocate(vh_correction(1:der%mesh%np_part))
846 call correct_rho(this%corrector, der, rho, rho_corrected, vh_correction)
848 pot(1:der%mesh%np) = pot(1:der%mesh%np) - vh_correction(1:der%mesh%np)
849 call poisson_cg2(namespace, der, pot, rho_corrected)
850 pot(1:der%mesh%np) = pot(1:der%mesh%np) + vh_correction(1:der%mesh%np)
852 safe_deallocate_a(rho_corrected)
853 safe_deallocate_a(vh_correction)
860 call dpoisson_fft_solve(this%fft_solver, der%mesh, this%cube, pot, rho, this%mesh_cube_map, kernel=kernel)
862 safe_allocate(rho_corrected(1:der%mesh%np))
863 safe_allocate(vh_correction(1:der%mesh%np_part))
865 call correct_rho(this%corrector, der, rho, rho_corrected, vh_correction)
866 call dpoisson_fft_solve(this%fft_solver, der%mesh, this%cube, pot, rho_corrected, this%mesh_cube_map, &
867 average_to_zero = .
true., kernel=kernel)
869 pot(1:der%mesh%np) = pot(1:der%mesh%np) + vh_correction(1:der%mesh%np)
870 safe_deallocate_a(rho_corrected)
871 safe_deallocate_a(vh_correction)
875 call poisson_isf_solve(this%isf_solver, der%mesh, this%cube, pot, rho, all_nodes_value)
879 if (this%psolver_solver%datacode ==
"G")
then
892 if (this%is_dressed .and. this%method /=
poisson_no)
then
901 subroutine poisson_init_sm(this, namespace, space, main, der, sm, method, force_cmplx)
904 class(
space_t),
intent(in) :: space
908 integer,
optional,
intent(in) :: method
909 logical,
optional,
intent(in) :: force_cmplx
911 integer :: default_solver, idir, iter, maxl
912 integer :: box(space%dim)
919 this%is_dressed = .false.
921 this%all_nodes_default = .false.
927 this%all_nodes_default = main%all_nodes_default
930 default_solver = poisson_direct_sum
931 this%method = default_solver
932 if (
present(method)) this%method = method
934 if (der%mesh%use_curvilinear)
then
940 select case (this%method)
941 case (poisson_direct_sum)
946 assert(.not. der%mesh%parallel_in_domains)
949 call cube_init(this%cube, box, namespace, space, sm%mesh%spacing, sm%mesh%coord_system, &
950 fft_type =
fft_none, need_partition=.not.der%mesh%parallel_in_domains)
952 call poisson_isf_init(this%isf_solver, namespace, der%mesh, this%cube,
mpi_world%comm, init_world = this%all_nodes_default)
956 assert(.not. der%mesh%parallel_in_domains)
957 if (this%all_nodes_default)
then
960 this%cube%mpi_grp = this%der%mesh%mpi_grp
964 call cube_init(this%cube, box, namespace, space, sm%mesh%spacing, sm%mesh%coord_system, &
965 fft_type =
fft_none, need_partition=.not.der%mesh%parallel_in_domains)
980 do idir = 1, space%dim
981 box(idir) = (2 * (box(idir) - 1)) + 1
984 call cube_init(this%cube, box, namespace, space, sm%mesh%spacing, sm%mesh%coord_system, &
985 fft_type =
fft_complex, need_partition=.not.der%mesh%parallel_in_domains)
987 call cube_init(this%cube, box, namespace, space, sm%mesh%spacing, sm%mesh%coord_system, &
988 fft_type =
fft_real, need_partition=.not.der%mesh%parallel_in_domains)
990 call poisson_fft_init(this%fft_solver, namespace, space, this%cube, this%kernel)
992 call parse_variable(namespace,
'PoissonSolverMaxMultipole', 4, maxl)
993 write(
message(1),
'(a,i2)')
'Info: Boundary conditions fixed up to L =', maxl
1029 this%kernel /= poisson_fft_kernel_sph .and. this%kernel /= poisson_fft_kernel_corrected)
then
1040 solver = this%method
1047 type(multicomm_t),
intent(in) :: mc
1052 if (multicomm_have_slaves(mc))
then
1054 call mpi_grp_init(this%local_grp, mc%group_comm(p_strategy_states))
1056 this%root = (this%local_grp%is_root())
1058 this%intercomm = mc%slave_intercomm
1059 call mpi_comm_remote_size(this%intercomm, this%nslaves)
1072 type(multicomm_t),
intent(in) :: mc
1081 if (multicomm_have_slaves(mc))
then
1084 do islave = this%local_grp%rank, this%nslaves - 1, this%local_grp%size
1085 call mpi_send(m_one, 1, mpi_double_precision, islave,
cmd_finish, this%intercomm)
1099 type(namespace_t),
intent(in) :: namespace
1102 real(real64),
allocatable :: rho(:), pot(:)
1104 type(mpi_status) :: status
1105 integer :: bcast_root
1108 call profiling_in(
"SLAVE_WORK")
1110 safe_allocate(rho(1:this%der%mesh%np))
1111 safe_allocate(pot(1:this%der%mesh%np))
1114 do while(.not. done)
1116 call profiling_in(
"SLAVE_WAIT")
1117 call mpi_recv(rho(1), this%der%mesh%np, mpi_double_precision, mpi_any_source, mpi_any_tag, this%intercomm, status)
1118 call profiling_out(
"SLAVE_WAIT")
1121 select case (status%MPI_TAG)
1129 call profiling_in(
"SLAVE_BROADCAST")
1130 bcast_root = mpi_proc_null
1131 if (this%root) bcast_root = mpi_root
1132 call mpi_bcast(pot(1), this%der%mesh%np, mpi_double_precision, bcast_root, this%intercomm)
1133 call profiling_out(
"SLAVE_BROADCAST")
1139 safe_deallocate_a(pot)
1140 safe_deallocate_a(rho)
1142 call profiling_out(
"SLAVE_WORK")
1152 async = (this%nslaves > 0)
1160 type(namespace_t),
intent(in) :: namespace
1161 class(space_t),
intent(in) :: space
1162 type(fourier_space_op_t),
intent(inout) :: coulb
1163 real(real64),
intent(in) :: qq(:)
1164 type(xc_cam_t),
intent(in) :: cam
1165 real(real64),
optional,
intent(in) :: singul
1167 real(real64),
parameter :: vanishing_q = 1.0e-5_real64
1172 if (space%is_periodic())
then
1173 assert(ubound(qq, 1) >= space%periodic_dim)
1177 if (cam%omega > m_epsilon)
then
1179 write(message(1),
'(a)')
"Poisson solver with range separation is only implemented with FFT."
1180 call messages_fatal(1, namespace=namespace)
1186 if (
allocated(coulb%qq))
then
1187 reinit = any(abs(coulb%qq(1:space%periodic_dim) - qq(1:space%periodic_dim)) > m_epsilon)
1189 reinit = reinit .or. (abs(coulb%mu - cam%omega) > m_epsilon .and. cam%omega > m_epsilon)
1190 reinit = reinit .or. (abs(coulb%alpha - cam%alpha) > m_epsilon .and. cam%alpha > m_epsilon)
1191 reinit = reinit .or. (abs(coulb%beta - cam%beta) > m_epsilon .and. cam%beta > m_epsilon)
1196 select case (this%method)
1201 call fourier_space_op_end(coulb)
1203 safe_allocate(coulb%qq(1:space%dim))
1204 coulb%qq(1:space%periodic_dim) = qq(1:space%periodic_dim)
1205 coulb%qq(space%periodic_dim+1:space%dim) = vanishing_q
1207 coulb%singularity = optional_default(singul, m_zero)
1208 coulb%mu = cam%omega
1209 coulb%alpha = cam%alpha
1210 coulb%beta = cam%beta
1211 call poisson_fft_get_kernel(namespace, space, this%cube, coulb, this%kernel, &
1212 this%poisson_soft_coulomb_param)
1214 call messages_not_implemented(
"poisson_build_kernel with other methods than FFT", namespace=namespace)
1232 type(xc_cam_t),
intent(in) :: cam
1234 select case (this%method)
1238 if(cam%omega < m_epsilon)
then
1240 else if(cam%alpha > m_epsilon .and. cam%beta < m_epsilon)
then
1242 else if(cam%alpha < m_epsilon .and. cam%beta > m_epsilon)
then
1250#include "poisson_init_inc.F90"
1251#include "poisson_direct_inc.F90"
1252#include "poisson_direct_sm_inc.F90"
1256#include "poisson_inc.F90"
1258#include "complex.F90"
1259#include "poisson_inc.F90"
Prints out to iunit a message in the form: ["InputVariable" = value] where "InputVariable" is given b...
pure logical function, public accel_is_enabled()
This module implements batches of mesh functions.
This module handles the calculation mode.
integer, parameter, public p_strategy_kpoints
parallelization in k-points
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)
subroutine, public cube_end(cube)
subroutine, public cube_init_cube_map(cube, mesh)
This module calculates the derivatives (gradients, Laplacians, etc.) of a function.
Fast Fourier Transform module. This module provides a single interface that works with different FFT ...
integer, parameter, public fft_none
global constants
integer, public fft_default_lib
integer, parameter, public fftlib_accel
integer, parameter, public fft_real
integer, parameter, public fft_complex
integer, parameter, public fftlib_pfft
integer, parameter, public fftlib_fftw
real(real64), parameter, public m_two
real(real64), parameter, public m_zero
complex(real64), parameter, public m_zi
real(real64), parameter, public m_one
real(real64), parameter, public m_three
This module implements the index, used for the mesh points.
This module is intended to contain "only mathematical" functions and procedures.
subroutine, public mesh_cube_parallel_map_end(this)
subroutine, public mesh_cube_parallel_map_init(this, mesh, cube)
This module defines various routines, operating on mesh functions.
This module defines the meshes, which are used in Octopus.
subroutine, public mesh_double_box(space, mesh, alpha, db)
finds the dimension of a box doubled in the non-periodic dimensions
subroutine, public messages_print_with_emphasis(msg, iunit, namespace)
subroutine, public messages_not_implemented(feature, namespace)
character(len=512), private msg
subroutine, public messages_warning(no_lines, all_nodes, namespace)
character(len=256), dimension(max_lines), public message
to be output by fatal, warning
subroutine, public messages_fatal(no_lines, only_root_writes, namespace)
subroutine, public messages_input_error(namespace, var, details, row, column)
subroutine, public messages_experimental(name, namespace)
subroutine, public messages_info(no_lines, iunit, debug_only, stress, all_nodes, namespace)
type(mpi_grp_t), public mpi_world
This module handles the communicators for the various parallelization strategies.
logical pure function, public multicomm_strategy_is_parallel(mc, level)
logical pure function, public multicomm_have_slaves(this)
Some general things and nomenclature:
subroutine, public photon_mode_compute_dipoles(this, mesh)
Computes the polarization dipole.
subroutine, public photon_mode_add_poisson_terms(this, mesh, rho, pot)
subroutine, public photon_mode_end(this)
subroutine, public photon_mode_set_n_electrons(this, qtot)
subroutine, public photon_mode_init(this, namespace, dim, photon_free)
real(real64), public threshold
subroutine, public poisson_cg2(namespace, der, pot, rho)
subroutine, public poisson_cg1(namespace, der, corrector, pot, rho)
subroutine, public poisson_cg_init(thr, itr)
subroutine, public poisson_cg_end
subroutine, public poisson_corrections_end(this)
subroutine, public poisson_corrections_init(this, namespace, space, ml, mesh)
subroutine, public correct_rho(this, der, rho, rho_corrected, vh_correction)
integer, parameter, public poisson_fft_kernel_nocut
integer, parameter, public poisson_fft_kernel_cyl
subroutine, public zpoisson_fft_solve(this, mesh, cube, pot, rho, mesh_cube_map, average_to_zero, kernel, sm)
subroutine, public poisson_fft_end(this)
subroutine, public poisson_fft_init(this, namespace, space, cube, kernel, soft_coulb_param, fullcube)
integer, parameter, public poisson_fft_kernel_pla
integer, parameter, public poisson_fft_kernel_none
integer, parameter, public poisson_fft_kernel_corrected
integer, parameter, public poisson_fft_kernel_sph
subroutine, public dpoisson_fft_solve(this, mesh, cube, pot, rho, mesh_cube_map, average_to_zero, kernel, sm)
subroutine, public poisson_isf_end(this)
subroutine, public poisson_isf_init(this, namespace, mesh, cube, all_nodes_comm, init_world)
subroutine, public poisson_isf_solve(this, mesh, cube, pot, rho, all_nodes, sm)
subroutine, public poisson_multigrid_solver(this, namespace, der, pot, rho)
A multigrid Poisson solver with corrections at the boundaries.
subroutine, public poisson_multigrid_end(this)
subroutine, public poisson_no_solve(this, mesh, pot, rho)
subroutine, public poisson_no_end(this)
subroutine, public zpoisson_solve_sm(this, namespace, sm, pot, rho, all_nodes)
Calculates the Poisson equation. Given the density returns the corresponding potential.
integer, parameter, public poisson_multigrid
subroutine poisson_kernel_init(this, namespace, space, mc, stencil)
integer, parameter, public poisson_psolver
subroutine, public dpoisson_solve_start(this, rho)
integer, parameter cmd_finish
subroutine, public zpoisson_solve_finish(this, pot)
subroutine poisson_solve_direct(this, namespace, pot, rho)
integer, parameter, public poisson_fft
logical pure function, public poisson_is_multigrid(this)
subroutine, public zpoisson_solve(this, namespace, pot, rho, all_nodes, kernel, reset)
subroutine, public poisson_solve_batch(this, namespace, potb, rhob, all_nodes, kernel)
subroutine, public poisson_async_init(this, mc)
subroutine, public dpoisson_solve_sm(this, namespace, sm, pot, rho, all_nodes)
Calculates the Poisson equation. Given the density returns the corresponding potential.
subroutine zpoisson_solve_real_and_imag_separately(this, namespace, pot, rho, all_nodes, kernel)
subroutine, public poisson_init_sm(this, namespace, space, main, der, sm, method, force_cmplx)
logical pure function poisson_solver_is_iterative(this)
subroutine, public poisson_slave_work(this, namespace)
subroutine, public dpoisson_solve(this, namespace, pot, rho, all_nodes, kernel, reset)
Calculates the Poisson equation. Given the density returns the corresponding potential.
integer, parameter cmd_poisson_solve
integer, parameter, public poisson_cg
subroutine, public poisson_build_kernel(this, namespace, space, coulb, qq, cam, singul)
logical pure function, public poisson_solver_has_free_bc(this)
subroutine, public dpoisson_solve_finish(this, pot)
subroutine, public poisson_init(this, namespace, space, der, mc, stencil, qtot, label, solver, verbose, force_serial, force_cmplx)
subroutine, public zpoisson_solve_start(this, rho)
subroutine, public poisson_async_end(this, mc)
integer, parameter, public poisson_cg_corrected
integer pure function, public poisson_get_solver(this)
integer, parameter, public poisson_isf
real(real64) function, public poisson_get_full_range_weight(this, cam)
Most Poisson solvers do not implement Coulomb attenuated potentials, and can only be used for global ...
integer, parameter, public poisson_null
integer, parameter, public poisson_no
logical pure function, public poisson_is_async(this)
subroutine, public poisson_end(this)
subroutine, public poisson_psolver_global_solve(this, mesh, cube, pot, rho, sm)
subroutine, public poisson_psolver_parallel_solve(this, mesh, cube, pot, rho, mesh_cube_map)
subroutine, public poisson_psolver_end(this)
subroutine, public poisson_psolver_get_dims(this, cube)
subroutine, public poisson_psolver_init(this, namespace, space, cube, mu, qq, force_isolated)
subroutine, public profiling_out(label)
Increment out counter and sum up difference between entry and exit time.
subroutine, public profiling_in(label, exclude)
Increment in counter and save entry time.
This module defines stencils used in Octopus.
subroutine, public submesh_init_cube_map(sm, space)
subroutine, public submesh_get_cube_dim(sm, space, db)
finds the dimension of a box containing the submesh
type(type_t), public type_float
This module defines the unit system, used for input and output.
Class defining batches of mesh functions.
Class implementing a box that is a union of spheres. We do this in a specific class instead of using ...
class representing derivatives
A submesh is a type of mesh, used for the projectors in the pseudopotentials It contains points on a ...