diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp index 8f8a0c8c00..0cc609f91c 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp @@ -252,51 +252,51 @@ void AtomVecHybridKokkos::force_clear(int n, size_t nbytes) /* ---------------------------------------------------------------------- */ -int AtomVecHybridKokkos::pack_comm_kokkos(const int &n, const DAT::tdual_int_2d &k_sendlist, - const int & iswap, - const DAT::tdual_xfloat_2d &buf, - const int &pbc_flag, const int pbc[]) +int AtomVecHybridKokkos::pack_comm_kokkos(const int &/*n*/, const DAT::tdual_int_2d &/*k_sendlist*/, + const int & /*iswap*/, + const DAT::tdual_xfloat_2d &/*buf*/, + const int &/*pbc_flag*/, const int pbc[]) { error->all(FLERR,"AtomVecHybridKokkos doesn't yet support threaded comm"); return 0; } -void AtomVecHybridKokkos::unpack_comm_kokkos(const int &n, const int &nfirst, - const DAT::tdual_xfloat_2d &buf) +void AtomVecHybridKokkos::unpack_comm_kokkos(const int &/*n*/, const int &/*nfirst*/, + const DAT::tdual_xfloat_2d &/*buf*/) { error->all(FLERR,"AtomVecHybridKokkos doesn't yet support threaded comm"); } -int AtomVecHybridKokkos::pack_comm_self(const int &n, const DAT::tdual_int_2d &list, - const int & iswap, const int nfirst, - const int &pbc_flag, const int pbc[]) +int AtomVecHybridKokkos::pack_comm_self(const int &/*n*/, const DAT::tdual_int_2d &/*list*/, + const int & /*iswap*/, const int /*nfirst*/, + const int &/*pbc_flag*/, const int pbc[]) { error->all(FLERR,"AtomVecHybridKokkos doesn't yet support threaded comm"); return 0; } -int AtomVecHybridKokkos::pack_border_kokkos(int n, DAT::tdual_int_2d k_sendlist, - DAT::tdual_xfloat_2d buf,int iswap, - int pbc_flag, int *pbc, ExecutionSpace space) +int AtomVecHybridKokkos::pack_border_kokkos(int /*n*/, DAT::tdual_int_2d /*k_sendlist*/, + DAT::tdual_xfloat_2d /*buf*/,int /*iswap*/, + int /*pbc_flag*/, int * /*pbc*/, ExecutionSpace /*space*/) { error->all(FLERR,"AtomVecHybridKokkos doesn't yet support threaded comm"); return 0; } -void AtomVecHybridKokkos::unpack_border_kokkos(const int &n, const int &nfirst, - const DAT::tdual_xfloat_2d &buf, - ExecutionSpace space) +void AtomVecHybridKokkos::unpack_border_kokkos(const int &/*n*/, const int &/*nfirst*/, + const DAT::tdual_xfloat_2d &/*buf*/, + ExecutionSpace /*space*/) { error->all(FLERR,"AtomVecHybridKokkos doesn't yet support threaded comm"); } -int AtomVecHybridKokkos::pack_exchange_kokkos(const int &nsend,DAT::tdual_xfloat_2d &buf, - DAT::tdual_int_1d k_sendlist, - DAT::tdual_int_1d k_copylist, - ExecutionSpace space, int dim, - X_FLOAT lo, X_FLOAT hi) +int AtomVecHybridKokkos::pack_exchange_kokkos(const int &/*nsend*/,DAT::tdual_xfloat_2d &/*buf*/, + DAT::tdual_int_1d /*k_sendlist*/, + DAT::tdual_int_1d /*k_copylist*/, + ExecutionSpace /*space*/, int /*dim*/, + X_FLOAT /*lo*/, X_FLOAT /*hi*/) { error->all(FLERR,"AtomVecHybridKokkos doesn't yet support threaded comm"); return 0; } -int AtomVecHybridKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf, int nrecv, - int nlocal, int dim, X_FLOAT lo, X_FLOAT hi, - ExecutionSpace space) +int AtomVecHybridKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d & /*k_buf*/, int /*nrecv*/, + int /*nlocal*/, int /*dim*/, X_FLOAT /*lo*/, + X_FLOAT /*hi*/, ExecutionSpace /*space*/) { error->all(FLERR,"AtomVecHybridKokkos doesn't yet support threaded comm"); return 0; diff --git a/src/KOKKOS/comm_kokkos.cpp b/src/KOKKOS/comm_kokkos.cpp index 11ad5ed1e9..d8d882c6bc 100644 --- a/src/KOKKOS/comm_kokkos.cpp +++ b/src/KOKKOS/comm_kokkos.cpp @@ -821,7 +821,7 @@ void CommKokkos::borders_device() { double lo,hi; int *type; double **x; - double *buf,*mlo,*mhi; + double *mlo,*mhi; MPI_Request request; AtomVecKokkos *avec = (AtomVecKokkos *) atom->avec; @@ -990,10 +990,8 @@ void CommKokkos::borders_device() { if (n) MPI_Send(k_buf_send.view().data(),n, MPI_DOUBLE,sendproc[iswap],0,world); if (nrecv) MPI_Wait(&request,MPI_STATUS_IGNORE); - buf = buf_recv; } else { nrecv = nsend; - buf = buf_send; } // unpack buffer @@ -1172,7 +1170,7 @@ void CommKokkos::grow_send_kokkos(int n, int flag, ExecutionSpace space) free/malloc the size of the recv buffer as needed with BUFFACTOR ------------------------------------------------------------------------- */ -void CommKokkos::grow_recv_kokkos(int n, ExecutionSpace space) +void CommKokkos::grow_recv_kokkos(int n, ExecutionSpace /*space*/) { maxrecv = static_cast (BUFFACTOR * n); int maxrecv_border = (maxrecv+BUFEXTRA+5)/atom->avec->size_border + 2; @@ -1185,7 +1183,7 @@ void CommKokkos::grow_recv_kokkos(int n, ExecutionSpace space) realloc the size of the iswap sendlist as needed with BUFFACTOR ------------------------------------------------------------------------- */ -void CommKokkos::grow_list(int iswap, int n) +void CommKokkos::grow_list(int /*iswap*/, int n) { int size = static_cast (BUFFACTOR * n); diff --git a/src/KOKKOS/fix_freeze_kokkos.cpp b/src/KOKKOS/fix_freeze_kokkos.cpp index 70f3d3236d..726850f807 100644 --- a/src/KOKKOS/fix_freeze_kokkos.cpp +++ b/src/KOKKOS/fix_freeze_kokkos.cpp @@ -58,7 +58,7 @@ void FixFreezeKokkos::setup(int vflag) /* ---------------------------------------------------------------------- */ template -void FixFreezeKokkos::post_force(int vflag) +void FixFreezeKokkos::post_force(int /*vflag*/) { atomKK->sync(execution_space,datamask_read); atomKK->modified(execution_space,datamask_modify); @@ -84,7 +84,7 @@ void FixFreezeKokkos::post_force(int vflag) /* ---------------------------------------------------------------------- */ template -void FixFreezeKokkos::post_force_respa(int vflag, int ilevel, int iloop) +void FixFreezeKokkos::post_force_respa(int vflag, int /*ilevel*/, int /*iloop*/) { post_force(vflag); } diff --git a/src/KOKKOS/fix_langevin_kokkos.cpp b/src/KOKKOS/fix_langevin_kokkos.cpp index a8cc072ffc..44ae18f9a9 100644 --- a/src/KOKKOS/fix_langevin_kokkos.cpp +++ b/src/KOKKOS/fix_langevin_kokkos.cpp @@ -168,7 +168,7 @@ void FixLangevinKokkos::initial_integrate_item(int i) const /* ---------------------------------------------------------------------- */ template -void FixLangevinKokkos::post_force(int vflag) +void FixLangevinKokkos::post_force(int /*vflag*/) { // sync the device views which might have been modified on host atomKK->sync(execution_space,datamask_read); @@ -873,7 +873,7 @@ void FixLangevinKokkos::end_of_step_rmass_item(int i) const ------------------------------------------------------------------------- */ template -void FixLangevinKokkos::copy_arrays(int i, int j, int delflag) +void FixLangevinKokkos::copy_arrays(int i, int j, int /*delflag*/) { h_franprev(j,0) = h_franprev(i,0); h_franprev(j,1) = h_franprev(i,1); diff --git a/src/KOKKOS/fix_neigh_history_kokkos.cpp b/src/KOKKOS/fix_neigh_history_kokkos.cpp index 848940c4b7..a43c5ef458 100644 --- a/src/KOKKOS/fix_neigh_history_kokkos.cpp +++ b/src/KOKKOS/fix_neigh_history_kokkos.cpp @@ -284,7 +284,7 @@ void FixNeighHistoryKokkos::grow_arrays(int nmax) ------------------------------------------------------------------------- */ template -void FixNeighHistoryKokkos::copy_arrays(int i, int j, int delflag) +void FixNeighHistoryKokkos::copy_arrays(int i, int j, int /*delflag*/) { k_npartner.template sync(); k_partner.template sync(); diff --git a/src/KOKKOS/fix_nh_kokkos.cpp b/src/KOKKOS/fix_nh_kokkos.cpp index 46993994b1..96e9663712 100644 --- a/src/KOKKOS/fix_nh_kokkos.cpp +++ b/src/KOKKOS/fix_nh_kokkos.cpp @@ -88,7 +88,7 @@ void FixNHKokkos::init() ------------------------------------------------------------------------- */ template -void FixNHKokkos::setup(int vflag) +void FixNHKokkos::setup(int /*vflag*/) { // t_target is needed by NPH and NPT in compute_scalar() // If no thermostat or using fix nphug, @@ -179,7 +179,7 @@ void FixNHKokkos::setup(int vflag) ------------------------------------------------------------------------- */ template -void FixNHKokkos::initial_integrate(int vflag) +void FixNHKokkos::initial_integrate(int /*vflag*/) { // update eta_press_dot diff --git a/src/KOKKOS/fix_qeq_reax_kokkos.cpp b/src/KOKKOS/fix_qeq_reax_kokkos.cpp index 7e798c740b..6d36669a86 100644 --- a/src/KOKKOS/fix_qeq_reax_kokkos.cpp +++ b/src/KOKKOS/fix_qeq_reax_kokkos.cpp @@ -53,7 +53,7 @@ FixQEqReaxKokkos(LAMMPS *lmp, int narg, char **arg) : datamask_read = X_MASK | V_MASK | F_MASK | MASK_MASK | Q_MASK | TYPE_MASK | TAG_MASK; datamask_modify = Q_MASK | X_MASK; - nmax = nmax = m_cap = 0; + nmax = m_cap = 0; allocated_flag = 0; nprev = 4; @@ -183,7 +183,7 @@ void FixQEqReaxKokkos::setup_pre_force(int vflag) /* ---------------------------------------------------------------------- */ template -void FixQEqReaxKokkos::pre_force(int vflag) +void FixQEqReaxKokkos::pre_force(int /*vflag*/) { if (update->ntimestep % nevery) return; @@ -1364,7 +1364,7 @@ void FixQEqReaxKokkos::calculate_q_item(int ii) const template int FixQEqReaxKokkos::pack_forward_comm(int n, int *list, double *buf, - int pbc_flag, int *pbc) + int /*pbc_flag*/, int * /*pbc*/) { int m; @@ -1473,7 +1473,7 @@ void FixQEqReaxKokkos::grow_arrays(int nmax) ------------------------------------------------------------------------- */ template -void FixQEqReaxKokkos::copy_arrays(int i, int j, int delflag) +void FixQEqReaxKokkos::copy_arrays(int i, int j, int /*delflag*/) { k_s_hist.template sync(); k_t_hist.template sync(); diff --git a/src/KOKKOS/fix_qeq_reax_kokkos.h b/src/KOKKOS/fix_qeq_reax_kokkos.h index 4eeb9294ef..bed532905e 100644 --- a/src/KOKKOS/fix_qeq_reax_kokkos.h +++ b/src/KOKKOS/fix_qeq_reax_kokkos.h @@ -267,8 +267,7 @@ struct FixQEqReaxKokkosComputeHFunctor { FixQEqReaxKokkosComputeHFunctor(FixQEqReaxKokkos *c_ptr, int _atoms_per_team, int _vector_length) - : c(*c_ptr), atoms_per_team(_atoms_per_team), - vector_length(_vector_length) { + : atoms_per_team(_atoms_per_team), vector_length(_vector_length), c(*c_ptr) { c.cleanup_copy(); }; diff --git a/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp b/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp index 51702bc603..3a706ece83 100644 --- a/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp +++ b/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp @@ -60,7 +60,7 @@ void FixReaxCBondsKokkos::init() /* ---------------------------------------------------------------------- */ -void FixReaxCBondsKokkos::Output_ReaxC_Bonds(bigint ntimestep, FILE *fp) +void FixReaxCBondsKokkos::Output_ReaxC_Bonds(bigint /*ntimestep*/, FILE * /*fp*/) { int nbuf_local; diff --git a/src/KOKKOS/fix_wall_lj93_kokkos.h b/src/KOKKOS/fix_wall_lj93_kokkos.h index 64f3c59a62..e7ff26bcf5 100644 --- a/src/KOKKOS/fix_wall_lj93_kokkos.h +++ b/src/KOKKOS/fix_wall_lj93_kokkos.h @@ -53,15 +53,15 @@ class FixWallLJ93Kokkos : public FixWallLJ93 { }; template -struct FixWallLJ93KokkosFunctor { +class FixWallLJ93KokkosFunctor { + public: typedef DeviceType device_type ; typedef double value_type[]; const int value_count; FixWallLJ93Kokkos c; FixWallLJ93KokkosFunctor(FixWallLJ93Kokkos* c_ptr): - c(*c_ptr), - value_count(c_ptr->m+1) {} + value_count(c_ptr->m+1), c(*c_ptr) {} KOKKOS_INLINE_FUNCTION void operator()(const int i, value_type ewall) const { c.wall_particle_item(i,ewall); diff --git a/src/KOKKOS/neighbor_kokkos.cpp b/src/KOKKOS/neighbor_kokkos.cpp index a594c8f7a0..9599aca00c 100644 --- a/src/KOKKOS/neighbor_kokkos.cpp +++ b/src/KOKKOS/neighbor_kokkos.cpp @@ -163,8 +163,6 @@ int NeighborKokkos::check_distance() template int NeighborKokkos::check_distance_kokkos() { - typedef DeviceType device_type; - double delx,dely,delz; double delta,delta1,delta2; @@ -216,7 +214,6 @@ int NeighborKokkos::check_distance_kokkos() template KOKKOS_INLINE_FUNCTION void NeighborKokkos::operator()(TagNeighborCheckDistance, const int &i, int &flag) const { - typedef DeviceType device_type; const X_FLOAT delx = x.view()(i,0) - xhold.view()(i,0); const X_FLOAT dely = x.view()(i,1) - xhold.view()(i,1); const X_FLOAT delz = x.view()(i,2) - xhold.view()(i,2); @@ -242,8 +239,6 @@ void NeighborKokkos::build(int topoflag) template void NeighborKokkos::build_kokkos(int topoflag) { - typedef DeviceType device_type; - int i,m; ago = 0; diff --git a/src/KOKKOS/npair_kokkos.cpp b/src/KOKKOS/npair_kokkos.cpp index 66daccc981..a1110f5e95 100644 --- a/src/KOKKOS/npair_kokkos.cpp +++ b/src/KOKKOS/npair_kokkos.cpp @@ -107,8 +107,8 @@ void NPairKokkos::copy_stencil_info() k_stencil = DAT::tdual_int_1d("neighlist:stencil",maxstencil); for (int k = 0; k < maxstencil; k++) k_stencil.h_view(k) = ns->stencil[k]; - k_stencil.modify(); - k_stencil.sync(); + k_stencil.modify(); + k_stencil.sync(); if (GHOST) { if (maxstencil > k_stencilxyz.extent(0)) k_stencilxyz = DAT::tdual_int_1d_3("neighlist:stencilxyz",maxstencil); diff --git a/src/KOKKOS/npair_kokkos.h b/src/KOKKOS/npair_kokkos.h index 06cd9a0dc7..038698376e 100644 --- a/src/KOKKOS/npair_kokkos.h +++ b/src/KOKKOS/npair_kokkos.h @@ -269,13 +269,13 @@ class NeighborKokkosExecute bincount(_bincount),c_bincount(_bincount),bins(_bins),c_bins(_bins), atom2bin(_atom2bin),c_atom2bin(_atom2bin), nstencil(_nstencil),d_stencil(_d_stencil),d_stencilxyz(_d_stencilxyz), - nlocal(_nlocal), x(_x),radius(_radius),type(_type),mask(_mask),molecule(_molecule), tag(_tag),special(_special),nspecial(_nspecial),molecular(_molecular), nbinx(_nbinx),nbiny(_nbiny),nbinz(_nbinz), mbinx(_mbinx),mbiny(_mbiny),mbinz(_mbinz), mbinxlo(_mbinxlo),mbinylo(_mbinylo),mbinzlo(_mbinzlo), bininvx(_bininvx),bininvy(_bininvy),bininvz(_bininvz), + nlocal(_nlocal), exclude(_exclude),nex_type(_nex_type), ex1_type(_ex1_type),ex2_type(_ex2_type),ex_type(_ex_type), nex_group(_nex_group), diff --git a/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp b/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp index a6af4708d5..afa8bd649a 100644 --- a/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp @@ -171,7 +171,8 @@ template template KOKKOS_INLINE_FUNCTION F_FLOAT PairBuckCoulCutKokkos:: -compute_fpair(const F_FLOAT& rsq, const int& i, const int&j, const int& itype, const int& jtype) const { +compute_fpair(const F_FLOAT& rsq, const int& /*i*/, const int& /*j*/, + const int& itype, const int& jtype) const { const F_FLOAT r2inv = 1.0/rsq; const F_FLOAT r6inv = r2inv*r2inv*r2inv; const F_FLOAT r = sqrt(rsq); @@ -191,7 +192,8 @@ template template KOKKOS_INLINE_FUNCTION F_FLOAT PairBuckCoulCutKokkos:: -compute_evdwl(const F_FLOAT& rsq, const int& i, const int&j, const int& itype, const int& jtype) const { +compute_evdwl(const F_FLOAT& rsq, const int& /*i*/, const int& /*j*/, + const int& itype, const int& jtype) const { const F_FLOAT r2inv = 1.0/rsq; const F_FLOAT r6inv = r2inv*r2inv*r2inv; const F_FLOAT r = sqrt(rsq); @@ -209,8 +211,8 @@ template template KOKKOS_INLINE_FUNCTION F_FLOAT PairBuckCoulCutKokkos:: -compute_fcoul(const F_FLOAT& rsq, const int& i, const int&j, - const int& itype, const int& jtype, const F_FLOAT& factor_coul, const F_FLOAT& qtmp) const { +compute_fcoul(const F_FLOAT& rsq, const int& /*i*/, const int&j, + const int& /*itype*/, const int& /*jtype*/, const F_FLOAT& factor_coul, const F_FLOAT& qtmp) const { const F_FLOAT r2inv = 1.0/rsq; const F_FLOAT rinv = sqrt(r2inv); F_FLOAT forcecoul; @@ -227,8 +229,8 @@ template template KOKKOS_INLINE_FUNCTION F_FLOAT PairBuckCoulCutKokkos:: -compute_ecoul(const F_FLOAT& rsq, const int& i, const int&j, - const int& itype, const int& jtype, const F_FLOAT& factor_coul, const F_FLOAT& qtmp) const { +compute_ecoul(const F_FLOAT& rsq, const int& /*i*/, const int& j, + const int& /*itype*/, const int& /*jtype*/, const F_FLOAT& factor_coul, const F_FLOAT& qtmp) const { const F_FLOAT r2inv = 1.0/rsq; const F_FLOAT rinv = sqrt(r2inv); diff --git a/src/KOKKOS/pair_kokkos.h b/src/KOKKOS/pair_kokkos.h index 938b0c38cb..820ecf08f8 100644 --- a/src/KOKKOS/pair_kokkos.h +++ b/src/KOKKOS/pair_kokkos.h @@ -712,7 +712,10 @@ EV_FLOAT pair_compute_neighlist (PairStyle* fpair, typename std::enable_if -int GetTeamSize(FunctorStyle& functor, int inum, int reduce_flag, int team_size, int KOKKOS_GPU_ARG(vector_length)) { +int GetTeamSize(FunctorStyle& KOKKOS_GPU_ARG(functor), int KOKKOS_GPU_ARG(inum), + int KOKKOS_GPU_ARG(reduce_flag), int team_size, int KOKKOS_GPU_ARG(vector_length)) { + +#ifdef LMP_KOKKOS_GPU int team_size_max; if (reduce_flag) @@ -720,7 +723,6 @@ int GetTeamSize(FunctorStyle& functor, int inum, int reduce_flag, int team_size, else team_size_max = Kokkos::TeamPolicy<>(inum,Kokkos::AUTO).team_size_max(functor,Kokkos::ParallelForTag()); -#ifdef LMP_KOKKOS_GPU if(team_size*vector_length > team_size_max) team_size = team_size_max/vector_length; #else diff --git a/src/KOKKOS/pppm_kokkos.cpp b/src/KOKKOS/pppm_kokkos.cpp index 743f2daec9..3cb87c14a2 100644 --- a/src/KOKKOS/pppm_kokkos.cpp +++ b/src/KOKKOS/pppm_kokkos.cpp @@ -1479,7 +1479,7 @@ void PPPMKokkos::compute_gf_ik_triclinic() template KOKKOS_INLINE_FUNCTION -void PPPMKokkos::operator()(TagPPPM_compute_gf_ik_triclinic, const int &m) const +void PPPMKokkos::operator()(TagPPPM_compute_gf_ik_triclinic, const int &/*m*/) const { //int n = (m - nzlo_fft)*(nyhi_fft+1 - nylo_fft)*(nxhi_fft+1 - nxlo_fft); // @@ -2085,14 +2085,14 @@ void PPPMKokkos::poisson_ik_triclinic() template KOKKOS_INLINE_FUNCTION -void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic1, const int &k) const +void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic1, const int &/*k*/) const { } template KOKKOS_INLINE_FUNCTION -void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic2, const int &k) const +void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic2, const int &/*k*/) const { // for (j = nylo_in-nylo_out; j <= nyhi_in-nylo_out; j++) // for (i = nxlo_in-nxlo_out; i <= nxhi_in-nxlo_out; i++) { @@ -2103,7 +2103,7 @@ void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic2, const int template KOKKOS_INLINE_FUNCTION -void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic3, const int &k) const +void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic3, const int &/*k*/) const { // int n = (k - (nzlo_in-nzlo_out))*((nyhi_in-nylo_out) - (nylo_in-nylo_out) + 1)*((nxhi_in-nxlo_out) - (nxlo_in-nxlo_out) + 1)*2; @@ -2111,7 +2111,7 @@ void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic3, const int template KOKKOS_INLINE_FUNCTION -void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic4, const int &k) const +void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic4, const int &/*k*/) const { // int n = (k - (nzlo_in-nzlo_out))*((nyhi_in-nylo_out) - (nylo_in-nylo_out) + 1)*((nxhi_in-nxlo_out) - (nxlo_in-nxlo_out) + 1)*2; // @@ -2119,7 +2119,7 @@ void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic4, const int template KOKKOS_INLINE_FUNCTION -void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic5, const int &k) const +void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic5, const int &/*k*/) const { // int n = (k - (nzlo_in-nzlo_out))*((nyhi_in-nylo_out) - (nylo_in-nylo_out) + 1)*((nxhi_in-nxlo_out) - (nxlo_in-nxlo_out) + 1)*2; // @@ -2127,7 +2127,7 @@ void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic5, const int template KOKKOS_INLINE_FUNCTION -void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic6, const int &k) const +void PPPMKokkos::operator()(TagPPPM_poisson_ik_triclinic6, const int &/*k*/) const { // int n = (k - (nzlo_in-nzlo_out))*((nyhi_in-nylo_out) - (nylo_in-nylo_out) + 1)*((nxhi_in-nxlo_out) - (nxlo_in-nxlo_out) + 1)*2; // @@ -2681,7 +2681,7 @@ void PPPMKokkos::operator()(TagPPPM_unpack_forward2, const int &i) c ------------------------------------------------------------------------- */ template -void PPPMKokkos::pack_reverse_kspace_kokkos(int flag, FFT_DAT::tdual_FFT_SCALAR_1d &k_buf, int nlist, DAT::tdual_int_2d &k_list, int index) +void PPPMKokkos::pack_reverse_kspace_kokkos(int /*flag*/, FFT_DAT::tdual_FFT_SCALAR_1d &k_buf, int nlist, DAT::tdual_int_2d &k_list, int index) { typename AT::t_int_2d_um d_list = k_list.view(); d_list_index = Kokkos::subview(d_list,index,Kokkos::ALL()); @@ -2711,7 +2711,7 @@ void PPPMKokkos::operator()(TagPPPM_pack_reverse, const int &i) cons ------------------------------------------------------------------------- */ template -void PPPMKokkos::unpack_reverse_kspace_kokkos(int flag, FFT_DAT::tdual_FFT_SCALAR_1d &k_buf, int nlist, DAT::tdual_int_2d &k_list, int index) +void PPPMKokkos::unpack_reverse_kspace_kokkos(int /*flag*/, FFT_DAT::tdual_FFT_SCALAR_1d &k_buf, int nlist, DAT::tdual_int_2d &k_list, int index) { typename AT::t_int_2d_um d_list = k_list.view(); d_list_index = Kokkos::subview(d_list,index,Kokkos::ALL()); diff --git a/src/KOKKOS/remap_kokkos.cpp b/src/KOKKOS/remap_kokkos.cpp index 2894009887..d496db05e2 100644 --- a/src/KOKKOS/remap_kokkos.cpp +++ b/src/KOKKOS/remap_kokkos.cpp @@ -220,7 +220,7 @@ struct remap_plan_3d_kokkos* RemapKokkos::remap_3d_creat int in_klo, int in_khi, int out_ilo, int out_ihi, int out_jlo, int out_jhi, int out_klo, int out_khi, - int nqty, int permute, int memory, int precision, + int nqty, int permute, int memory, int /*precision*/, int usecollective, int usecuda_aware) {