2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 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.
37 * \brief Implements PME OpenCL force gathering kernel.
38 * When including this and other PME OpenCL kernel files, plenty of common
39 * constants/macros are expected to be defined (such as "order" which is PME interpolation order).
40 * For details, please see how pme-program.cl is compiled in pme-gpu-program-impl-ocl.cpp.
42 * This file's kernels specifically expect the following definitions:
44 * - atomsPerBlock which expresses how many atoms are processed by a single work group
45 * - order which is a PME interpolation order
46 * - overwriteForces must evaluate to either true or false to specify whether the kernel
47 * overwrites or reduces into the forces buffer
48 * - wrapX and wrapY must evaluate to either true or false to specify whether the grid overlap
49 * in dimension X/Y is to be used
51 * \author Aleksei Iupinov <a.yupinov@gmail.com>
54 #include "pme-gpu-types.h"
55 #include "pme-gpu-utils.clh"
57 #ifndef COMPILE_GATHER_HELPERS_ONCE
58 #define COMPILE_GATHER_HELPERS_ONCE
61 * Unrolls the dynamic index accesses to the constant grid sizes to avoid local memory operations.
63 inline float read_grid_size(const float *realGridSizeFP,
68 case XX: return realGridSizeFP[XX];
69 case YY: return realGridSizeFP[YY];
70 case ZZ: return realGridSizeFP[ZZ];
76 /*! \brief Reduce the partial force contributions.
78 * FIXME: this reduction should be simplified and improved, it does 3x16 force component
79 * reduction per 16 threads so no extra shared mem should be needed for intermediates
80 * or passing results back.
82 * \param[out] sm_forces Local memory array with the output forces (rvec).
83 * \param[in] atomIndexLocal Local atom index
84 * \param[in] splineIndex Spline index
85 * \param[in] lineIndex Line index (same as threadLocalId)
86 * \param[in] realGridSizeFP Local grid size constant
87 * \param[in] fx Input force partial component X
88 * \param[in] fy Input force partial component Y
89 * \param[in] fz Input force partial component Z
90 * \param[in,out] sm_forceReduction Reduction working buffer
91 * \param[in] sm_forceTemp Convenience pointers into \p sm_forceReduction
93 inline void reduce_atom_forces(__local float * __restrict__ sm_forces,
94 const int atomIndexLocal,
95 const int splineIndex,
97 const float *realGridSizeFP,
101 __local float * __restrict__ sm_forceReduction,
102 __local float ** __restrict__ sm_forceTemp
106 // TODO: implement AMD intrinsics reduction, like with shuffles in CUDA version. #2514
108 /* Number of data components and threads for a single atom */
109 #define atomDataSize threadsPerAtom
110 // We use blockSize local memory elements to read fx, or fy, or fz, and then reduce them to fit into smemPerDim elements
111 // All those guys are defines and not consts, because they go into the local memory array size.
112 #define blockSize (atomsPerBlock * atomDataSize)
113 #define smemPerDim warp_size
114 #define smemReserved ((DIM - 1) * smemPerDim)
116 const int numWarps = blockSize / smemPerDim;
117 const int minStride = max(1, atomDataSize / numWarps);
120 for (int dimIndex = 0; dimIndex < DIM; dimIndex++)
122 int elementIndex = smemReserved + lineIndex;
123 // Store input force contributions
124 sm_forceReduction[elementIndex] = (dimIndex == XX) ? fx : (dimIndex == YY) ? fy : fz;
125 /* This barrier was not needed in CUDA. Different OpenCL compilers might have different ideas
126 * about #pragma unroll, though. OpenCL 2 has _attribute__((opencl_unroll_hint)).
129 barrier(CLK_LOCAL_MEM_FENCE);
131 // Reduce to fit into smemPerDim (warp size)
133 for (int redStride = atomDataSize >> 1; redStride > minStride; redStride >>= 1)
135 if (splineIndex < redStride)
137 sm_forceReduction[elementIndex] += sm_forceReduction[elementIndex + redStride];
140 barrier(CLK_LOCAL_MEM_FENCE);
141 // Last iteration - packing everything to be nearby, storing convenience pointer
142 sm_forceTemp[dimIndex] = sm_forceReduction + dimIndex * smemPerDim;
143 int redStride = minStride;
144 if (splineIndex < redStride)
146 const int packedIndex = atomIndexLocal * redStride + splineIndex;
147 sm_forceTemp[dimIndex][packedIndex] = sm_forceReduction[elementIndex] + sm_forceReduction[elementIndex + redStride];
151 barrier(CLK_LOCAL_MEM_FENCE);
153 assert ((blockSize / warp_size) >= DIM);
155 const int warpIndex = lineIndex / warp_size;
156 const int dimIndex = warpIndex;
158 // First 3 warps can now process 1 dimension each
161 int sourceIndex = lineIndex % warp_size;
163 for (int redStride = minStride >> 1; redStride > 1; redStride >>= 1)
165 if (!(splineIndex & redStride))
167 sm_forceTemp[dimIndex][sourceIndex] += sm_forceTemp[dimIndex][sourceIndex + redStride];
171 const float n = read_grid_size(realGridSizeFP, dimIndex);
173 const int atomIndex = sourceIndex / minStride;
174 if (sourceIndex == minStride * atomIndex)
176 sm_forces[atomIndex * DIM + dimIndex] = (sm_forceTemp[dimIndex][sourceIndex] + sm_forceTemp[dimIndex][sourceIndex + 1]) * n;
181 #endif //COMPILE_GATHER_HELPERS_ONCE
184 * An OpenCL kernel which gathers the atom forces from the grid.
185 * The grid is assumed to be wrapped in dimension Z.
186 * Please see the file description for additional defines which this kernel expects.
188 * \param[in] kernelParams All the PME GPU data.
189 * \param[in] gm_coefficients Atom charges/coefficients.
190 * \param[in] gm_grid Global 3D grid.
191 * \param[in] gm_theta Atom spline parameter values
192 * \param[in] gm_dtheta Atom spline parameter derivatives
193 * \param[in] gm_gridlineIndices Atom gridline indices (ivec)
194 * \param[in,out] gm_forces Atom forces (rvec)
196 __attribute__((reqd_work_group_size(order, order, atomsPerBlock)))
197 __kernel void CUSTOMIZED_KERNEL_NAME(pme_gather_kernel)(const struct PmeOpenCLKernelParams kernelParams,
198 __global const float * __restrict__ gm_coefficients,
199 __global const float * __restrict__ gm_grid,
200 __global const float * __restrict__ gm_theta,
201 __global const float * __restrict__ gm_dtheta,
202 __global const int * __restrict__ gm_gridlineIndices,
203 __global float * __restrict__ gm_forces
206 /* These are the atom indices - for the shared and global memory */
207 const int atomIndexLocal = get_local_id(ZZ);
208 const int atomIndexOffset = get_group_id(XX) * atomsPerBlock;
209 const int atomIndexGlobal = atomIndexOffset + atomIndexLocal;
211 /* Some sizes which are defines and not consts because they go into the array size */
212 #define blockSize (atomsPerBlock * atomDataSize)
213 assert(blockSize == (get_local_size(0) * get_local_size(1) * get_local_size(2)));
214 #define smemPerDim warp_size
215 #define smemReserved ((DIM - 1) * smemPerDim)
216 #define totalSharedMemory (smemReserved + blockSize)
217 #define gridlineIndicesSize (atomsPerBlock * DIM)
218 #define splineParamsSize (atomsPerBlock * DIM * order)
220 __local int sm_gridlineIndices[gridlineIndicesSize];
221 __local float2 sm_splineParams[splineParamsSize]; /* Theta/dtheta pairs as .x/.y */
223 /* Spline Y/Z coordinates */
224 const int ithy = get_local_id(YY);
225 const int ithz = get_local_id(XX);
227 const int threadLocalId = (get_local_id(2) * get_local_size(1) + get_local_id(1)) * get_local_size(0) + get_local_id(0);
229 /* These are the spline contribution indices in shared memory */
230 const int splineIndex = (get_local_id(1) * get_local_size(0) + get_local_id(0)); /* Relative to the current particle , 0..15 for order 4 */
231 const int lineIndex = threadLocalId; /* And to all the block's particles */
233 /* Staging the atom gridline indices, DIM * atomsPerBlock threads */
234 const int localGridlineIndicesIndex = threadLocalId;
235 const int globalGridlineIndicesIndex = get_group_id(XX) * gridlineIndicesSize + localGridlineIndicesIndex;
236 const int globalCheckIndices = pme_gpu_check_atom_data_index(globalGridlineIndicesIndex, kernelParams.atoms.nAtoms * DIM);
237 if ((localGridlineIndicesIndex < gridlineIndicesSize) & globalCheckIndices)
239 sm_gridlineIndices[localGridlineIndicesIndex] = gm_gridlineIndices[globalGridlineIndicesIndex];
240 assert(sm_gridlineIndices[localGridlineIndicesIndex] >= 0);
242 /* Staging the spline parameters, DIM * order * atomsPerBlock threads */
243 const int localSplineParamsIndex = threadLocalId;
244 const int globalSplineParamsIndex = get_group_id(XX) * splineParamsSize + localSplineParamsIndex;
245 const int globalCheckSplineParams = pme_gpu_check_atom_data_index(globalSplineParamsIndex, kernelParams.atoms.nAtoms * DIM * order);
246 if ((localSplineParamsIndex < splineParamsSize) && globalCheckSplineParams)
248 sm_splineParams[localSplineParamsIndex].x = gm_theta[globalSplineParamsIndex];
249 sm_splineParams[localSplineParamsIndex].y = gm_dtheta[globalSplineParamsIndex];
250 assert(isfinite(sm_splineParams[localSplineParamsIndex].x));
251 assert(isfinite(sm_splineParams[localSplineParamsIndex].y));
253 barrier(CLK_LOCAL_MEM_FENCE);
259 const int globalCheck = pme_gpu_check_atom_data_index(atomIndexGlobal, kernelParams.atoms.nAtoms);
260 const int chargeCheck = pme_gpu_check_atom_charge(gm_coefficients[atomIndexGlobal]);
262 if (chargeCheck & globalCheck)
264 const int nx = kernelParams.grid.realGridSize[XX];
265 const int ny = kernelParams.grid.realGridSize[YY];
266 const int nz = kernelParams.grid.realGridSize[ZZ];
267 const int pny = kernelParams.grid.realGridSizePadded[YY];
268 const int pnz = kernelParams.grid.realGridSizePadded[ZZ];
270 const int atomWarpIndex = atomIndexLocal % atomsPerWarp;
271 const int warpIndex = atomIndexLocal / atomsPerWarp;
273 const int splineIndexBase = getSplineParamIndexBase(warpIndex, atomWarpIndex);
274 const int splineIndexY = getSplineParamIndex(splineIndexBase, YY, ithy);
275 const float2 tdy = sm_splineParams[splineIndexY];
276 const int splineIndexZ = getSplineParamIndex(splineIndexBase, ZZ, ithz);
277 const float2 tdz = sm_splineParams[splineIndexZ];
279 const int ixBase = sm_gridlineIndices[atomIndexLocal * DIM + XX];
280 int iy = sm_gridlineIndices[atomIndexLocal * DIM + YY] + ithy;
281 if (wrapY & (iy >= ny))
285 int iz = sm_gridlineIndices[atomIndexLocal * DIM + ZZ] + ithz;
290 const int constOffset = iy * pnz + iz;
293 for (int ithx = 0; (ithx < order); ithx++)
295 int ix = ixBase + ithx;
296 if (wrapX & (ix >= nx))
300 const int gridIndexGlobal = ix * pny * pnz + constOffset;
301 assert(gridIndexGlobal >= 0);
302 const float gridValue = gm_grid[gridIndexGlobal];
303 assert(isfinite(gridValue));
304 const int splineIndexX = getSplineParamIndex(splineIndexBase, XX, ithx);
305 const float2 tdx = sm_splineParams[splineIndexX];
306 const float fxy1 = tdz.x * gridValue;
307 const float fz1 = tdz.y * gridValue;
308 fx += tdx.y * tdy.x * fxy1;
309 fy += tdx.x * tdy.y * fxy1;
310 fz += tdx.x * tdy.x * fz1;
314 // Reduction of partial force contributions
315 __local float sm_forces[atomsPerBlock * DIM];
317 __local float sm_forceReduction[totalSharedMemory];
318 __local float *sm_forceTemp[DIM];
320 reduce_atom_forces(sm_forces,
321 atomIndexLocal, splineIndex, lineIndex,
322 kernelParams.grid.realGridSizeFP,
326 barrier(CLK_LOCAL_MEM_FENCE);
328 /* Calculating the final forces with no component branching, atomsPerBlock threads */
329 const int forceIndexLocal = threadLocalId;
330 const int forceIndexGlobal = atomIndexOffset + forceIndexLocal;
331 const int calcIndexCheck = pme_gpu_check_atom_data_index(forceIndexGlobal, kernelParams.atoms.nAtoms);
332 if ((forceIndexLocal < atomsPerBlock) & calcIndexCheck)
334 const float3 atomForces = vload3(forceIndexLocal, sm_forces);
335 const float negCoefficient = -gm_coefficients[forceIndexGlobal];
337 result.x = negCoefficient * kernelParams.current.recipBox[XX][XX] * atomForces.x;
338 result.y = negCoefficient * (kernelParams.current.recipBox[XX][YY] * atomForces.x +
339 kernelParams.current.recipBox[YY][YY] * atomForces.y);
340 result.z = negCoefficient * (kernelParams.current.recipBox[XX][ZZ] * atomForces.x +
341 kernelParams.current.recipBox[YY][ZZ] * atomForces.y +
342 kernelParams.current.recipBox[ZZ][ZZ] * atomForces.z);
343 vstore3(result, forceIndexLocal, sm_forces);
346 #if !defined(_AMD_SOURCE_) && !defined(_NVIDIA_SOURCE_)
347 /* This is only here for execution of e.g. 32-sized warps on 16-wide hardware; this was gmx_syncwarp() in CUDA.
350 barrier(CLK_LOCAL_MEM_FENCE);
353 assert(atomsPerBlock <= warp_size);
355 /* Writing or adding the final forces component-wise, single warp */
356 const int blockForcesSize = atomsPerBlock * DIM;
357 const int numIter = (blockForcesSize + warp_size - 1) / warp_size;
358 const int iterThreads = blockForcesSize / numIter;
359 if (threadLocalId < iterThreads)
362 for (int i = 0; i < numIter; i++)
364 const int outputIndexLocal = i * iterThreads + threadLocalId;
365 const int outputIndexGlobal = get_group_id(XX) * blockForcesSize + outputIndexLocal;
366 const int globalOutputCheck = pme_gpu_check_atom_data_index(outputIndexGlobal, kernelParams.atoms.nAtoms * DIM);
367 if (globalOutputCheck)
369 const float outputForceComponent = sm_forces[outputIndexLocal];
372 gm_forces[outputIndexGlobal] = outputForceComponent;
376 gm_forces[outputIndexGlobal] += outputForceComponent;