1#include "../include/particles.cuh"
2#include "../include/cuda_utils/cuda_launcher.cuh"
15 ax(ax), level(level), uid(uid), materialId(materialId), sml(sml),
16 nnl(nnl), noi(noi), e(e), dedt(dedt), cs(cs), rho(rho), p(p) {
52 mass(mass), x(x), y(y), vx(vx), vy(vy), ax(ax), ay(ay),
53 uid(uid), materialId(materialId), sml(sml), nnl(nnl), noi(noi),
54 e(e), dedt(dedt), cs(cs), rho(rho), p(p) {
92 vx(vx), vy(vy), vz(vz), ax(ax), ay(ay), az(az), uid(uid),
93 materialId(materialId), sml(sml), nnl(nnl), noi(noi), e(e), dedt(dedt),
94 cs(cs), rho(rho), p(p) {
195#if VARIABLE_SML || INTEGRATE_SML
197 this->dsmldt = dsmldt;
202 this->sml_omega = sml_omega;
207 this->Tshear = Tshear;
215 this->localStrain = localStrain;
218#if SOLID || NAVIER_STOKES
232 real *epsilon_v,
real *depsilon_vdt) {
234 this->alpha_jutzi = alpha_jutzi;
235 this->alpha_jutzi_old = alpha_jutzi_old;
236 this->dalphadt = dalphadt;
237 this->dalphadp = dalphadp;
239 this->dalphadrho = dalphadrho;
241 this->delpdelrho = delpdelrho;
242 this->delpdele = delpdele;
243 this->cs_old = cs_old;
244 this->alpha_epspor = alpha_epspor;
245 this->dalpha_epspordt = dalpha_epspordt;
246 this->epsilon_v = epsilon_v;
247 this->depsilon_vdt = depsilon_vdt;
252 this->shepardCorrection = shepardCorrection;
255#if LINEAR_CONSISTENCY
257 this->tensorialCorrectionMatrix = tensorialCorrectionMatrix;
264 this->damage_total = damage_total;
266 this->numFlaws = numFlaws;
267 this->maxNumFlaws = maxNumFlaws;
268 this->numActiveFlaws = numActiveFlaws;
273 this->damage_porjutzi = damage_porjutzi;
274 this->ddamage_porjutzidt = ddamage_porjutzidt;
295 if (
x[index_1] <
x[index_2]) {
296 dx =
x[index_2] -
x[index_1];
298 else if (
x[index_1] >
x[index_2]) {
299 dx =
x[index_1] -
x[index_2];
306 if (
y[index_1] <
y[index_2]) {
307 dy =
y[index_2] -
y[index_1];
309 else if (
y[index_1] >
y[index_2]) {
310 dy =
y[index_1] -
y[index_2];
317 if (
z[index_1] <
z[index_2]) {
318 dz =
z[index_2] -
z[index_1];
320 else if (
z[index_1] >
z[index_2]) {
321 dz =
z[index_1] -
z[index_2];
332 return sqrt(dx*dx + dy*dy);
334 return sqrt(dx*dx + dy*dy + dz*dz);
342 return x[index] *
mass[index];
346 return y[index] *
mass[index];
350 return z[index] *
mass[index];
355 printf(
"Entry not available!\n");
433 int bodyIndex = threadIdx.x + blockDim.x * blockIdx.x;
434 int stride = blockDim.x * gridDim.x;
437 while ((bodyIndex + offset) < n) {
439 if (particles->
level[bodyIndex + offset] == -1) {
440 printf(
"level[%i] = %i!\n", bodyIndex + offset, particles->
level[bodyIndex + offset]);
529 int bodyIndex = threadIdx.x + blockDim.x * blockIdx.x;
530 int stride = blockDim.x * gridDim.x;
534 printf(
"not implemented yet for DIM == 1...\n");
536 printf(
"not implemented yet for DIM == 2...\n");
538 while ((bodyIndex + offset) < n) {
540 printf(
"x[%i] = (%f, %f, %f) v = (%f, %f, %f) a = (%f, %f, %f) mass = %f\n", bodyIndex + offset,
541 particles->
x[bodyIndex + offset], particles->
y[bodyIndex + offset], particles->
z[bodyIndex + offset],
542 particles->
vx[bodyIndex + offset], particles->
vy[bodyIndex + offset], particles->
vz[bodyIndex + offset],
543 particles->
ax[bodyIndex + offset], particles->
ay[bodyIndex + offset], particles->
az[bodyIndex + offset],
544 particles->
mass[bodyIndex + offset]);
550 while ((bodyIndex + offset) < k && (bodyIndex + offset) > m) {
552 printf(
"x[%i] = (%f, %f, %f) mass = %f\n", bodyIndex + offset, particles->
x[bodyIndex + offset],
553 particles->
y[bodyIndex + offset],
554 particles->
z[bodyIndex + offset],
555 particles->
mass[bodyIndex + offset]);
579 particles->
set(
numParticles, numNodes, mass, x, vx, ax, level, uid, materialId, sml, nnl, noi, e,
590 x, vx, ax, level, uid, materialId, sml, nnl, noi, e, dedt, cs, rho, p);
601 particles->
set(
numParticles, numNodes, mass, x, y, vx, vy, ax, ay, level, uid, materialId, sml,
602 nnl, noi, e, dedt, cs, rho, p);
613 mass, x, y, vx, vy, ax, ay, level, uid, materialId, sml, nnl, noi, e, dedt,
626 particles->
set(
numParticles, numNodes, mass, x, y, z, vx, vy, vz, ax, ay, az, level, uid,
627 materialId, sml, nnl, noi, e, dedt, cs, rho, p);
638 mass, x, y, z, vx, vy, vz, ax, ay, az, level, uid, materialId, sml,
639 nnl, noi, e, dedt, cs, rho, p);
699 particles->
setLeapfrog(ax_old, ay_old, g_ax_old, g_ay_old);
706 ax_old, ay_old, g_ax_old, g_ay_old);
712 particles->
setLeapfrog(ax_old, ay_old, az_old, g_ax_old, g_ay_old, g_az_old);
720 ax_old, ay_old, az_old, g_ax_old, g_ay_old, g_az_old);
760 particles->setDivCurl(divv, curlv);
765 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setDivCurl, particles, divv, curlv);
779#if VARIABLE_SML || INTEGRATE_SML
780 __global__
void setVariableSML(
Particles *particles,
real *dsmldt) {
781 particles->setVariableSML(dsmldt);
783 void Launch::setVariableSML(
Particles *particles,
real *dsmldt) {
785 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setVariableSML, particles, dsmldt);
789 __global__
void setSMLCorrection(
Particles *particles,
real *sml_omega) {
790 particles->setSMLCorrection(sml_omega);
793 void Launch::setSMLCorrection(
Particles *particles,
real *sml_omega) {
795 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setSMLCorrection, particles, sml_omega);
800 particles->setNavierStokes(Tshear, eta);
805 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setNavierStokes, particles, Tshear, eta);
811 particles->setSolid(S, dSdt, localStrain);
815 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setSolid, particles, S, dSdt, localStrain);
818#if SOLID || NAVIER_STOKES
819 __global__
void setSolidNavierStokes(
Particles *particles,
real *sigma) {
820 particles->setSolidNavierStokes(sigma);
822 void Launch::setSolidNavierStokes(
Particles *particles,
real *sigma) {
824 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setSolidNavierStokes, particles, sigma);
828 __global__
void setArtificialStress(
Particles *particles,
real *R) {
829 particles->setArtificialStress(R);
831 void Launch::setArtificialStress(
Particles *particles,
real *R) {
833 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setArtificialStress, particles, R);
840 real *epsilon_v,
real *depsilon_vdt) {
841 particles->setPorosity(pold, alpha_jutzi, alpha_jutzi_old, dalphadt,
842 dalphadp, dp, dalphadrho, f, delpdelrho,
843 delpdele, cs_old, alpha_epspor, dalpha_epspordt,
844 epsilon_v, depsilon_vdt);
849 real *epsilon_v,
real *depsilon_vdt) {
851 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setPorosity, particles, pold, alpha_jutzi,
852 alpha_jutzi_old, dalphadt, dalphadp, dp, dalphadrho, f, delpdelrho, delpdele, cs_old,
853 alpha_epspor, dalpha_epspordt, epsilon_v, depsilon_vdt);
858 __global__
void setZeroConsistency(
Particles *particles,
real *shepardCorrection) {
859 particles->setZeroConsistency(shepardCorrection);
861 void Launch::setZeroConsistency(
Particles *particles,
real *shepardCorrection) {
863 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setZeroConsistency, particles,
867#if LINEAR_CONSISTENCY
868 __global__
void setLinearConsistency(
Particles *particles,
real *tensorialCorrectionMatrix) {
869 particles->setLinearConsistency(tensorialCorrectionMatrix);
871 void Launch::setLinearConsistency(
Particles *particles,
real *tensorialCorrectionMatrix) {
873 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setLinearConsistency, particles,
874 tensorialCorrectionMatrix);
880 particles->setFragmentation(d, damage_total, dddt, numFlaws, maxNumFlaws, numActiveFlaws, flaws);
885 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setFragmentation, particles, d, damage_total,
886 dddt, numFlaws, maxNumFlaws, numActiveFlaws, flaws);
889 __global__
void setPalphaPorosity(
Particles *particles,
real *damage_porjutzi,
real *ddamage_porjutzidt) {
890 particles->setPalphaPorosity(damage_porjutzi, ddamage_porjutzidt);
892 void Launch::setPalphaPorosity(
Particles *particles,
real *damage_porjutzi,
real *ddamage_porjutzidt) {
894 cuda::launch(
false, executionPolicy, ::ParticlesNS::Kernel::setPalphaPorosity, particles, damage_porjutzi,
904 int bodyIndex = threadIdx.x + blockDim.x * blockIdx.x;
905 int stride = blockDim.x * gridDim.x;
908 if (bodyIndex == 0) {
909 printf(
"device: numParticles = %i\n", *particles->
numParticles);
913 printf(
"not implemented yet for DIM == 1...\n");
915 printf(
"not implemented yet for DIM == 2...\n");
917 while ((bodyIndex + offset) < *particles->
numParticles) {
918 if ((bodyIndex + offset) % 10000 == 0) {
919 printf(
"device: x[%i] = (%f, %f, %f)\n", bodyIndex + offset, particles->
x[bodyIndex + offset],
920 particles->
y[bodyIndex + offset],
921 particles->
z[bodyIndex + offset]);
947 uid(uid), rho(rho), e(e), dedt(dedt), p(p), cs(cs),
948 x(x), vx(vx), ax(ax) {
969 real *ay) : uid(uid), rho(rho), e(e), dedt(dedt),
970 p(p), cs(cs), x(x), y(y), vx(vx), vy(vy), ax(ax),
997 uid(uid), rho(rho), e(e), dedt(dedt), p(p), cs(cs),
998 x(x), y(y), z(z), vx(vx), vy(vy), vz(vz), ax(ax), ay(ay),
1043#if VARIABLE_SML || INTEGRATE_SML
1045 this->dsmldt = dsmldt;
1090 integratedParticles->
set(uid, rho, e, dedt, p, cs, x, vx, ax);
1097 rho, e, dedt, p, cs, x, vx, ax);
1104 integratedParticles->
set(uid, rho, e, dedt, p, cs, x, y, vx, vy, ax, ay);
1111 rho, e, dedt, p, cs, x, y, vx, vy, ax, ay);
1119 integratedParticles->
set(uid, rho, e, dedt, p, cs, x, y, z, vx, vy, vz, ax, ay, az);
1127 rho, e, dedt, p, cs, x, y, z, vx, vy, vz, ax, ay, az);
1155 integratedParticles->
setSML(sml);
1162 integratedParticles, sml);
1176 integratedParticles, drhodt);
1182#if VARIABLE_SML || INTEGRATE_SML
1184 integratedParticles->setIntegrateSML(dsmldt);
1190 cuda::launch(
false, executionPolicy, ::IntegratedParticlesNS::Kernel::setIntegrateSML,
1191 integratedParticles, dsmldt);
Execution policy/instruction for CUDA kernel execution.
CUDA_CALLABLE_MEMBER void setSML(real *sml)
CUDA_CALLABLE_MEMBER IntegratedParticles()
CUDA_CALLABLE_MEMBER ~IntegratedParticles()
CUDA_CALLABLE_MEMBER void reset(integer index)
idInteger * uid
unique identifier
CUDA_CALLABLE_MEMBER void setIntegrateDensity(real *drhodt)
CUDA_CALLABLE_MEMBER void set(idInteger *uid, real *rho, real *e, real *dedt, real *p, real *cs, real *x, real *y, real *z, real *vx, real *vy, real *vz, real *ax, real *ay, real *az)
Particle(s) class based on SoA (Structur of Arrays).
integer * noi
(pointer to) number of interactions (array)
real * e
(pointer to) internal energy (array)
CUDA_CALLABLE_MEMBER real weightedEntry(integer index, Entry::Name entry)
integer * materialId
(pointer to) material identifier (array)
real * x
(pointer to) x position (array)
real * rho
(pointer to) density (array)
integer * level
(pointer to) level of the (pseudo-)particles
idInteger * uid
(pointer to) unique identifier (array)
real * drhodt
(pointer to) time derivative of density (array)
CUDA_CALLABLE_MEMBER void set(integer *numParticles, integer *numNodes, real *mass, real *x, real *y, real *z, real *vx, real *vy, real *vz, real *ax, real *ay, real *az, integer *level, idInteger *uid, integer *materialId, real *sml, integer *nnl, integer *noi, real *e, real *dedt, real *cs, real *rho, real *p)
Setter (DIM = 3) assigning variables to pointer members.
real * g_ay
(pointer to) y gravitational acceleration (array)
real * ay
(pointer to) y acceleration (array)
integer * nodeType
(pointer to) node type
integer * nnl
(pointer to) near(est) neighbor list (array)
real * az
(pointer to) z acceleration (array)
real * p
(pointer to) pressure (array)
real * cs
(pointer to) sound of speed (array)
real * y
(pointer to) y position (array)
real * ax
(pointer to) x acceleration (array)
CUDA_CALLABLE_MEMBER void reset(integer index)
Reset (specific) entries.
real * u
energy (kinetic + gravitational for now)
real * g_ax
(pointer to) x gravitational acceleration (array)
CUDA_CALLABLE_MEMBER Particles()
CUDA_CALLABLE_MEMBER ~Particles()
real * sml
(pointer to) smoothing length (array)
real * dedt
(pointer to) time derivative of internal energy (array)
real * mass
(pointer to) mass (array)
real * z
(pointer to) z position (array)
integer * numParticles
number of particles
integer * numNodes
number of nodes
real * vz
(pointer to) z velocity (array)
CUDA_CALLABLE_MEMBER real distance(integer index_1, integer index_2)
Distance of two particles.
CUDA_CALLABLE_MEMBER void setLeapfrog(real *ax_old, real *ay_old, real *az_old, real *g_ax_old, real *g_ay_old, real *g_az_old)
real * muijmax
(pointer) to max(mu_ij) (array) needed for artificial viscosity and determining timestp
CUDA_CALLABLE_MEMBER void setGravity(real *g_ax, real *g_ay, real *g_az)
Constructor (DIM = 3) assigning gravitational acceleration to member variables.
real * g_az
(pointer to) z gravitational acceleration (array)
real * vx
(pointer to) x velocity (array)
CUDA_CALLABLE_MEMBER void setNodeType(integer *nodeType)
Setter for node type.
real * vy
(pointer to) y velocity (array)
CUDA_CALLABLE_MEMBER void setArtificialViscosity(real *muijmax)
Setter for artificial viscosity (entry).
CUDA_CALLABLE_MEMBER void setIntegrateDensity(real *drhodt)
Setter in dependence of INTEGRATE_DENSITY.
CUDA_CALLABLE_MEMBER void setU(real *u)
Setter for energy.
#define CUDA_CALLABLE_MEMBER
void setSML(IntegratedParticles *integratedParticles, real *sml)
void setIntegrateDensity(IntegratedParticles *integratedParticles, real *drhodt)
void set(IntegratedParticles *integratedParticles, idInteger *uid, real *rho, real *e, real *dedt, real *p, real *cs, real *x, real *y, real *z, real *vx, real *vy, real *vz, real *ax, real *ay, real *az)
__global__ void set(IntegratedParticles *integratedParticles, idInteger *uid, real *rho, real *e, real *dedt, real *p, real *cs, real *x, real *y, real *z, real *vx, real *vy, real *vz, real *ax, real *ay, real *az)
__global__ void setSML(IntegratedParticles *integratedParticles, real *sml)
__global__ void setIntegrateDensity(IntegratedParticles *integratedParticles, real *drhodt)
__global__ void info(Material *material)
Debug kernel giving information about material(s).
void setU(Particles *particles, real *u)
void setIntegrateDensity(Particles *particles, real *drhodt)
void setGravity(Particles *particles, real *g_ax, real *g_ay, real *g_az)
void setLeapfrog(Particles *particles, real *ax_old, real *ay_old, real *az_old, real *g_ax_old, real *g_ay_old, real *g_az_old)
void set(Particles *particles, integer *numParticles, integer *numNodes, real *mass, real *x, real *y, real *z, real *vx, real *vy, real *vz, real *ax, real *ay, real *az, integer *level, idInteger *uid, integer *materialId, real *sml, integer *nnl, integer *noi, real *e, real *dedt, real *cs, real *rho, real *p)
real test(Particles *particles, bool time=false)
void setNodeType(Particles *particles, integer *nodeType)
real info(Particles *particles, integer n, integer m, integer k)
real check4nans(Particles *particles, integer n)
void setArtificialViscosity(Particles *particles, real *muijmax)
__global__ void set(Particles *particles, integer *numParticles, integer *numNodes, real *mass, real *x, real *y, real *z, real *vx, real *vy, real *vz, real *ax, real *ay, real *az, integer *level, idInteger *uid, integer *materialId, real *sml, integer *nnl, integer *noi, real *e, real *dedt, real *cs, real *rho, real *p)
__global__ void setArtificialViscosity(Particles *particles, real *muijmax)
__global__ void setNodeType(Particles *particles, integer *nodeType)
__global__ void setIntegrateDensity(Particles *particles, real *drhodt)
__global__ void setGravity(Particles *particles, real *g_ax, real *g_ay, real *g_az)
__global__ void info(Particles *particles, integer n, integer m, integer k)
__global__ void setLeapfrog(Particles *particles, real *ax_old, real *ay_old, real *az_old, real *g_ax_old, real *g_ay_old, real *g_az_old)
__global__ void check4nans(Particles *particles, integer n)
__global__ void setU(Particles *particles, real *u)
__global__ void test(Particles *particles)
Particle class related functions and kernels.
const char *const numParticles
__device__ real sqrt(real a)
Square root of a floating point value.
void set(T *d_var, T val, std::size_t count=1)
Set device memory to a specific value.
real launch(bool timeKernel, const ExecutionPolicy &policy, void(*f)(Arguments...), Arguments... args)
CUDA execution wrapper function.