2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2009,2010,2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
5 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6 * and including many others, as listed in the AUTHORS file in the
7 * top-level source directory and at http://www.gromacs.org.
9 * GROMACS is free software; you can redistribute it and/or
10 * modify it under the terms of the GNU Lesser General Public License
11 * as published by the Free Software Foundation; either version 2.1
12 * of the License, or (at your option) any later version.
14 * GROMACS is distributed in the hope that it will be useful,
15 * but WITHOUT ANY WARRANTY; without even the implied warranty of
16 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
17 * Lesser General Public License for more details.
19 * You should have received a copy of the GNU Lesser General Public
20 * License along with GROMACS; if not, see
21 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
22 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
24 * If you want to redistribute modifications to GROMACS, please
25 * consider that scientific software is very special. Version
26 * control is crucial - bugs must be traceable. We will be happy to
27 * consider code for inclusion in the official distribution, but
28 * derived work must not be called official GROMACS. Details are found
29 * in the README & COPYING files - if they are missing, get the
30 * official version at http://www.gromacs.org.
32 * To help us fund GROMACS development, we humbly ask that you cite
33 * the research papers on the package. Check out http://www.gromacs.org.
50 #include "gromacs/gpu_utils/gpu_utils.h"
51 #include "gromacs/gpu_utils/hostallocator.h"
52 #include "gromacs/gpu_utils/pinning.h"
53 #include "gromacs/utility/alignedallocator.h"
54 #include "gromacs/utility/exceptions.h"
55 #include "gromacs/utility/fatalerror.h"
56 #include "gromacs/utility/gmxmpi.h"
57 #include "gromacs/utility/smalloc.h"
60 #define GMX_PARALLEL_ENV_INITIALIZED 1
63 #define GMX_PARALLEL_ENV_INITIALIZED 1
65 #define GMX_PARALLEL_ENV_INITIALIZED 0
70 /* TODO: Do we still need this? Are we still planning ot use fftw + OpenMP? */
72 /* requires fftw compiled with openmp */
73 /* #define FFT5D_FFTW_THREADS (now set by cmake) */
76 #ifndef __FLT_EPSILON__
77 #define __FLT_EPSILON__ FLT_EPSILON
78 #define __DBL_EPSILON__ DBL_EPSILON
87 #include "gromacs/utility/exceptions.h"
88 #include "gromacs/utility/mutex.h"
89 /* none of the fftw3 calls, except execute(), are thread-safe, so
90 we need to serialize them with this mutex. */
91 static gmx::Mutex big_fftw_mutex
;
92 #define FFTW_LOCK try { big_fftw_mutex.lock(); } GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR
93 #define FFTW_UNLOCK try { big_fftw_mutex.unlock(); } GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR
94 #endif /* GMX_FFT_FFTW3 */
97 /* largest factor smaller than sqrt */
98 static int lfactor(int z
)
100 int i
= static_cast<int>(sqrt(static_cast<double>(z
)));
110 #if HAVE_GETTIMEOFDAY
111 #include <sys/time.h>
115 gettimeofday(&tv
, 0);
116 return tv
.tv_sec
+tv
.tv_usec
*1e-6;
126 static int vmax(const int* a
, int s
)
129 for (i
= 0; i
< s
; i
++)
140 /* NxMxK the size of the data
141 * comm communicator to use for fft5d
142 * P0 number of processor in 1st axes (can be null for automatic)
143 * lin is allocated by fft5d because size of array is only known after planning phase
144 * rlout2 is only used as intermediate buffer - only returned after allocation to reuse for back transform - should not be used by caller
146 fft5d_plan
fft5d_plan_3d(int NG
, int MG
, int KG
, MPI_Comm comm
[2], int flags
, t_complex
** rlin
, t_complex
** rlout
, t_complex
** rlout2
, t_complex
** rlout3
, int nthreads
, gmx::PinningPolicy realGridAllocationPinningPolicy
)
149 int P
[2], prank
[2], i
, t
;
152 int *N0
= nullptr, *N1
= nullptr, *M0
= nullptr, *M1
= nullptr, *K0
= nullptr, *K1
= nullptr, *oN0
= nullptr, *oN1
= nullptr, *oM0
= nullptr, *oM1
= nullptr, *oK0
= nullptr, *oK1
= nullptr;
153 int N
[3], M
[3], K
[3], pN
[3], pM
[3], pK
[3], oM
[3], oK
[3], *iNin
[3] = {nullptr}, *oNin
[3] = {nullptr}, *iNout
[3] = {nullptr}, *oNout
[3] = {nullptr};
154 int C
[3], rC
[3], nP
[2];
156 t_complex
*lin
= nullptr, *lout
= nullptr, *lout2
= nullptr, *lout3
= nullptr;
160 /* comm, prank and P are in the order of the decomposition (plan->cart is in the order of transposes) */
162 if (GMX_PARALLEL_ENV_INITIALIZED
&& comm
[0] != MPI_COMM_NULL
)
164 MPI_Comm_size(comm
[0], &P
[0]);
165 MPI_Comm_rank(comm
[0], &prank
[0]);
174 if (GMX_PARALLEL_ENV_INITIALIZED
&& comm
[1] != MPI_COMM_NULL
)
176 MPI_Comm_size(comm
[1], &P
[1]);
177 MPI_Comm_rank(comm
[1], &prank
[1]);
186 bMaster
= prank
[0] == 0 && prank
[1] == 0;
191 fprintf(debug
, "FFT5D: Using %dx%d rank grid, rank %d,%d\n",
192 P
[0], P
[1], prank
[0], prank
[1]);
199 fprintf(debug
, "FFT5D: N: %d, M: %d, K: %d, P: %dx%d, real2complex: %d, backward: %d, order yz: %d, debug %d\n",
200 NG
, MG
, KG
, P
[0], P
[1], int((flags
&FFT5D_REALCOMPLEX
) > 0), int((flags
&FFT5D_BACKWARD
) > 0), int((flags
&FFT5D_ORDER_YZ
) > 0), int((flags
&FFT5D_DEBUG
) > 0));
202 /* The check below is not correct, one prime factor 11 or 13 is ok.
203 if (fft5d_fmax(fft5d_fmax(lpfactor(NG),lpfactor(MG)),lpfactor(KG))>7) {
204 printf("WARNING: FFT very slow with prime factors larger 7\n");
205 printf("Change FFT size or in case you cannot change it look at\n");
206 printf("http://www.fftw.org/fftw3_doc/Generating-your-own-code.html\n");
211 if (NG
== 0 || MG
== 0 || KG
== 0)
215 printf("FFT5D: FATAL: Datasize cannot be zero in any dimension\n");
220 rNG
= NG
; rMG
= MG
; rKG
= KG
;
222 if (flags
&FFT5D_REALCOMPLEX
)
224 if (!(flags
&FFT5D_BACKWARD
))
230 if (!(flags
&FFT5D_ORDER_YZ
))
242 /*for transpose we need to know the size for each processor not only our own size*/
244 N0
= static_cast<int*>(malloc(P
[0]*sizeof(int))); N1
= static_cast<int*>(malloc(P
[1]*sizeof(int)));
245 M0
= static_cast<int*>(malloc(P
[0]*sizeof(int))); M1
= static_cast<int*>(malloc(P
[1]*sizeof(int)));
246 K0
= static_cast<int*>(malloc(P
[0]*sizeof(int))); K1
= static_cast<int*>(malloc(P
[1]*sizeof(int)));
247 oN0
= static_cast<int*>(malloc(P
[0]*sizeof(int))); oN1
= static_cast<int*>(malloc(P
[1]*sizeof(int)));
248 oM0
= static_cast<int*>(malloc(P
[0]*sizeof(int))); oM1
= static_cast<int*>(malloc(P
[1]*sizeof(int)));
249 oK0
= static_cast<int*>(malloc(P
[0]*sizeof(int))); oK1
= static_cast<int*>(malloc(P
[1]*sizeof(int)));
251 for (i
= 0; i
< P
[0]; i
++)
255 oN0
[i
] = i
*ceil((double)NG
/P
[0]);
256 oM0
[i
] = i
*ceil((double)MG
/P
[0]);
257 oK0
[i
] = i
*ceil((double)KG
/P
[0]);
259 oN0
[i
] = (NG
*i
)/P
[0];
260 oM0
[i
] = (MG
*i
)/P
[0];
261 oK0
[i
] = (KG
*i
)/P
[0];
264 for (i
= 0; i
< P
[1]; i
++)
267 oN1
[i
] = i
*ceil((double)NG
/P
[1]);
268 oM1
[i
] = i
*ceil((double)MG
/P
[1]);
269 oK1
[i
] = i
*ceil((double)KG
/P
[1]);
271 oN1
[i
] = (NG
*i
)/P
[1];
272 oM1
[i
] = (MG
*i
)/P
[1];
273 oK1
[i
] = (KG
*i
)/P
[1];
276 for (i
= 0; i
< P
[0]-1; i
++)
278 N0
[i
] = oN0
[i
+1]-oN0
[i
];
279 M0
[i
] = oM0
[i
+1]-oM0
[i
];
280 K0
[i
] = oK0
[i
+1]-oK0
[i
];
282 N0
[P
[0]-1] = NG
-oN0
[P
[0]-1];
283 M0
[P
[0]-1] = MG
-oM0
[P
[0]-1];
284 K0
[P
[0]-1] = KG
-oK0
[P
[0]-1];
285 for (i
= 0; i
< P
[1]-1; i
++)
287 N1
[i
] = oN1
[i
+1]-oN1
[i
];
288 M1
[i
] = oM1
[i
+1]-oM1
[i
];
289 K1
[i
] = oK1
[i
+1]-oK1
[i
];
291 N1
[P
[1]-1] = NG
-oN1
[P
[1]-1];
292 M1
[P
[1]-1] = MG
-oM1
[P
[1]-1];
293 K1
[P
[1]-1] = KG
-oK1
[P
[1]-1];
295 /* for step 1-3 the local N,M,K sizes of the transposed system
296 C: contiguous dimension, and nP: number of processor in subcommunicator
300 pM
[0] = M0
[prank
[0]];
301 oM
[0] = oM0
[prank
[0]];
302 pK
[0] = K1
[prank
[1]];
303 oK
[0] = oK1
[prank
[1]];
306 if (!(flags
&FFT5D_ORDER_YZ
))
308 N
[0] = vmax(N1
, P
[1]);
310 K
[0] = vmax(K1
, P
[1]);
311 pN
[0] = N1
[prank
[1]];
317 N
[1] = vmax(K0
, P
[0]);
318 pN
[1] = K0
[prank
[0]];
323 M
[1] = vmax(M0
, P
[0]);
324 pM
[1] = M0
[prank
[0]];
325 oM
[1] = oM0
[prank
[0]];
327 pK
[1] = N1
[prank
[1]];
328 oK
[1] = oN1
[prank
[1]];
334 M
[2] = vmax(K0
, P
[0]);
335 pM
[2] = K0
[prank
[0]];
336 oM
[2] = oK0
[prank
[0]];
337 K
[2] = vmax(N1
, P
[1]);
338 pK
[2] = N1
[prank
[1]];
339 oK
[2] = oN1
[prank
[1]];
340 free(N0
); free(oN0
); /*these are not used for this order*/
341 free(M1
); free(oM1
); /*the rest is freed in destroy*/
345 N
[0] = vmax(N0
, P
[0]);
346 M
[0] = vmax(M0
, P
[0]);
348 pN
[0] = N0
[prank
[0]];
354 N
[1] = vmax(M1
, P
[1]);
355 pN
[1] = M1
[prank
[1]];
361 pM
[1] = N0
[prank
[0]];
362 oM
[1] = oN0
[prank
[0]];
363 K
[1] = vmax(K1
, P
[1]);
364 pK
[1] = K1
[prank
[1]];
365 oK
[1] = oK1
[prank
[1]];
371 M
[2] = vmax(N0
, P
[0]);
372 pM
[2] = N0
[prank
[0]];
373 oM
[2] = oN0
[prank
[0]];
374 K
[2] = vmax(M1
, P
[1]);
375 pK
[2] = M1
[prank
[1]];
376 oK
[2] = oM1
[prank
[1]];
377 free(N1
); free(oN1
); /*these are not used for this order*/
378 free(K0
); free(oK0
); /*the rest is freed in destroy*/
380 N
[2] = pN
[2] = -1; /*not used*/
383 Difference between x-y-z regarding 2d decomposition is whether they are
384 distributed along axis 1, 2 or both
387 /* int lsize = fmax(N[0]*M[0]*K[0]*nP[0],N[1]*M[1]*K[1]*nP[1]); */
388 lsize
= std::max(N
[0]*M
[0]*K
[0]*nP
[0], std::max(N
[1]*M
[1]*K
[1]*nP
[1], C
[2]*M
[2]*K
[2]));
389 /* int lsize = fmax(C[0]*M[0]*K[0],fmax(C[1]*M[1]*K[1],C[2]*M[2]*K[2])); */
390 if (!(flags
&FFT5D_NOMALLOC
))
392 // only needed for PME GPU mixed mode
393 if (realGridAllocationPinningPolicy
== gmx::PinningPolicy::PinnedIfSupported
&&
394 GMX_GPU
== GMX_GPU_CUDA
)
396 const std::size_t numBytes
= lsize
* sizeof(t_complex
);
397 lin
= static_cast<t_complex
*>(gmx::PageAlignedAllocationPolicy::malloc(numBytes
));
398 gmx::pinBuffer(lin
, numBytes
);
402 snew_aligned(lin
, lsize
, 32);
404 snew_aligned(lout
, lsize
, 32);
407 /* We need extra transpose buffers to avoid OpenMP barriers */
408 snew_aligned(lout2
, lsize
, 32);
409 snew_aligned(lout3
, lsize
, 32);
413 /* We can reuse the buffers to avoid cache misses */
434 plan
= static_cast<fft5d_plan
>(calloc(1, sizeof(struct fft5d_plan_t
)));
439 fprintf(debug
, "Running on %d threads\n", nthreads
);
443 /* Don't add more stuff here! We have already had at least one bug because we are reimplementing
444 * the low-level FFT interface instead of using the Gromacs FFT module. If we need more
445 * generic functionality it is far better to extend the interface so we can use it for
446 * all FFT libraries instead of writing FFTW-specific code here.
449 /*if not FFTW - then we don't do a 3d plan but instead use only 1D plans */
450 /* It is possible to use the 3d plan with OMP threads - but in that case it is not allowed to be called from
451 * within a parallel region. For now deactivated. If it should be supported it has to made sure that
452 * that the execute of the 3d plan is in a master/serial block (since it contains it own parallel region)
453 * and that the 3d plan is faster than the 1d plan.
455 if ((!(flags
&FFT5D_INPLACE
)) && (!(P
[0] > 1 || P
[1] > 1)) && nthreads
== 1) /*don't do 3d plan in parallel or if in_place requested */
457 int fftwflags
= FFTW_DESTROY_INPUT
;
459 int inNG
= NG
, outMG
= MG
, outKG
= KG
;
463 fftwflags
|= (flags
& FFT5D_NOMEASURE
) ? FFTW_ESTIMATE
: FFTW_MEASURE
;
465 if (flags
&FFT5D_REALCOMPLEX
)
467 if (!(flags
&FFT5D_BACKWARD
)) /*input pointer is not complex*/
471 else /*output pointer is not complex*/
473 if (!(flags
&FFT5D_ORDER_YZ
))
484 if (!(flags
&FFT5D_BACKWARD
))
490 dims
[0].is
= inNG
*MG
; /*N M K*/
493 if (!(flags
&FFT5D_ORDER_YZ
))
495 dims
[0].os
= MG
; /*M K N*/
501 dims
[0].os
= 1; /*K N M*/
508 if (!(flags
&FFT5D_ORDER_YZ
))
518 dims
[0].os
= outMG
*KG
;
532 dims
[0].os
= outKG
*NG
;
538 #ifdef FFT5D_FFTW_THREADS
539 FFTW(plan_with_nthreads
)(nthreads
);
542 if ((flags
&FFT5D_REALCOMPLEX
) && !(flags
&FFT5D_BACKWARD
))
544 plan
->p3d
= FFTW(plan_guru_dft_r2c
)(/*rank*/ 3, dims
,
545 /*howmany*/ 0, /*howmany_dims*/ nullptr,
546 reinterpret_cast<real
*>(lin
), reinterpret_cast<FFTW(complex) *>(lout
),
547 /*flags*/ fftwflags
);
549 else if ((flags
&FFT5D_REALCOMPLEX
) && (flags
&FFT5D_BACKWARD
))
551 plan
->p3d
= FFTW(plan_guru_dft_c2r
)(/*rank*/ 3, dims
,
552 /*howmany*/ 0, /*howmany_dims*/ nullptr,
553 reinterpret_cast<FFTW(complex) *>(lin
), reinterpret_cast<real
*>(lout
),
554 /*flags*/ fftwflags
);
558 plan
->p3d
= FFTW(plan_guru_dft
)(/*rank*/ 3, dims
,
559 /*howmany*/ 0, /*howmany_dims*/ nullptr,
560 reinterpret_cast<FFTW(complex) *>(lin
), reinterpret_cast<FFTW(complex) *>(lout
),
561 /*sign*/ (flags
&FFT5D_BACKWARD
) ? 1 : -1, /*flags*/ fftwflags
);
564 #ifdef FFT5D_FFTW_THREADS
565 FFTW(plan_with_nthreads
)(1);
570 if (!plan
->p3d
) /* for decomposition and if 3d plan did not work */
572 #endif /* GMX_FFT_FFTW3 */
573 for (s
= 0; s
< 3; s
++)
577 fprintf(debug
, "FFT5D: Plan s %d rC %d M %d pK %d C %d lsize %d\n",
578 s
, rC
[s
], M
[s
], pK
[s
], C
[s
], lsize
);
580 plan
->p1d
[s
] = static_cast<gmx_fft_t
*>(malloc(sizeof(gmx_fft_t
)*nthreads
));
582 /* Make sure that the init routines are only called by one thread at a time and in order
583 (later is only important to not confuse valgrind)
585 #pragma omp parallel for num_threads(nthreads) schedule(static) ordered
586 for (t
= 0; t
< nthreads
; t
++)
592 int tsize
= ((t
+1)*pM
[s
]*pK
[s
]/nthreads
)-(t
*pM
[s
]*pK
[s
]/nthreads
);
594 if ((flags
&FFT5D_REALCOMPLEX
) && ((!(flags
&FFT5D_BACKWARD
) && s
== 0) || ((flags
&FFT5D_BACKWARD
) && s
== 2)))
596 gmx_fft_init_many_1d_real( &plan
->p1d
[s
][t
], rC
[s
], tsize
, (flags
&FFT5D_NOMEASURE
) ? GMX_FFT_FLAG_CONSERVATIVE
: 0 );
600 gmx_fft_init_many_1d ( &plan
->p1d
[s
][t
], C
[s
], tsize
, (flags
&FFT5D_NOMEASURE
) ? GMX_FFT_FLAG_CONSERVATIVE
: 0 );
603 GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR
;
611 if ((flags
&FFT5D_ORDER_YZ
)) /*plan->cart is in the order of transposes */
613 plan
->cart
[0] = comm
[0]; plan
->cart
[1] = comm
[1];
617 plan
->cart
[1] = comm
[0]; plan
->cart
[0] = comm
[1];
619 #ifdef FFT5D_MPI_TRANSPOSE
621 for (s
= 0; s
< 2; s
++)
623 if ((s
== 0 && !(flags
&FFT5D_ORDER_YZ
)) || (s
== 1 && (flags
&FFT5D_ORDER_YZ
)))
625 plan
->mpip
[s
] = FFTW(mpi_plan_many_transpose
)(nP
[s
], nP
[s
], N
[s
]*K
[s
]*pM
[s
]*2, 1, 1, (real
*)lout2
, (real
*)lout3
, plan
->cart
[s
], FFTW_PATIENT
);
629 plan
->mpip
[s
] = FFTW(mpi_plan_many_transpose
)(nP
[s
], nP
[s
], N
[s
]*pK
[s
]*M
[s
]*2, 1, 1, (real
*)lout2
, (real
*)lout3
, plan
->cart
[s
], FFTW_PATIENT
);
641 plan
->NG
= NG
; plan
->MG
= MG
; plan
->KG
= KG
;
643 for (s
= 0; s
< 3; s
++)
645 plan
->N
[s
] = N
[s
]; plan
->M
[s
] = M
[s
]; plan
->K
[s
] = K
[s
]; plan
->pN
[s
] = pN
[s
]; plan
->pM
[s
] = pM
[s
]; plan
->pK
[s
] = pK
[s
];
646 plan
->oM
[s
] = oM
[s
]; plan
->oK
[s
] = oK
[s
];
647 plan
->C
[s
] = C
[s
]; plan
->rC
[s
] = rC
[s
];
648 plan
->iNin
[s
] = iNin
[s
]; plan
->oNin
[s
] = oNin
[s
]; plan
->iNout
[s
] = iNout
[s
]; plan
->oNout
[s
] = oNout
[s
];
650 for (s
= 0; s
< 2; s
++)
652 plan
->P
[s
] = nP
[s
]; plan
->coor
[s
] = prank
[s
];
655 /* plan->fftorder=fftorder;
656 plan->direction=direction;
657 plan->realcomplex=realcomplex;
660 plan
->nthreads
= nthreads
;
661 plan
->pinningPolicy
= realGridAllocationPinningPolicy
;
681 /*here x,y,z and N,M,K is in rotated coordinate system!!
682 x (and N) is mayor (consecutive) dimension, y (M) middle and z (K) major
683 maxN,maxM,maxK is max size of local data
684 pN, pM, pK is local size specific to current processor (only different to max if not divisible)
685 NG, MG, KG is size of global data*/
686 static void splitaxes(t_complex
* lout
, const t_complex
* lin
,
687 int maxN
, int maxM
, int maxK
, int pM
,
688 int P
, int NG
, const int *N
, const int* oN
, int starty
, int startz
, int endy
, int endz
)
691 int in_i
, out_i
, in_z
, out_z
, in_y
, out_y
;
694 for (z
= startz
; z
< endz
+1; z
++) /*3. z l*/
715 for (i
= 0; i
< P
; i
++) /*index cube along long axis*/
717 out_i
= out_z
+ i
*maxN
*maxM
*maxK
;
719 for (y
= s_y
; y
< e_y
; y
++) /*2. y k*/
721 out_y
= out_i
+ y
*maxN
;
723 for (x
= 0; x
< N
[i
]; x
++) /*1. x j*/
725 lout
[out_y
+x
] = lin
[in_y
+x
]; /*in=z*NG*pM+oN[i]+y*NG+x*/
726 /*after split important that each processor chunk i has size maxN*maxM*maxK and thus being the same size*/
727 /*before split data contiguos - thus if different processor get different amount oN is different*/
734 /*make axis contiguous again (after AllToAll) and also do local transpose*/
735 /*transpose mayor and major dimension
737 the major, middle, minor order is only correct for x,y,z (N,M,K) for the input
738 N,M,K local dimensions
740 static void joinAxesTrans13(t_complex
* lout
, const t_complex
* lin
,
741 int maxN
, int maxM
, int maxK
, int pM
,
742 int P
, int KG
, const int* K
, const int* oK
, int starty
, int startx
, int endy
, int endx
)
745 int out_i
, in_i
, out_x
, in_x
, out_z
, in_z
;
748 for (x
= startx
; x
< endx
+1; x
++) /*1.j*/
770 for (i
= 0; i
< P
; i
++) /*index cube along long axis*/
772 out_i
= out_x
+ oK
[i
];
773 in_i
= in_x
+ i
*maxM
*maxN
*maxK
;
774 for (z
= 0; z
< K
[i
]; z
++) /*3.l*/
777 in_z
= in_i
+ z
*maxM
*maxN
;
778 for (y
= s_y
; y
< e_y
; y
++) /*2.k*/
780 lout
[out_z
+y
*KG
] = lin
[in_z
+y
*maxN
]; /*out=x*KG*pM+oK[i]+z+y*KG*/
787 /*make axis contiguous again (after AllToAll) and also do local transpose
788 tranpose mayor and middle dimension
790 the minor, middle, major order is only correct for x,y,z (N,M,K) for the input
793 static void joinAxesTrans12(t_complex
* lout
, const t_complex
* lin
, int maxN
, int maxM
, int maxK
, int pN
,
794 int P
, int MG
, const int* M
, const int* oM
, int startx
, int startz
, int endx
, int endz
)
797 int out_i
, in_i
, out_z
, in_z
, out_x
, in_x
;
800 for (z
= startz
; z
< endz
+1; z
++)
821 for (i
= 0; i
< P
; i
++) /*index cube along long axis*/
823 out_i
= out_z
+ oM
[i
];
824 in_i
= in_z
+ i
*maxM
*maxN
*maxK
;
825 for (x
= s_x
; x
< e_x
; x
++)
827 out_x
= out_i
+ x
*MG
;
829 for (y
= 0; y
< M
[i
]; y
++)
831 lout
[out_x
+y
] = lin
[in_x
+y
*maxN
]; /*out=z*MG*pN+oM[i]+x*MG+y*/
839 static void rotate_offsets(int x
[])
850 /*compute the offset to compare or print transposed local data in original input coordinates
851 xs matrix dimension size, xl dimension length, xc decomposition offset
852 s: step in computation = number of transposes*/
853 static void compute_offsets(fft5d_plan plan
, int xs
[], int xl
[], int xc
[], int NG
[], int s
)
855 /* int direction = plan->direction;
856 int fftorder = plan->fftorder;*/
860 int *pM
= plan
->pM
, *pK
= plan
->pK
, *oM
= plan
->oM
, *oK
= plan
->oK
,
861 *C
= plan
->C
, *rC
= plan
->rC
;
863 NG
[0] = plan
->NG
; NG
[1] = plan
->MG
; NG
[2] = plan
->KG
;
865 if (!(plan
->flags
&FFT5D_ORDER_YZ
))
869 case 0: o
= XYZ
; break;
870 case 1: o
= ZYX
; break;
871 case 2: o
= YZX
; break;
879 case 0: o
= XYZ
; break;
880 case 1: o
= YXZ
; break;
881 case 2: o
= ZXY
; break;
888 case XYZ
: pos
[0] = 1; pos
[1] = 2; pos
[2] = 3; break;
889 case XZY
: pos
[0] = 1; pos
[1] = 3; pos
[2] = 2; break;
890 case YXZ
: pos
[0] = 2; pos
[1] = 1; pos
[2] = 3; break;
891 case YZX
: pos
[0] = 3; pos
[1] = 1; pos
[2] = 2; break;
892 case ZXY
: pos
[0] = 2; pos
[1] = 3; pos
[2] = 1; break;
893 case ZYX
: pos
[0] = 3; pos
[1] = 2; pos
[2] = 1; break;
895 /*if (debug) printf("pos: %d %d %d\n",pos[0],pos[1],pos[2]);*/
897 /*xs, xl give dimension size and data length in local transposed coordinate system
898 for 0(/1/2): x(/y/z) in original coordinate system*/
899 for (i
= 0; i
< 3; i
++)
903 case 1: xs
[i
] = 1; xc
[i
] = 0; xl
[i
] = C
[s
]; break;
904 case 2: xs
[i
] = C
[s
]; xc
[i
] = oM
[s
]; xl
[i
] = pM
[s
]; break;
905 case 3: xs
[i
] = C
[s
]*pM
[s
]; xc
[i
] = oK
[s
]; xl
[i
] = pK
[s
]; break;
908 /*input order is different for test program to match FFTW order
909 (important for complex to real)*/
910 if (plan
->flags
&FFT5D_BACKWARD
)
916 if (plan
->flags
&FFT5D_ORDER_YZ
)
924 if ((plan
->flags
&FFT5D_REALCOMPLEX
) && ((!(plan
->flags
&FFT5D_BACKWARD
) && s
== 0) || ((plan
->flags
&FFT5D_BACKWARD
) && s
== 2)))
930 static void print_localdata(const t_complex
* lin
, const char* txt
, int s
, fft5d_plan plan
)
933 int *coor
= plan
->coor
;
934 int xs
[3], xl
[3], xc
[3], NG
[3];
935 int ll
= (plan
->flags
&FFT5D_REALCOMPLEX
) ? 1 : 2;
936 compute_offsets(plan
, xs
, xl
, xc
, NG
, s
);
937 fprintf(debug
, txt
, coor
[0], coor
[1]);
938 /*printf("xs: %d %d %d, xl: %d %d %d\n",xs[0],xs[1],xs[2],xl[0],xl[1],xl[2]);*/
939 for (z
= 0; z
< xl
[2]; z
++)
941 for (y
= 0; y
< xl
[1]; y
++)
943 fprintf(debug
, "%d %d: ", coor
[0], coor
[1]);
944 for (x
= 0; x
< xl
[0]; x
++)
946 for (l
= 0; l
< ll
; l
++)
948 fprintf(debug
, "%f ", reinterpret_cast<const real
*>(lin
)[(z
*xs
[2]+y
*xs
[1])*2+(x
*xs
[0])*ll
+l
]);
952 fprintf(debug
, "\n");
957 void fft5d_execute(fft5d_plan plan
, int thread
, fft5d_time times
)
959 t_complex
*lin
= plan
->lin
;
960 t_complex
*lout
= plan
->lout
;
961 t_complex
*lout2
= plan
->lout2
;
962 t_complex
*lout3
= plan
->lout3
;
963 t_complex
*fftout
, *joinin
;
965 gmx_fft_t
**p1d
= plan
->p1d
;
966 #ifdef FFT5D_MPI_TRANSPOSE
967 FFTW(plan
) *mpip
= plan
->mpip
;
970 MPI_Comm
*cart
= plan
->cart
;
973 double time_fft
= 0, time_local
= 0, time_mpi
[2] = {0}, time
= 0;
975 int *N
= plan
->N
, *M
= plan
->M
, *K
= plan
->K
, *pN
= plan
->pN
, *pM
= plan
->pM
, *pK
= plan
->pK
,
976 *C
= plan
->C
, *P
= plan
->P
, **iNin
= plan
->iNin
, **oNin
= plan
->oNin
, **iNout
= plan
->iNout
, **oNout
= plan
->oNout
;
977 int s
= 0, tstart
, tend
, bParallelDim
;
991 FFTW(execute
)(plan
->p3d
);
995 times
->fft
+= MPI_Wtime()-time
;
1006 if ((plan
->flags
&FFT5D_DEBUG
) && thread
== 0)
1008 print_localdata(lin
, "%d %d: copy in lin\n", s
, plan
);
1011 for (s
= 0; s
< 2; s
++) /*loop over first two FFT steps (corner rotations)*/
1015 if (GMX_PARALLEL_ENV_INITIALIZED
&& cart
[s
] != MPI_COMM_NULL
&& P
[s
] > 1)
1025 /* ---------- START FFT ------------ */
1027 if (times
!= 0 && thread
== 0)
1033 if (bParallelDim
|| plan
->nthreads
== 1)
1049 tstart
= (thread
*pM
[s
]*pK
[s
]/plan
->nthreads
)*C
[s
];
1050 if ((plan
->flags
&FFT5D_REALCOMPLEX
) && !(plan
->flags
&FFT5D_BACKWARD
) && s
== 0)
1052 gmx_fft_many_1d_real(p1d
[s
][thread
], (plan
->flags
&FFT5D_BACKWARD
) ? GMX_FFT_COMPLEX_TO_REAL
: GMX_FFT_REAL_TO_COMPLEX
, lin
+tstart
, fftout
+tstart
);
1056 gmx_fft_many_1d( p1d
[s
][thread
], (plan
->flags
&FFT5D_BACKWARD
) ? GMX_FFT_BACKWARD
: GMX_FFT_FORWARD
, lin
+tstart
, fftout
+tstart
);
1061 if (times
!= NULL
&& thread
== 0)
1063 time_fft
+= MPI_Wtime()-time
;
1066 if ((plan
->flags
&FFT5D_DEBUG
) && thread
== 0)
1068 print_localdata(lout
, "%d %d: FFT %d\n", s
, plan
);
1070 /* ---------- END FFT ------------ */
1072 /* ---------- START SPLIT + TRANSPOSE------------ (if parallel in in this dimension)*/
1076 if (times
!= NULL
&& thread
== 0)
1083 1. (most outer) axes (x) is split into P[s] parts of size N[s]
1087 tend
= ((thread
+1)*pM
[s
]*pK
[s
]/plan
->nthreads
);
1089 splitaxes(lout2
, lout
, N
[s
], M
[s
], K
[s
], pM
[s
], P
[s
], C
[s
], iNout
[s
], oNout
[s
], tstart
%pM
[s
], tstart
/pM
[s
], tend
%pM
[s
], tend
/pM
[s
]);
1091 #pragma omp barrier /*barrier required before AllToAll (all input has to be their) - before timing to make timing more acurate*/
1093 if (times
!= NULL
&& thread
== 0)
1095 time_local
+= MPI_Wtime()-time
;
1099 /* ---------- END SPLIT , START TRANSPOSE------------ */
1109 wallcycle_start(times
, ewcPME_FFTCOMM
);
1111 #ifdef FFT5D_MPI_TRANSPOSE
1112 FFTW(execute
)(mpip
[s
]);
1115 if ((s
== 0 && !(plan
->flags
&FFT5D_ORDER_YZ
)) || (s
== 1 && (plan
->flags
&FFT5D_ORDER_YZ
)))
1117 MPI_Alltoall(reinterpret_cast<real
*>(lout2
), N
[s
]*pM
[s
]*K
[s
]*sizeof(t_complex
)/sizeof(real
), GMX_MPI_REAL
, reinterpret_cast<real
*>(lout3
), N
[s
]*pM
[s
]*K
[s
]*sizeof(t_complex
)/sizeof(real
), GMX_MPI_REAL
, cart
[s
]);
1121 MPI_Alltoall(reinterpret_cast<real
*>(lout2
), N
[s
]*M
[s
]*pK
[s
]*sizeof(t_complex
)/sizeof(real
), GMX_MPI_REAL
, reinterpret_cast<real
*>(lout3
), N
[s
]*M
[s
]*pK
[s
]*sizeof(t_complex
)/sizeof(real
), GMX_MPI_REAL
, cart
[s
]);
1124 gmx_incons("fft5d MPI call without MPI configuration");
1126 #endif /*FFT5D_MPI_TRANSPOSE*/
1130 time_mpi
[s
] = MPI_Wtime()-time
;
1133 wallcycle_stop(times
, ewcPME_FFTCOMM
);
1137 #pragma omp barrier /*both needed for parallel and non-parallel dimension (either have to wait on data from AlltoAll or from last FFT*/
1139 /* ---------- END SPLIT + TRANSPOSE------------ */
1141 /* ---------- START JOIN ------------ */
1143 if (times
!= NULL
&& thread
== 0)
1157 /*bring back in matrix form
1158 thus make new 1. axes contiguos
1159 also local transpose 1 and 2/3
1160 runs on thread used for following FFT (thus needing a barrier before but not afterwards)
1162 if ((s
== 0 && !(plan
->flags
&FFT5D_ORDER_YZ
)) || (s
== 1 && (plan
->flags
&FFT5D_ORDER_YZ
)))
1166 tstart
= ( thread
*pM
[s
]*pN
[s
]/plan
->nthreads
);
1167 tend
= ((thread
+1)*pM
[s
]*pN
[s
]/plan
->nthreads
);
1168 joinAxesTrans13(lin
, joinin
, N
[s
], pM
[s
], K
[s
], pM
[s
], P
[s
], C
[s
+1], iNin
[s
+1], oNin
[s
+1], tstart
%pM
[s
], tstart
/pM
[s
], tend
%pM
[s
], tend
/pM
[s
]);
1175 tstart
= ( thread
*pK
[s
]*pN
[s
]/plan
->nthreads
);
1176 tend
= ((thread
+1)*pK
[s
]*pN
[s
]/plan
->nthreads
);
1177 joinAxesTrans12(lin
, joinin
, N
[s
], M
[s
], pK
[s
], pN
[s
], P
[s
], C
[s
+1], iNin
[s
+1], oNin
[s
+1], tstart
%pN
[s
], tstart
/pN
[s
], tend
%pN
[s
], tend
/pN
[s
]);
1182 if (times
!= NULL
&& thread
== 0)
1184 time_local
+= MPI_Wtime()-time
;
1187 if ((plan
->flags
&FFT5D_DEBUG
) && thread
== 0)
1189 print_localdata(lin
, "%d %d: tranposed %d\n", s
+1, plan
);
1191 /* ---------- END JOIN ------------ */
1193 /*if (debug) print_localdata(lin, "%d %d: transposed x-z\n", N1, M0, K, ZYX, coor);*/
1194 } /* for(s=0;s<2;s++) */
1196 if (times
!= NULL
&& thread
== 0)
1202 if (plan
->flags
&FFT5D_INPLACE
)
1204 lout
= lin
; /*in place currently not supported*/
1207 /* ----------- FFT ----------- */
1208 tstart
= (thread
*pM
[s
]*pK
[s
]/plan
->nthreads
)*C
[s
];
1209 if ((plan
->flags
&FFT5D_REALCOMPLEX
) && (plan
->flags
&FFT5D_BACKWARD
))
1211 gmx_fft_many_1d_real(p1d
[s
][thread
], (plan
->flags
&FFT5D_BACKWARD
) ? GMX_FFT_COMPLEX_TO_REAL
: GMX_FFT_REAL_TO_COMPLEX
, lin
+tstart
, lout
+tstart
);
1215 gmx_fft_many_1d( p1d
[s
][thread
], (plan
->flags
&FFT5D_BACKWARD
) ? GMX_FFT_BACKWARD
: GMX_FFT_FORWARD
, lin
+tstart
, lout
+tstart
);
1217 /* ------------ END FFT ---------*/
1220 if (times
!= NULL
&& thread
== 0)
1222 time_fft
+= MPI_Wtime()-time
;
1224 times
->fft
+= time_fft
;
1225 times
->local
+= time_local
;
1226 times
->mpi2
+= time_mpi
[1];
1227 times
->mpi1
+= time_mpi
[0];
1231 if ((plan
->flags
&FFT5D_DEBUG
) && thread
== 0)
1233 print_localdata(lout
, "%d %d: FFT %d\n", s
, plan
);
1237 void fft5d_destroy(fft5d_plan plan
)
1241 for (s
= 0; s
< 3; s
++)
1245 for (t
= 0; t
< plan
->nthreads
; t
++)
1247 gmx_many_fft_destroy(plan
->p1d
[s
][t
]);
1253 free(plan
->iNin
[s
]);
1254 plan
->iNin
[s
] = nullptr;
1258 free(plan
->oNin
[s
]);
1259 plan
->oNin
[s
] = nullptr;
1263 free(plan
->iNout
[s
]);
1264 plan
->iNout
[s
] = nullptr;
1268 free(plan
->oNout
[s
]);
1269 plan
->oNout
[s
] = nullptr;
1274 #ifdef FFT5D_MPI_TRANSPOS
1275 for (s
= 0; s
< 2; s
++)
1277 FFTW(destroy_plan
)(plan
->mpip
[s
]);
1279 #endif /* FFT5D_MPI_TRANSPOS */
1282 FFTW(destroy_plan
)(plan
->p3d
);
1285 #endif /* GMX_FFT_FFTW3 */
1287 if (!(plan
->flags
&FFT5D_NOMALLOC
))
1289 // only needed for PME GPU mixed mode
1290 if (plan
->pinningPolicy
== gmx::PinningPolicy::PinnedIfSupported
&&
1291 isHostMemoryPinned(plan
->lin
))
1293 gmx::unpinBuffer(plan
->lin
);
1295 sfree_aligned(plan
->lin
);
1296 sfree_aligned(plan
->lout
);
1297 if (plan
->nthreads
> 1)
1299 sfree_aligned(plan
->lout2
);
1300 sfree_aligned(plan
->lout3
);
1304 #ifdef FFT5D_THREADS
1305 #ifdef FFT5D_FFTW_THREADS
1306 /*FFTW(cleanup_threads)();*/
1313 /*Is this better than direct access of plan? enough data?
1314 here 0,1 reference divided by which processor grid dimension (not FFT step!)*/
1315 void fft5d_local_size(fft5d_plan plan
, int* N1
, int* M0
, int* K0
, int* K1
, int** coor
)
1326 /*same as fft5d_plan_3d but with cartesian coordinator and automatic splitting
1327 of processor dimensions*/
1328 fft5d_plan
fft5d_plan_3d_cart(int NG
, int MG
, int KG
, MPI_Comm comm
, int P0
, int flags
, t_complex
** rlin
, t_complex
** rlout
, t_complex
** rlout2
, t_complex
** rlout3
, int nthreads
)
1330 MPI_Comm cart
[2] = {MPI_COMM_NULL
, MPI_COMM_NULL
};
1332 int size
= 1, prank
= 0;
1335 int wrap
[] = {0, 0};
1337 int rdim1
[] = {0, 1}, rdim2
[] = {1, 0};
1339 MPI_Comm_size(comm
, &size
);
1340 MPI_Comm_rank(comm
, &prank
);
1350 printf("FFT5D: WARNING: Number of ranks %d not evenly divisible by %d\n", size
, P0
);
1355 P
[0] = P0
; P
[1] = size
/P0
; /*number of processors in the two dimensions*/
1357 /*Difference between x-y-z regarding 2d decomposition is whether they are
1358 distributed along axis 1, 2 or both*/
1360 MPI_Cart_create(comm
, 2, P
, wrap
, 1, &gcart
); /*parameter 4: value 1: reorder*/
1361 MPI_Cart_get(gcart
, 2, P
, wrap
, coor
);
1362 MPI_Cart_sub(gcart
, rdim1
, &cart
[0]);
1363 MPI_Cart_sub(gcart
, rdim2
, &cart
[1]);
1368 return fft5d_plan_3d(NG
, MG
, KG
, cart
, flags
, rlin
, rlout
, rlout2
, rlout3
, nthreads
);
1373 /*prints in original coordinate system of data (as the input to FFT)*/
1374 void fft5d_compare_data(const t_complex
* lin
, const t_complex
* in
, fft5d_plan plan
, int bothLocal
, int normalize
)
1376 int xs
[3], xl
[3], xc
[3], NG
[3];
1378 int *coor
= plan
->coor
;
1379 int ll
= 2; /*compare ll values per element (has to be 2 for complex)*/
1380 if ((plan
->flags
&FFT5D_REALCOMPLEX
) && (plan
->flags
&FFT5D_BACKWARD
))
1385 compute_offsets(plan
, xs
, xl
, xc
, NG
, 2);
1386 if (plan
->flags
&FFT5D_DEBUG
)
1388 printf("Compare2\n");
1390 for (z
= 0; z
< xl
[2]; z
++)
1392 for (y
= 0; y
< xl
[1]; y
++)
1394 if (plan
->flags
&FFT5D_DEBUG
)
1396 printf("%d %d: ", coor
[0], coor
[1]);
1398 for (x
= 0; x
< xl
[0]; x
++)
1400 for (l
= 0; l
< ll
; l
++) /*loop over real/complex parts*/
1403 a
= reinterpret_cast<const real
*>(lin
)[(z
*xs
[2]+y
*xs
[1])*2+x
*xs
[0]*ll
+l
];
1406 a
/= plan
->rC
[0]*plan
->rC
[1]*plan
->rC
[2];
1410 b
= reinterpret_cast<const real
*>(in
)[((z
+xc
[2])*NG
[0]*NG
[1]+(y
+xc
[1])*NG
[0])*2+(x
+xc
[0])*ll
+l
];
1414 b
= reinterpret_cast<const real
*>(in
)[(z
*xs
[2]+y
*xs
[1])*2+x
*xs
[0]*ll
+l
];
1416 if (plan
->flags
&FFT5D_DEBUG
)
1418 printf("%f %f, ", a
, b
);
1422 if (std::fabs(a
-b
) > 2*NG
[0]*NG
[1]*NG
[2]*GMX_REAL_EPS
)
1424 printf("result incorrect on %d,%d at %d,%d,%d: FFT5D:%f reference:%f\n", coor
[0], coor
[1], x
, y
, z
, a
, b
);
1426 /* assert(fabs(a-b)<2*NG[0]*NG[1]*NG[2]*GMX_REAL_EPS);*/
1429 if (plan
->flags
&FFT5D_DEBUG
)
1434 if (plan
->flags
&FFT5D_DEBUG
)