2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2016,2017, 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 * Implements PME spline computation and charge spreading tests.
39 * \author Aleksei Iupinov <a.yupinov@gmail.com>
40 * \ingroup module_ewald
47 #include <gmock/gmock.h>
49 #include "gromacs/mdtypes/inputrec.h"
50 #include "gromacs/utility/stringutil.h"
52 #include "testutils/refdata.h"
53 #include "testutils/testasserts.h"
55 #include "pmetestcommon.h"
64 //! PME spline and spread code path being tested
65 enum class PmeSplineAndSpreadOptions
69 SplineAndSpreadUnified
72 /*! \brief Convenience typedef of input parameters - unit cell box, PME interpolation order, grid dimensions,
73 * particle coordinates, particle charges
74 * TODO: consider inclusion of local grid offsets/sizes or PME nodes counts to test the PME DD
76 typedef std::tuple
<Matrix3x3
, int, IVec
, CoordinatesVector
, ChargesVector
> SplineAndSpreadInputParameters
;
78 /*! \brief Test fixture for testing both atom spline parameter computation and charge spreading.
79 * These 2 stages of PME are tightly coupled in the code.
81 class PmeSplineAndSpreadTest
: public ::testing::TestWithParam
<SplineAndSpreadInputParameters
>
84 //! Default constructor
85 PmeSplineAndSpreadTest() = default;
89 /* Getting the input */
93 CoordinatesVector coordinates
;
94 ChargesVector charges
;
96 std::tie(box
, pmeOrder
, gridSize
, coordinates
, charges
) = GetParam();
97 const size_t atomCount
= coordinates
.size();
99 /* Storing the input where it's needed */
101 inputRec
.nkx
= gridSize
[XX
];
102 inputRec
.nky
= gridSize
[YY
];
103 inputRec
.nkz
= gridSize
[ZZ
];
104 inputRec
.pme_order
= pmeOrder
;
105 inputRec
.coulombtype
= eelPME
;
107 TestReferenceData refData
;
109 const std::map
<CodePath
, std::string
> modesToTest
= {{CodePath::CPU
, "CPU"}};
110 const std::map
<PmeSplineAndSpreadOptions
, std::string
> optionsToTest
= {{PmeSplineAndSpreadOptions::SplineAndSpreadUnified
, "spline computation and charge spreading (fused)"},
111 {PmeSplineAndSpreadOptions::SplineOnly
, "spline computation"},
112 {PmeSplineAndSpreadOptions::SpreadOnly
, "charge spreading"}};
113 for (const auto &mode
: modesToTest
)
115 for (const auto &option
: optionsToTest
)
117 /* Describing the test uniquely in case it fails */
119 SCOPED_TRACE(formatString("Testing %s with %s for PME grid size %d %d %d"
120 ", order %d, %zu atoms",
121 option
.second
.c_str(), mode
.second
.c_str(),
122 gridSize
[XX
], gridSize
[YY
], gridSize
[ZZ
],
126 /* Running the test */
128 PmeSafePointer pmeSafe
= pmeInitWithAtoms(&inputRec
, coordinates
, charges
, box
);
130 const bool computeSplines
= (option
.first
== PmeSplineAndSpreadOptions::SplineOnly
) || (option
.first
== PmeSplineAndSpreadOptions::SplineAndSpreadUnified
);
131 const bool spreadCharges
= (option
.first
== PmeSplineAndSpreadOptions::SpreadOnly
) || (option
.first
== PmeSplineAndSpreadOptions::SplineAndSpreadUnified
);
135 // Here we should set up the results of the spline computation so that the spread can run.
136 // What is lazy and works is running the separate spline so that it will set it up for us:
137 pmePerformSplineAndSpread(pmeSafe
.get(), mode
.first
, true, false);
138 // We know that it is tested in another iteration.
139 // TODO: Clean alternative: read and set the reference gridline indices, spline params
142 pmePerformSplineAndSpread(pmeSafe
.get(), mode
.first
, computeSplines
, spreadCharges
);
144 /* Outputs correctness check */
145 /* All tolerances were picked empirically for single precision on CPU */
147 TestReferenceChecker
rootChecker(refData
.rootChecker());
149 const auto maxGridSize
= std::max(std::max(gridSize
[XX
], gridSize
[YY
]), gridSize
[ZZ
]);
150 const auto ulpToleranceSplineValues
= 2 * (pmeOrder
- 2) * maxGridSize
;
151 /* 2 is empiric, the rest follows from the amount of operations */
155 const char *dimString
[] = { "X", "Y", "Z" };
158 SCOPED_TRACE(formatString("Testing spline values with tolerance of %ld", ulpToleranceSplineValues
));
159 TestReferenceChecker
splineValuesChecker(rootChecker
.checkCompound("Splines", "Values"));
160 splineValuesChecker
.setDefaultTolerance(relativeToleranceAsUlp(1.0, ulpToleranceSplineValues
));
161 for (int i
= 0; i
< DIM
; i
++)
163 auto splineValuesDim
= pmeGetSplineData(pmeSafe
.get(), mode
.first
, PmeSplineDataType::Values
, i
);
164 splineValuesChecker
.checkSequence(splineValuesDim
.begin(), splineValuesDim
.end(), dimString
[i
]);
167 /* Spline derivatives */
168 const auto ulpToleranceSplineDerivatives
= 4 * ulpToleranceSplineValues
;
169 /* 4 is just a wild guess since the derivatives are deltas of neighbor spline values which could differ greatly */
170 SCOPED_TRACE(formatString("Testing spline derivatives with tolerance of %ld", ulpToleranceSplineDerivatives
));
171 TestReferenceChecker
splineDerivativesChecker(rootChecker
.checkCompound("Splines", "Derivatives"));
172 splineDerivativesChecker
.setDefaultTolerance(relativeToleranceAsUlp(1.0, ulpToleranceSplineDerivatives
));
173 for (int i
= 0; i
< DIM
; i
++)
175 auto splineDerivativesDim
= pmeGetSplineData(pmeSafe
.get(), mode
.first
, PmeSplineDataType::Derivatives
, i
);
176 splineDerivativesChecker
.checkSequence(splineDerivativesDim
.begin(), splineDerivativesDim
.end(), dimString
[i
]);
179 /* Particle gridline indices */
180 auto gridLineIndices
= pmeGetGridlineIndices(pmeSafe
.get(), mode
.first
);
181 rootChecker
.checkSequence(gridLineIndices
.begin(), gridLineIndices
.end(), "Gridline indices");
186 /* The wrapped grid */
187 SparseRealGridValuesOutput nonZeroGridValues
= pmeGetRealGrid(pmeSafe
.get(), mode
.first
);
188 TestReferenceChecker
gridValuesChecker(rootChecker
.checkCompound("NonZeroGridValues", "RealSpaceGrid"));
189 const auto ulpToleranceGrid
= 2 * ulpToleranceSplineValues
* (int)(ceil(sqrt(atomCount
)));
190 /* 2 is empiric; sqrt(atomCount) assumes all the input charges may spread onto the same cell */
191 SCOPED_TRACE(formatString("Testing grid values with tolerance of %ld", ulpToleranceGrid
));
192 gridValuesChecker
.setDefaultTolerance(relativeToleranceAsUlp(1.0, ulpToleranceGrid
));
193 for (const auto &point
: nonZeroGridValues
)
195 gridValuesChecker
.checkReal(point
.second
, point
.first
.c_str());
204 /*! \brief Test for PME B-spline moduli computation */
205 TEST_P(PmeSplineAndSpreadTest
, ReproducesOutputs
)
207 EXPECT_NO_THROW(runTest());
210 /* Valid input instances */
212 //! A couple of valid inputs for boxes.
213 static std::vector
<Matrix3x3
> const sampleBoxes
229 //! A couple of valid inputs for grid sizes.
230 static std::vector
<IVec
> const sampleGridSizes
241 static std::vector
<real
> const sampleChargesFull
243 4.95f
, 3.11f
, 3.97f
, 1.08f
, 2.09f
, 1.1f
, 4.13f
, 3.31f
, 2.8f
, 5.83f
, 5.09f
, 6.1f
, 2.86f
, 0.24f
, 5.76f
, 5.19f
, 0.72f
246 static auto const sampleCharges1
= ChargesVector::fromVector(sampleChargesFull
.begin(), sampleChargesFull
.begin() + 1);
248 static auto const sampleCharges2
= ChargesVector::fromVector(sampleChargesFull
.begin() + 1, sampleChargesFull
.begin() + 3);
250 static auto const sampleCharges13
= ChargesVector::fromVector(sampleChargesFull
.begin() + 3, sampleChargesFull
.begin() + 16);
252 //! Random coordinate vectors
253 static CoordinatesVector
const sampleCoordinatesFull
258 16.0f
, 1.02f
, 0.22f
// 2 box lengths in x
268 16.0001f
, 1.52f
, 1.19f
// > 2 box lengths in x
270 1.43f
, 1.1f
, 4.1f
// > 2 box lengths in z
272 -1.08f
, 1.19f
, 0.08f
// negative x
276 1.32f
, -1.48f
, 0.16f
// negative y
280 0.95f
, 7.7f
, -0.48f
// > 2 box lengths in y, negative z
291 //! 1 coordinate vector
292 static CoordinatesVector
const sampleCoordinates1(sampleCoordinatesFull
.begin(), sampleCoordinatesFull
.begin() + 1);
293 //! 2 coordinate vectors
294 static CoordinatesVector
const sampleCoordinates2(sampleCoordinatesFull
.begin() + 1, sampleCoordinatesFull
.begin() + 3);
295 //! 13 coordinate vectors
296 static CoordinatesVector
const sampleCoordinates13(sampleCoordinatesFull
.begin() + 3, sampleCoordinatesFull
.begin() + 16);
298 //! moved out from instantiantions for readability
299 auto inputBoxes
= ::testing::ValuesIn(sampleBoxes
);
300 //! moved out from instantiantions for readability
301 auto inputPmeOrders
= ::testing::Range(3, 5 + 1);
302 //! moved out from instantiantions for readability
303 auto inputGridSizes
= ::testing::ValuesIn(sampleGridSizes
);
305 /*! \brief Instantiation of the PME spline computation test with valid input and 1 atom */
306 INSTANTIATE_TEST_CASE_P(SaneInput1
, PmeSplineAndSpreadTest
, ::testing::Combine(inputBoxes
, inputPmeOrders
, inputGridSizes
,
307 ::testing::Values(sampleCoordinates1
),
308 ::testing::Values(sampleCharges1
)
310 /*! \brief Instantiation of the PME spline computation test with valid input and 2 atoms */
311 INSTANTIATE_TEST_CASE_P(SaneInput2
, PmeSplineAndSpreadTest
, ::testing::Combine(inputBoxes
, inputPmeOrders
, inputGridSizes
,
312 ::testing::Values(sampleCoordinates2
),
313 ::testing::Values(sampleCharges2
)
315 /*! \brief Instantiation of the PME spline computation test with valid input and 13 atoms */
316 INSTANTIATE_TEST_CASE_P(SaneInput13
, PmeSplineAndSpreadTest
, ::testing::Combine(inputBoxes
, inputPmeOrders
, inputGridSizes
,
317 ::testing::Values(sampleCoordinates13
),
318 ::testing::Values(sampleCharges13
)