94 class(box_t),
pointer :: box
95 class(coordinate_system_t),
pointer :: coord_system
97 logical :: use_curvilinear
99 real(real64),
allocatable :: spacing(:)
106 integer(int64) :: np_global
107 integer(int64) :: np_part_global
108 logical :: parallel_in_domains
109 type(mpi_grp_t) :: mpi_grp
110 type(par_vec_t) :: pv
111 type(partition_t) :: partition
113 real(real64),
allocatable :: x(:,:)
114 real(real64),
allocatable :: x_t(:,:)
115 real(real64),
allocatable :: chi(:,:)
116 real(real64) :: volume_element
117 real(real64),
allocatable :: vol_pp(:)
118 real(real64),
allocatable :: jacobian_inverse(:,:,:)
120 logical :: masked_periodic_boundaries
121 character(len=256) :: periodic_boundary_mask
127 procedure :: dmesh_allreduce_0, zmesh_allreduce_0, imesh_allreduce_0, lmesh_allreduce_0
128 procedure :: dmesh_allreduce_1, zmesh_allreduce_1, imesh_allreduce_1, lmesh_allreduce_1
129 procedure :: dmesh_allreduce_2, zmesh_allreduce_2, imesh_allreduce_2, lmesh_allreduce_2
130 procedure :: dmesh_allreduce_3, zmesh_allreduce_3, imesh_allreduce_3, lmesh_allreduce_3
131 procedure :: dmesh_allreduce_4, zmesh_allreduce_4, imesh_allreduce_4, lmesh_allreduce_4
132 procedure :: dmesh_allreduce_5, zmesh_allreduce_5, imesh_allreduce_5, lmesh_allreduce_5
133 procedure :: dmesh_allreduce_6, zmesh_allreduce_6, imesh_allreduce_6, lmesh_allreduce_6
134 generic :: allreduce => dmesh_allreduce_0, zmesh_allreduce_0, imesh_allreduce_0, lmesh_allreduce_0
135 generic :: allreduce => dmesh_allreduce_1, zmesh_allreduce_1, imesh_allreduce_1, lmesh_allreduce_1
136 generic :: allreduce => dmesh_allreduce_2, zmesh_allreduce_2, imesh_allreduce_2, lmesh_allreduce_2
137 generic :: allreduce => dmesh_allreduce_3, zmesh_allreduce_3, imesh_allreduce_3, lmesh_allreduce_3
138 generic :: allreduce => dmesh_allreduce_4, zmesh_allreduce_4, imesh_allreduce_4, lmesh_allreduce_4
139 generic :: allreduce => dmesh_allreduce_5, zmesh_allreduce_5, imesh_allreduce_5, lmesh_allreduce_5
140 generic :: allreduce => dmesh_allreduce_6, zmesh_allreduce_6, imesh_allreduce_6, lmesh_allreduce_6
157 real(real64) :: u(3), v(3)
158 real(real64) :: origin(3)
159 real(real64) :: spacing
160 integer :: nu, mu, nv, mv
170 real(real64) :: origin(2)
171 real(real64) :: spacing
178 class(mesh_t),
intent(inout) :: this
182 call this%set_time_dependent(.false.)
192 real(real64),
intent(in) :: alpha
193 integer,
intent(out) :: db(:)
202 do idir = 1, space%periodic_dim
203 db(idir) = mesh%idx%ll(idir)
205 do idir = space%periodic_dim + 1, space%dim
206 db(idir) = nint(alpha * (mesh%idx%ll(idir) - 1)) + 1
216 integer,
optional,
intent(in) :: iunit
217 type(
namespace_t),
optional,
intent(in) :: namespace
220 real(real64) :: cutoff
225 do ii = 1, this%box%dim
233 write(
message(2),
'(a, i10)')
' # inner mesh = ', this%np_global
234 write(
message(3),
'(a, i10)')
' # total mesh = ', this%np_part_global
246 pure subroutine mesh_r(mesh, ip, rr, origin, coords)
247 class(
mesh_t),
intent(in) :: mesh
248 integer,
intent(in) :: ip
249 real(real64),
intent(out) :: rr
250 real(real64),
intent(in),
optional :: origin(:)
251 real(real64),
intent(out),
optional :: coords(:)
253 real(real64) :: xx(1:mesh%box%dim)
256 if (
present(origin)) xx = xx - origin
259 if (
present(coords))
then
268 integer(int64),
intent(in) :: ipg
269 real(real64),
intent(out) :: rr
270 real(real64),
intent(in),
optional :: origin(:)
271 real(real64),
intent(out),
optional :: coords(:)
273 real(real64) :: xx(1:mesh%box%dim)
276 if (
present(origin)) xx = xx - origin
279 if (
present(coords))
then
291 class(
mesh_t),
intent(in) :: mesh
292 real(real64),
intent(in) :: pos(:)
293 real(real64),
intent(out) :: dmin
294 integer,
intent(out) :: rankmin
305 dd = sum((pos - mesh%x(:, ip))**2)
306 if ((dd < dmin) .or. (ip == 1))
then
313 call mesh%mpi_grp%bcast(imin, 1, mpi_integer, rankmin)
321 class(
mesh_t),
intent(in ) :: mesh
322 real(real64),
intent(inout) ::
values(:, :)
324 integer :: i, ip, ndim
326 real(real64) :: dummy
330 if (mesh%parallel_in_domains)
then
335 if (mesh%mpi_grp%rank == process)
values(:, i) = mesh%x(:, ip)
336 call mesh%mpi_grp%bcast(
values(:, i), ndim, mpi_double_precision, process)
355 class(
mesh_t),
intent(in) :: mesh
358 gmax =
m_pi / (maxval(mesh%spacing))
365 type(
mesh_t),
intent(in) :: mesh
366 character(len=*),
intent(in) :: dir
367 character(len=*),
intent(in) :: filename
368 type(mpi_grp_t),
intent(in) :: mpi_grp
369 type(namespace_t),
intent(in) :: namespace
370 integer,
intent(out) :: ierr
378 iunit = io_open(trim(dir)//
"/"//trim(filename), namespace, action=
'write', &
379 die=.false., grp=mpi_grp)
380 if (iunit == -1)
then
381 message(1) =
"Unable to open file '"//trim(dir)//
"/"//trim(filename)//
"'."
382 call messages_warning(1, namespace=namespace)
385 if (mpi_grp%is_root())
then
386 write(iunit,
'(a20,i21)')
'np_part_global= ', mesh%np_part_global
387 write(iunit,
'(a20,i21)')
'np_global= ', mesh%np_global
388 write(iunit,
'(a20,i21)')
'algorithm= ', 1
389 write(iunit,
'(a20,i21)')
'checksum= ', mesh%idx%checksum
390 write(iunit,
'(a20,i21)')
'bits= ', mesh%idx%bits
391 write(iunit,
'(a20,i21)')
'dim= ', mesh%idx%dim
392 write(iunit,
'(a20,i21)')
'type= ', mesh%idx%type
393 do ii = 1, mesh%idx%dim
394 write(iunit,
'(a7,i2,a11,i21)')
'offset(',ii,
')= ', mesh%idx%offset(ii)
396 do ii = 1, mesh%idx%dim
397 write(iunit,
'(a7,i2,a11,i21)')
'nn(',ii,
')= ', mesh%idx%nr(2, ii) - mesh%idx%nr(1, ii) + 1
400 call io_close(iunit, grp=mpi_grp)
413 read_np_part, read_np, bits, type, offset, nn, ierr)
414 type(
mesh_t),
intent(in) :: mesh
415 character(len=*),
intent(in) :: dir
416 character(len=*),
intent(in) :: filename
417 type(mpi_grp_t),
intent(in) :: mpi_grp
418 type(namespace_t),
intent(in) :: namespace
419 integer(int64),
intent(out) :: read_np_part
420 integer(int64),
intent(out) :: read_np
421 integer,
intent(out) :: bits
422 integer,
intent(out) :: type
423 integer,
intent(out) :: offset(1:mesh%idx%dim)
424 integer,
intent(out) :: nn(1:mesh%idx%dim)
425 integer,
intent(out) :: ierr
427 character(len=20) :: str
428 character(len=100) :: lines(7)
429 integer :: iunit, algorithm, dim, err, ii
430 integer(int64) :: checksum
436 read_np_part = 0_int64
439 iunit = io_open(trim(dir)//
"/"//trim(filename), namespace, action=
'read', &
440 status=
'old', die=.false., grp=mpi_grp)
441 if (iunit == -1)
then
443 message(1) =
"Unable to open file '"//trim(dir)//
"/"//trim(filename)//
"'."
444 call messages_warning(1, namespace=namespace)
446 call iopar_read(mpi_grp, iunit, lines, 7, err)
450 read(lines(1),
'(a20,i21)') str, read_np_part
451 read(lines(2),
'(a20,i21)') str, read_np
452 read(lines(3),
'(a20,i21)') str, algorithm
453 read(lines(4),
'(a20,i21)') str, checksum
454 read(lines(5),
'(a20,i21)') str, bits
455 read(lines(6),
'(a20,i21)') str, dim
456 read(lines(7),
'(a20,i21)') str,
type
458 if (dim /= mesh%idx%dim)
then
462 call iopar_read(mpi_grp, iunit, lines, dim, err)
467 read(lines(ii),
'(a20,i21)') str, offset(ii)
472 call iopar_read(mpi_grp, iunit, lines, dim, err)
477 read(lines(ii),
'(a20,i21)') str, nn(ii)
482 assert(read_np_part >= read_np)
484 if (read_np_part == mesh%np_part_global &
485 .and. read_np == mesh%np_global &
486 .and. algorithm == 1 &
487 .and. checksum == mesh%idx%checksum)
then
493 call io_close(iunit, grp=mpi_grp)
501 type(
mesh_t),
intent(in) :: mesh
502 character(len=*),
intent(in) :: dir
503 character(len=*),
intent(in) :: filename
504 type(namespace_t),
intent(in) :: namespace
505 type(mpi_grp_t),
intent(in) :: mpi_grp
506 logical,
intent(out) :: grid_changed
507 logical,
intent(out) :: grid_reordered
508 integer(int64),
allocatable,
intent(out) :: map(:)
509 integer,
intent(out) :: ierr
511 integer(int64) :: ipg, ipg_new, read_np_part, read_np
513 integer :: bits,
type, offset(mesh%idx%dim), point(mesh%idx%dim), nn(mesh%idx%dim)
514 integer(int64),
allocatable :: read_indices(:)
515 type(index_t) :: idx_old
521 grid_changed = .false.
522 grid_reordered = .false.
526 bits,
type, offset, nn, err)
529 message(1) =
"Unable to read mesh fingerprint from '"//trim(dir)//
"/"//trim(filename)//
"'."
530 call messages_warning(1, namespace=namespace)
532 else if (read_np > 0)
then
533 if (.not.
associated(mesh%box))
then
538 grid_changed = .
true.
543 grid_reordered = (read_np == mesh%np_global)
546 safe_allocate(read_indices(1:read_np_part))
547 call io_binary_read(trim(io_workpath(dir, namespace))//
"/indices.obf", read_np_part, &
551 message(1) =
"Unable to read index map from '"//trim(dir)//
"'."
552 call messages_warning(1, namespace=namespace)
555 call index_init(idx_old, mesh%idx%dim)
558 idx_old%nr(1, :) = -offset
559 idx_old%nr(2, :) = -offset + nn - 1
560 idx_old%offset = offset
561 idx_old%stride(1) = 1
562 do idir = 2, mesh%idx%dim
563 idx_old%stride(idir) = idx_old%stride(idir-1) * nn(idir-1)
566 safe_allocate(map(1:read_np))
569 call index_spatial_to_point(idx_old, mesh%idx%dim, read_indices(ipg), point)
574 if (map(ipg) > mesh%np_global) map(ipg) = 0
576 if (map(ipg) == 0) grid_reordered = .false.
578 call index_end(idx_old)
581 safe_deallocate_a(read_indices)
591 class(
mesh_t),
intent(inout) :: this
596 call lmpi_destroy_shared_memory_window(this%idx%window_grid_to_spatial)
597 call lmpi_destroy_shared_memory_window(this%idx%window_spatial_to_grid)
598 nullify(this%idx%grid_to_spatial_global)
599 nullify(this%idx%spatial_to_grid_global)
601 safe_deallocate_p(this%idx%grid_to_spatial_global)
602 safe_deallocate_p(this%idx%spatial_to_grid_global)
605 safe_deallocate_a(this%x)
606 safe_deallocate_a(this%chi)
607 safe_deallocate_a(this%vol_pp)
608 safe_deallocate_a(this%jacobian_inverse)
610 if (this%parallel_in_domains)
then
611 call par_vec_end(this%pv)
612 call partition_end(this%partition)
615 call index_end(this%idx)
616 safe_deallocate_a(this%spacing)
629 class(
mesh_t),
intent(in) :: mesh
630 class(space_t),
intent(in) :: space
631 integer,
intent(in) :: ip
633 integer :: ix(space%dim), nr(2, space%dim), idim
634 real(real64) :: xx(space%dim), rr, ufn_re, ufn_im
639 nr(1, :) = mesh%idx%nr(1, :) + mesh%idx%enlarge(:)
640 nr(2, :) = mesh%idx%nr(2, :) - mesh%idx%enlarge(:)
642 do idim = 1, space%periodic_dim
643 do while (ix(idim) < nr(1, idim))
644 ix(idim) = ix(idim) + mesh%idx%ll(idim)
646 do while (ix(idim) > nr(2, idim))
647 ix(idim) = ix(idim) - mesh%idx%ll(idim)
654 if (mesh%masked_periodic_boundaries)
then
655 call mesh_r(mesh, ip, rr, coords = xx)
656 call parse_expression(ufn_re, ufn_im, space%dim, xx, rr, m_zero, mesh%periodic_boundary_mask)
663 class(
mesh_t),
intent(in) :: mesh
664 class(space_t),
intent(in) :: space
665 integer(int64),
intent(in) :: ipg_in
667 integer :: ix(space%dim), nr(2, space%dim), idim
668 real(real64) :: xx(space%dim), rr, ufn_re, ufn_im
673 nr(1, :) = mesh%idx%nr(1, :) + mesh%idx%enlarge(:)
674 nr(2, :) = mesh%idx%nr(2, :) - mesh%idx%enlarge(:)
676 do idim = 1, space%periodic_dim
677 if (ix(idim) < nr(1, idim)) ix(idim) = ix(idim) + mesh%idx%ll(idim)
678 if (ix(idim) > nr(2, idim)) ix(idim) = ix(idim) - mesh%idx%ll(idim)
684 if (mesh%masked_periodic_boundaries)
then
686 call parse_expression(ufn_re, ufn_im, space%dim, xx, rr, m_zero, mesh%periodic_boundary_mask)
687 if (int(ufn_re) == 0) ipg = ipg_in
696 use iso_c_binding,
only: c_sizeof, c_long_long
697 class(
mesh_t),
intent(in) :: mesh
700 memory = c_sizeof(c_long_long) * real(mesh%np_part_global, real64) * 2
707 use iso_c_binding,
only: c_sizeof, c_long_long
708 class(
mesh_t),
intent(in) :: mesh
713 memory = memory + real64 * real(mesh%np_part, real64) * mesh%idx%dim
715 memory = memory + c_sizeof(c_long_long) * real(mesh%np_part, real64) * 2
722 class(
mesh_t),
intent(in) :: mesh
723 integer(int64),
intent(in) :: ipg
724 real(real64) :: xx(1:mesh%box%dim)
726 real(real64) :: chi(1:mesh%box%dim)
727 integer :: ix(1:mesh%box%dim)
732 chi = ix * mesh%spacing
733 xx = mesh%coord_system%to_cartesian(chi)
740 class(
mesh_t),
intent(in) :: mesh
741 type(symmetries_t),
intent(in) :: symm
742 integer,
intent(in) :: periodic_dim
744 integer :: iop, ip, idim, nops, ix(1:3)
745 real(real64) :: destpoint(1:3), srcpoint(1:3), lsize(1:3), offset(1:3)
746 real(real64),
parameter :: tol_spacing = 1e-12_real64
754 if (mesh%idx%ll(1) == mesh%idx%ll(2) .and. &
755 mesh%idx%ll(2) == mesh%idx%ll(3) .and. &
756 abs(mesh%spacing(1) - mesh%spacing(2)) < tol_spacing .and. &
757 abs(mesh%spacing(2) - mesh%spacing(3)) < tol_spacing)
return
761 message(1) =
"Checking if the real-space grid is symmetric"
762 call messages_info(1)
764 lsize(1:3) = real(mesh%idx%ll(1:3), real64)
765 offset(1:3) = real(mesh%idx%nr(1, 1:3) + mesh%idx%enlarge(1:3), real64)
767 nops = symmetries_number(symm)
774 destpoint(1:3) = real(ix(1:3), real64) - offset(1:3)
776 assert(all(destpoint >= 0))
777 assert(all(destpoint < lsize))
780 destpoint = destpoint - real(int(lsize)/2, real64)
784 destpoint(idim) = destpoint(idim)/lsize(idim)
789 srcpoint = symm_op_apply_red(symm%ops(iop), destpoint)
793 srcpoint(idim) = srcpoint(idim)*lsize(idim)
797 srcpoint = srcpoint + real(int(lsize)/2, real64)
800 do idim = 1, periodic_dim
801 if (nint(srcpoint(idim)) < 0 .or. nint(srcpoint(idim)) >= lsize(idim))
then
802 srcpoint(idim) = modulo(srcpoint(idim)+m_half*symprec, lsize(idim))
805 assert(all(srcpoint >= -symprec))
806 assert(all(srcpoint < lsize))
808 srcpoint(1:3) = srcpoint(1:3) + offset(1:3)
810 if (any(srcpoint-anint(srcpoint)> symprec*m_two))
then
811 message(1) =
"The real-space grid breaks at least one of the symmetries of the system."
812 message(2) =
"Change your spacing or use SymmetrizeDensity=no."
813 call messages_fatal(2)
824 class(
mesh_t),
intent(in) :: mesh
825 integer,
intent(in) :: ix(:)
827 index = index_from_coords(mesh%idx, ix)
833 type(
mesh_t),
intent(in) :: mesh
834 integer(int64),
intent(in) :: ipg
835 integer,
intent(out) :: ix(:)
837 call index_to_coords(mesh%idx, ipg, ix)
843 type(
mesh_t),
intent(in) :: mesh
844 integer,
intent(in) :: ix(:)
846 integer(int64) :: ipg
848 ipg = index_from_coords(mesh%idx, ix)
855 type(
mesh_t),
intent(in) :: mesh
856 integer,
intent(in) :: ip
857 integer,
intent(out) :: ix(:)
859 integer(int64) :: ipg
862 call index_to_coords(mesh%idx, ipg, ix)
867 type(
mesh_t),
intent(in) :: mesh
868 integer,
intent(in) :: ip
870 ipg = par_vec_local2global(mesh%pv, ip)
877 type(
mesh_t),
intent(in) :: mesh
878 integer(int64),
intent(in) :: ipg
880 ip = par_vec_global2local(mesh%pv, ipg)
886 type(
mesh_t),
intent(in) :: mesh
887 real(real64),
intent(inout) :: min_or_max
888 integer,
intent(out) :: rank_min_or_max
889 type(mpi_op),
intent(in) :: op
891 real(real64) :: loc_in(2), loc_out(2)
895 assert(op == mpi_minloc .or. op == mpi_maxloc)
898 if (mesh%parallel_in_domains)
then
899 loc_in(1) = min_or_max
900 loc_in(2) = mesh%mpi_grp%rank
901 call mesh%mpi_grp%allreduce(loc_in, loc_out, 1, mpi_2double_precision, op)
902 min_or_max = loc_out(1)
903 rank_min_or_max = nint(loc_out(2))
912#include "mesh_inc.F90"
915#include "complex.F90"
916#include "mesh_inc.F90"
919#include "integer.F90"
920#include "mesh_inc.F90"
923#include "integer8.F90"
924#include "mesh_inc.F90"
real(real64), parameter, public m_two
real(real64), parameter, public m_zero
real(real64), parameter, public m_pi
some mathematical constants
This module implements a simple hash table for non-negative integer keys and integer values.
This module implements the index, used for the mesh points.
This module defines the meshes, which are used in Octopus.
integer(int64) function, public mesh_periodic_point(mesh, space, ip)
This function returns the point inside the grid corresponding to a boundary point when PBCs are used....
subroutine, public mesh_global_index_to_coords(mesh, ipg, ix)
Given a global point index, this function returns the set of integer coordinates of the point.
integer function, public mesh_local_index_from_coords(mesh, ix)
This function returns the local index of the point for a given vector of integer coordinates.
subroutine, public mesh_double_box(space, mesh, alpha, db)
finds the dimension of a box doubled in the non-periodic dimensions
integer(int64) function, public mesh_global_index_from_coords(mesh, ix)
This function returns the true global index of the point for a given vector of integer coordinates.
subroutine, public mesh_check_symmetries(mesh, symm, periodic_dim)
subroutine, public mesh_write_info(this, iunit, namespace)
subroutine, public mesh_local_index_to_coords(mesh, ip, ix)
Given a local point index, this function returns the set of integer coordinates of the point.
subroutine, public mesh_discretize_values_to_mesh(mesh, values)
Assign a set of values to their nearest discrete points on the mesh.
integer function, public mesh_nearest_point(mesh, pos, dmin, rankmin)
Returns the index of the point which is nearest to a given vector position pos.
integer(int64) function, public mesh_periodic_point_global(mesh, space, ipg_in)
real(real64) pure function, public mesh_global_memory(mesh)
subroutine, public mesh_read_fingerprint(mesh, dir, filename, mpi_grp, namespace, read_np_part, read_np, bits, type, offset, nn, ierr)
This function reads the fingerprint of a mesh written in filename. If the meshes are equal (same fing...
pure subroutine, public mesh_r(mesh, ip, rr, origin, coords)
return the distance to the origin for a given grid point
subroutine, public mesh_check_dump_compatibility(mesh, dir, filename, namespace, mpi_grp, grid_changed, grid_reordered, map, ierr)
real(real64) function, public mesh_gcutoff(mesh)
mesh_gcutoff returns the "natural" band limitation of the grid mesh, in terms of the maximum G vector...
subroutine, public mesh_minmaxloc(mesh, min_or_max, rank_min_or_max, op)
Given a local min/max this returns the global min/max and the rank where this is located.
integer function, public mesh_global2local(mesh, ipg)
This function returns the local mesh index for a given global index.
recursive subroutine, public mesh_end(this)
real(real64) pure function, public mesh_local_memory(mesh)
integer(int64) function, public mesh_local2global(mesh, ip)
This function returns the global mesh index for a given local index.
real(real64) function, dimension(1:mesh%box%dim), public mesh_x_global(mesh, ipg)
Given a global point index, this function returns the coordinates of the point.
subroutine mesh_r_global(mesh, ipg, rr, origin, coords)
return the distance to the origin for a given grid point
subroutine, public mesh_write_fingerprint(mesh, dir, filename, mpi_grp, namespace, ierr)
subroutine mesh_init(this)
character(len=256), dimension(max_lines), public message
to be output by fatal, warning
subroutine, public messages_info(no_lines, iunit, debug_only, stress, all_nodes, namespace)
This module contains some common usage patterns of MPI routines.
Some general things and nomenclature:
brief This module defines the class unit_t which is used by the unit_systems_oct_m module.
character(len=20) pure function, public units_abbrev(this)
This module defines the unit system, used for input and output.
type(unit_system_t), public units_out
abstract class for basis sets
This data type defines a line, and a regular grid defined on this line (or rather,...
define a grid on a plane.
Describes mesh distribution to nodes.
real(real64) function values(xx)