borg_public/libLSS/tests/test_mngp.cpp

152 lines
5.1 KiB
C++
Raw Normal View History

2023-05-29 10:41:03 +02:00
/*+
ARES/HADES/BORG Package -- ./libLSS/tests/test_mngp.cpp
Copyright (C) 2014-2020 Guilhem Lavaux <guilhem.lavaux@iap.fr>
Copyright (C) 2009-2020 Jens Jasche <jens.jasche@fysik.su.se>
Additional contributions from:
Guilhem Lavaux <guilhem.lavaux@iap.fr> (2023)
+*/
#include <cmath>
#include <CosmoTool/algo.hpp>
#include <boost/multi_array.hpp>
#include "libLSS/mpi/generic_mpi.hpp"
#include "libLSS/tools/console.hpp"
#include "libLSS/tools/static_init.hpp"
#include "libLSS/tools/uninitialized_type.hpp"
#include "libLSS/tools/array_tools.hpp"
#include "libLSS/physics/classic_cic.hpp"
//#include "libLSS/tools/mpi_fftw_helper.hpp"
#include "libLSS/physics/modified_ngp.hpp"
#include "libLSS/physics/modified_ngp_smooth.hpp"
#include "libLSS/physics/cosmo.hpp"
#include <H5Cpp.h>
#include <CosmoTool/hdf5_array.hpp>
#include "libLSS/tools/hdf5_error.hpp"
#include "libLSS/samplers/rgen/gsl_random_number.hpp"
#include <boost/chrono.hpp>
//#undef RANDOM_ACCESS
#define RANDOM_ACCESS
using namespace LibLSS;
using CosmoTool::cube;
typedef ClassicCloudInCell<double> CIC;
//typedef ModifiedNGP<double> MNGP;
typedef ModifiedNGP<double, NGPGrid::Quad> MNGP;
typedef SmoothModifiedNGP<double, SmoothNGPGrid::Quad> MNGPS;
//typedef ModifiedNGP<double, NGPGrid::CIC> MNGP;
int main(int argc, char **argv) {
StaticInit::execute();
MPI_Communication *world = setupMPI(argc, argv);
CosmologicalParameters cosmo;
cosmo.omega_m = 0.30;
cosmo.omega_b = 0.045;
cosmo.omega_q = 0.70;
cosmo.w = -1;
cosmo.n_s = 0.97;
cosmo.sigma8 = 0.8;
cosmo.h = 0.68;
cosmo.a0 = 1.0;
Console::instance().setVerboseLevel<LOG_DEBUG>();
double L = 1.0;
int N = 64;
int Np_g = 128;
int Np = cube(Np_g);
typedef UninitializedArray<boost::multi_array<double, 3>> U_Density;
typedef UninitializedArray<boost::multi_array<double, 2>> U_Particles;
U_Density density_p(boost::extents[N][N][N]);
U_Density density_mngp_p(boost::extents[N][N][N]);
U_Density density_mngps_p(boost::extents[N][N][N]);
U_Particles particles_p(boost::extents[Np][3]);
U_Particles adjoint_p(boost::extents[Np][3]);
U_Particles adjoint_mngp_p(boost::extents[Np][3]);
U_Particles adjoint_mngps_p(boost::extents[Np][3]);
U_Density::array_type &density = density_p.get_array();
U_Density::array_type &density_mngp = density_mngp_p.get_array();
U_Density::array_type &density_mngps = density_mngps_p.get_array();
U_Particles::array_type &particles = particles_p.get_array();
U_Particles::array_type &adjoint = adjoint_p.get_array();
U_Particles::array_type &adjoint_mngp = adjoint_mngp_p.get_array();
U_Particles::array_type &adjoint_mngps = adjoint_mngps_p.get_array();
CIC cic;
MNGP mngp;
#ifdef RANDOM_ACCESS
RandomNumberThreaded<GSL_RandomNumber> rgen(-1);
# pragma omp parallel for schedule(static)
for (long i = 0; i < Np; i++) {
particles[i][0] = L * rgen.uniform();
particles[i][1] = L * rgen.uniform();
particles[i][2] = L * rgen.uniform();
}
#else
# pragma omp parallel for schedule(static)
for (long i = 0; i < Np; i++) {
int iz = (i % Np_g);
int iy = ((i / Np_g) % Np_g);
int ix = ((i / Np_g / Np_g));
particles[i][0] = L / Np_g * ix;
particles[i][1] = L / Np_g * iy;
particles[i][2] = L / Np_g * iz;
}
#endif
Console::instance().print<LOG_INFO>("Clearing and projecting");
array::fill(density, 0);
array::fill(density_mngp, 0);
array::fill(density_mngps, 0);
using namespace boost::chrono;
system_clock::time_point start_classic, end_classic, start_mp, end_mp,
start_mp2, end_mp2;
start_classic = system_clock::now();
CIC::projection(particles, density, L, L, L, N, N, N);
end_classic = system_clock::now();
CIC::adjoint(particles, density, adjoint, L, L, L, N, N, N, 1.0);
start_mp = system_clock::now();
MNGP::projection(particles, density_mngp, L, L, L, N, N, N);
end_mp = system_clock::now();
start_mp2 = system_clock::now();
MNGPS::projection(particles, density_mngps, L, L, L, N, N, N);
end_mp2 = system_clock::now();
MNGP::adjoint(particles, density_mngp, adjoint_mngp, L, L, L, N, N, N, 1.0);
MNGPS::adjoint(
particles, density_mngps, adjoint_mngps, L, L, L, N, N, N, 1.0);
duration<double> elapsed_classic = end_classic - start_classic;
duration<double> elapsed_mp = end_mp - start_mp;
duration<double> elapsed_mps = end_mp2 - start_mp2;
std::cout << "MNGP: " << elapsed_mp << " MNPS:" << elapsed_mps
<< " Classic: " << elapsed_classic << std::endl;
try {
H5::H5File f("cic.h5", H5F_ACC_TRUNC);
CosmoTool::hdf5_write_array(f, "density", density);
CosmoTool::hdf5_write_array(f, "density_mngp", density_mngp);
CosmoTool::hdf5_write_array(f, "density_mngps", density_mngps);
CosmoTool::hdf5_write_array(f, "adjoint", adjoint);
CosmoTool::hdf5_write_array(f, "adjoint_mngp", adjoint_mngp);
CosmoTool::hdf5_write_array(f, "adjoint_mngps", adjoint_mngps);
} catch (const H5::FileIException &) {
Console::instance().print<LOG_ERROR>(
"Failed to load ref_pm.h5 in the current directory. Check in the "
"source directory libLSS/tests/");
return 1;
}
return 0;
}