From 92a4dc25b1f402a345c41e1f8791a60f6df5acd4 Mon Sep 17 00:00:00 2001
From: Daniel Schwen <daniel.schwen@inl.gov>
Date: Fri, 24 Aug 2018 09:51:38 -0600
Subject: [PATCH] Fix unused params in packages (#1076)

---
 src/ASPHERE/fix_nve_asphere.cpp               |  2 +-
 src/ASPHERE/fix_nve_asphere_noforce.cpp       |  2 +-
 src/ASPHERE/fix_nve_line.cpp                  |  2 +-
 src/ASPHERE/fix_nve_tri.cpp                   |  2 +-
 src/BODY/body_nparticle.cpp                   |  4 +--
 src/BODY/body_rounded_polygon.cpp             |  4 +--
 src/BODY/body_rounded_polyhedron.cpp          |  4 +--
 src/BODY/fix_nve_body.cpp                     |  2 +-
 src/BODY/fix_wall_body_polygon.cpp            |  4 +--
 src/BODY/fix_wall_body_polyhedron.cpp         | 12 ++++-----
 src/BODY/pair_body_rounded_polygon.cpp        |  4 +--
 src/CLASS2/bond_class2.cpp                    |  2 +-
 src/CLASS2/improper_class2.cpp                |  2 +-
 src/CLASS2/pair_lj_class2.cpp                 |  4 +--
 src/COLLOID/pair_colloid.cpp                  |  4 +--
 src/COLLOID/pair_lubricate.cpp                |  6 ++---
 src/COLLOID/pair_lubricateU.cpp               |  2 +-
 src/COLLOID/pair_yukawa_colloid.cpp           |  4 +--
 src/KSPACE/pair_coul_long.cpp                 |  4 +--
 src/KSPACE/pair_coul_msm.cpp                  |  4 +--
 src/KSPACE/pppm_disp.cpp                      |  2 +-
 src/KSPACE/remap.cpp                          |  2 +-
 src/LATTE/fix_latte.cpp                       |  6 ++---
 src/MANYBODY/fix_qeq_comb.cpp                 |  6 ++---
 src/MANYBODY/pair_adp.cpp                     |  6 ++---
 src/MANYBODY/pair_airebo.cpp                  |  8 +++---
 src/MANYBODY/pair_comb.cpp                    |  8 +++---
 src/MANYBODY/pair_comb3.cpp                   | 20 +++++++-------
 src/MANYBODY/pair_eam.cpp                     |  6 ++---
 src/MANYBODY/pair_eam_cd.cpp                  |  2 +-
 src/MANYBODY/pair_eim.cpp                     |  6 ++---
 src/MANYBODY/pair_gw.cpp                      |  2 +-
 src/MANYBODY/pair_lcbop.cpp                   |  6 ++---
 src/MANYBODY/pair_nb3b_harmonic.cpp           |  4 +--
 src/MANYBODY/pair_polymorphic.cpp             |  2 +-
 src/MANYBODY/pair_rebo.cpp                    |  2 +-
 src/MANYBODY/pair_sw.cpp                      |  2 +-
 src/MANYBODY/pair_tersoff.cpp                 |  2 +-
 src/MANYBODY/pair_vashishta.cpp               |  2 +-
 src/MC/fix_atom_swap.cpp                      |  2 +-
 src/MC/fix_bond_break.cpp                     |  4 +--
 src/MC/fix_bond_create.cpp                    | 10 +++----
 src/MC/fix_bond_swap.cpp                      |  2 +-
 src/MC/fix_tfmc.cpp                           |  2 +-
 src/MC/pair_dsmc.cpp                          |  6 ++---
 src/MEAM/pair_meam.cpp                        |  6 ++---
 src/MISC/fix_efield.cpp                       |  2 +-
 src/MISC/fix_gld.cpp                          | 10 +++----
 src/MISC/fix_orient_bcc.cpp                   |  8 +++---
 src/MISC/fix_orient_fcc.cpp                   |  8 +++---
 src/MISC/fix_ttm.cpp                          | 10 +++----
 src/MISC/pair_nm_cut.cpp                      |  4 +--
 src/MISC/xdr_compat.cpp                       |  2 +-
 src/MOLECULE/angle_cosine.cpp                 |  2 +-
 src/MOLECULE/angle_cosine_periodic.cpp        |  2 +-
 src/MOLECULE/bond_fene.cpp                    |  2 +-
 src/MOLECULE/bond_fene_expand.cpp             |  2 +-
 src/MOLECULE/bond_gromos.cpp                  |  2 +-
 src/MOLECULE/bond_harmonic.cpp                |  2 +-
 src/MOLECULE/bond_morse.cpp                   |  2 +-
 src/MOLECULE/bond_nonlinear.cpp               |  2 +-
 src/MOLECULE/bond_quartic.cpp                 |  2 +-
 src/MOLECULE/bond_table.cpp                   |  2 +-
 src/MOLECULE/fix_cmap.cpp                     | 18 ++++++-------
 src/MOLECULE/pair_hbond_dreiding_lj.cpp       |  2 +-
 src/MOLECULE/pair_hbond_dreiding_morse.cpp    |  2 +-
 src/MOLECULE/pair_tip4p_cut.cpp               |  2 +-
 src/PERI/fix_peri_neigh.cpp                   |  8 +++---
 src/PERI/pair_peri_eps.cpp                    |  4 +--
 src/PERI/pair_peri_lps.cpp                    |  4 +--
 src/PERI/pair_peri_pmb.cpp                    |  4 +--
 src/PERI/pair_peri_ves.cpp                    |  4 +--
 src/QEQ/fix_qeq.cpp                           |  8 +++---
 src/QEQ/fix_qeq_dynamic.cpp                   |  4 +--
 src/QEQ/fix_qeq_fire.cpp                      |  4 +--
 src/QEQ/fix_qeq_point.cpp                     |  2 +-
 src/QEQ/fix_qeq_shielded.cpp                  |  2 +-
 src/QEQ/fix_qeq_slater.cpp                    |  2 +-
 src/REPLICA/fix_event.cpp                     |  2 +-
 src/REPLICA/fix_neb.cpp                       |  2 +-
 src/RIGID/fix_rattle.cpp                      |  4 +--
 src/RIGID/fix_rigid.cpp                       |  8 +++---
 src/RIGID/fix_rigid_small.cpp                 |  8 +++---
 src/RIGID/fix_shake.cpp                       |  4 +--
 src/SHOCK/fix_append_atoms.cpp                |  4 +--
 src/SHOCK/fix_msst.cpp                        |  4 +--
 src/SHOCK/fix_wall_piston.cpp                 |  2 +-
 src/SNAP/compute_sna_atom.cpp                 |  2 +-
 src/SNAP/compute_snad_atom.cpp                |  2 +-
 src/SNAP/compute_snav_atom.cpp                |  2 +-
 src/SNAP/sna.cpp                              |  2 +-
 src/SPIN/atom_vec_spin.cpp                    |  2 +-
 src/SPIN/fix_langevin_spin.cpp                |  2 +-
 src/SPIN/fix_nve_spin.cpp                     |  2 +-
 src/SPIN/fix_precession_spin.cpp              |  4 +--
 src/SPIN/pair_spin.cpp                        |  2 +-
 src/SPIN/pair_spin_dmi.cpp                    |  2 +-
 src/SPIN/pair_spin_magelec.cpp                |  2 +-
 src/SRD/fix_srd.cpp                           | 12 ++++-----
 src/USER-BOCS/fix_bocs.cpp                    |  8 +++---
 src/USER-CGDNA/bond_oxdna_fene.cpp            |  4 +--
 src/USER-CGDNA/fix_nve_dot.cpp                |  2 +-
 src/USER-CGDNA/fix_nve_dotc_langevin.cpp      |  2 +-
 src/USER-CGDNA/pair_oxdna2_coaxstk.cpp        |  2 +-
 src/USER-CGDNA/pair_oxdna2_dh.cpp             |  2 +-
 src/USER-CGDNA/pair_oxdna_coaxstk.cpp         |  2 +-
 src/USER-CGDNA/pair_oxdna_excv.cpp            |  4 +--
 src/USER-CGDNA/pair_oxdna_hbond.cpp           |  2 +-
 src/USER-CGDNA/pair_oxdna_stk.cpp             |  2 +-
 src/USER-CGDNA/pair_oxdna_xstk.cpp            |  2 +-
 src/USER-DIFFRACTION/fix_saed_vtk.cpp         |  2 +-
 src/USER-DPD/fix_dpd_energy.cpp               |  2 +-
 src/USER-DPD/fix_eos_table_rx.cpp             |  4 +--
 src/USER-DPD/fix_rx.cpp                       | 12 ++++-----
 src/USER-DPD/fix_shardlow.cpp                 |  8 +++---
 src/USER-DPD/pair_dpd_fdt.cpp                 |  4 +--
 src/USER-DPD/pair_dpd_fdt_energy.cpp          |  4 +--
 src/USER-DPD/pair_multi_lucy.cpp              |  2 +-
 src/USER-DPD/pair_multi_lucy_rx.cpp           |  2 +-
 src/USER-DPD/pair_table_rx.cpp                |  2 +-
 src/USER-DRUDE/fix_drude.cpp                  |  2 +-
 src/USER-DRUDE/fix_langevin_drude.cpp         |  2 +-
 src/USER-DRUDE/pair_thole.cpp                 |  2 +-
 src/USER-EFF/compute_temp_deform_eff.cpp      |  2 +-
 src/USER-EFF/compute_temp_region_eff.cpp      |  2 +-
 src/USER-EFF/fix_langevin_eff.cpp             |  2 +-
 src/USER-EFF/fix_nve_eff.cpp                  |  6 ++---
 src/USER-EFF/pair_eff_cut.cpp                 |  6 ++---
 src/USER-FEP/fix_adapt_fep.cpp                |  4 +--
 src/USER-FEP/pair_coul_cut_soft.cpp           |  2 +-
 src/USER-FEP/pair_coul_long_soft.cpp          |  2 +-
 src/USER-FEP/pair_lj_cut_soft.cpp             |  4 +--
 src/USER-FEP/pair_morse_soft.cpp              |  4 +--
 src/USER-INTEL/angle_charmm_intel.cpp         |  2 +-
 src/USER-INTEL/angle_harmonic_intel.cpp       |  2 +-
 src/USER-INTEL/bond_fene_intel.cpp            |  2 +-
 src/USER-INTEL/bond_harmonic_intel.cpp        |  2 +-
 src/USER-INTEL/dihedral_fourier_intel.cpp     |  2 +-
 src/USER-INTEL/dihedral_harmonic_intel.cpp    |  2 +-
 src/USER-INTEL/dihedral_opls_intel.cpp        |  2 +-
 src/USER-INTEL/fix_intel.cpp                  |  8 +++---
 src/USER-INTEL/fix_intel.h                    | 14 +++++-----
 src/USER-INTEL/fix_nve_asphere_intel.cpp      |  2 +-
 src/USER-INTEL/fix_nve_intel.cpp              |  2 +-
 src/USER-INTEL/improper_cvff_intel.cpp        |  2 +-
 src/USER-INTEL/improper_harmonic_intel.cpp    |  2 +-
 src/USER-INTEL/intel_buffers.cpp              | 14 +++++-----
 src/USER-INTEL/intel_buffers.h                | 10 +++----
 src/USER-INTEL/intel_intrinsics_airebo.h      |  4 +--
 src/USER-INTEL/npair_full_bin_ghost_intel.cpp |  2 +-
 src/USER-INTEL/npair_intel.cpp                |  4 +--
 src/USER-INTEL/pair_airebo_intel.cpp          | 14 +++++-----
 src/USER-INTEL/pair_eam_intel.cpp             |  2 +-
 src/USER-INTEL/pair_rebo_intel.cpp            |  2 +-
 src/USER-INTEL/pair_sw_intel.cpp              |  2 +-
 src/USER-INTEL/pppm_disp_intel.cpp            | 26 +++++++++----------
 src/USER-INTEL/pppm_intel.cpp                 |  2 +-
 src/USER-LB/fix_lb_fluid.cpp                  |  8 +++---
 src/USER-LB/fix_lb_pc.cpp                     |  4 +--
 src/USER-LB/fix_lb_rigid_pc_sphere.cpp        |  2 +-
 src/USER-LB/fix_lb_viscous.cpp                |  4 +--
 src/USER-MANIFOLD/fix_manifoldforce.cpp       |  4 +--
 src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp |  4 +--
 src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp |  4 +--
 src/USER-MANIFOLD/manifold.h                  |  2 +-
 src/USER-MANIFOLD/manifold_cylinder.cpp       |  4 +--
 src/USER-MANIFOLD/manifold_cylinder_dent.cpp  |  4 +--
 src/USER-MANIFOLD/manifold_dumbbell.cpp       |  2 +-
 src/USER-MANIFOLD/manifold_ellipsoid.cpp      |  2 +-
 src/USER-MANIFOLD/manifold_gaussian_bump.cpp  |  2 +-
 src/USER-MANIFOLD/manifold_plane.cpp          |  4 +--
 src/USER-MANIFOLD/manifold_plane_wiggle.cpp   |  2 +-
 src/USER-MANIFOLD/manifold_spine.cpp          |  2 +-
 src/USER-MANIFOLD/manifold_thylakoid.cpp      |  4 +--
 src/USER-MANIFOLD/manifold_torus.cpp          |  2 +-
 src/USER-MEAMC/meam_dens_final.cpp            |  2 +-
 src/USER-MEAMC/meam_dens_init.cpp             |  4 +--
 src/USER-MEAMC/meam_force.cpp                 |  2 +-
 src/USER-MEAMC/meam_setup_global.cpp          |  2 +-
 src/USER-MEAMC/pair_meamc.cpp                 |  6 ++---
 src/USER-MESO/fix_edpd_source.cpp             |  2 +-
 src/USER-MESO/fix_mvv_dpd.cpp                 |  2 +-
 src/USER-MESO/fix_mvv_edpd.cpp                |  2 +-
 src/USER-MESO/fix_mvv_tdpd.cpp                |  2 +-
 src/USER-MESO/fix_tdpd_source.cpp             |  2 +-
 src/USER-MESO/pair_edpd.cpp                   |  2 +-
 src/USER-MESO/pair_mdpd_rhosum.cpp            |  8 +++---
 src/USER-MESO/pair_tdpd.cpp                   |  4 +--
 src/USER-MGPT/pair_mgpt.cpp                   |  6 ++---
 src/USER-MISC/angle_dipole.cpp                |  2 +-
 src/USER-MISC/bond_harmonic_shift.cpp         |  2 +-
 src/USER-MISC/bond_harmonic_shift_cut.cpp     |  2 +-
 src/USER-MISC/compute_ackland_atom.cpp        |  2 +-
 src/USER-MISC/compute_basal_atom.cpp          |  2 +-
 src/USER-MISC/compute_cnp_atom.cpp            |  2 +-
 src/USER-MISC/compute_entropy_atom.cpp        |  2 +-
 src/USER-MISC/fix_addtorque.cpp               |  4 +--
 src/USER-MISC/fix_ave_correlate_long.cpp      |  2 +-
 src/USER-MISC/fix_bond_react.cpp              |  6 ++---
 src/USER-MISC/fix_filter_corotate.cpp         |  8 +++---
 src/USER-MISC/fix_flow_gauss.cpp              |  4 +--
 src/USER-MISC/fix_gle.cpp                     | 10 +++----
 src/USER-MISC/fix_grem.cpp                    |  2 +-
 src/USER-MISC/fix_imd.cpp                     |  4 +--
 src/USER-MISC/fix_ipi.cpp                     |  2 +-
 src/USER-MISC/fix_nvk.cpp                     |  6 ++---
 src/USER-MISC/fix_pimd.cpp                    | 10 +++----
 src/USER-MISC/fix_rhok.cpp                    |  4 +--
 src/USER-MISC/fix_smd.cpp                     |  2 +-
 src/USER-MISC/fix_srp.cpp                     |  8 +++---
 src/USER-MISC/fix_ti_spring.cpp               | 10 +++----
 src/USER-MISC/fix_ttm_mod.cpp                 | 10 +++----
 src/USER-MISC/fix_wall_region_ees.cpp         |  4 +--
 src/USER-MISC/pair_agni.cpp                   |  2 +-
 src/USER-MISC/pair_buck_mdf.cpp               |  4 +--
 src/USER-MISC/pair_coul_diel.cpp              |  2 +-
 src/USER-MISC/pair_coul_shield.cpp            |  2 +-
 src/USER-MISC/pair_edip.cpp                   |  2 +-
 src/USER-MISC/pair_edip_multi.cpp             |  2 +-
 src/USER-MISC/pair_extep.cpp                  |  2 +-
 src/USER-MISC/pair_gauss_cut.cpp              |  4 +--
 src/USER-MISC/pair_ilp_graphene_hbn.cpp       |  6 ++---
 src/USER-MISC/pair_kolmogorov_crespi_full.cpp |  6 ++---
 src/USER-MISC/pair_lennard_mdf.cpp            |  4 +--
 src/USER-MISC/pair_lj_mdf.cpp                 |  4 +--
 src/USER-MISC/pair_meam_spline.cpp            | 10 +++----
 src/USER-MISC/pair_meam_sw_spline.cpp         | 10 +++----
 src/USER-MISC/pair_momb.cpp                   |  4 +--
 src/USER-MISC/pair_morse_smooth_linear.cpp    |  4 +--
 src/USER-MISC/pair_tersoff_table.cpp          |  2 +-
 src/USER-MOFFF/angle_cosine_buck6d.cpp        |  2 +-
 src/USER-PHONON/fix_phonon.cpp                |  2 +-
 src/USER-QTB/fix_qbmsst.cpp                   |  6 ++---
 src/USER-QTB/fix_qtb.cpp                      |  6 ++---
 src/USER-QUIP/pair_quip.cpp                   |  4 +--
 src/USER-REAXC/fix_qeq_reax.cpp               | 10 +++----
 src/USER-REAXC/fix_reaxc.cpp                  |  4 +--
 src/USER-REAXC/fix_reaxc_bonds.cpp            |  6 ++---
 src/USER-REAXC/fix_reaxc_species.cpp          |  8 +++---
 src/USER-REAXC/pair_reaxc.cpp                 |  2 +-
 src/USER-REAXC/reaxc_allocate.cpp             | 14 +++++-----
 src/USER-REAXC/reaxc_bond_orders.cpp          |  4 +--
 src/USER-REAXC/reaxc_bonds.cpp                |  4 +--
 src/USER-REAXC/reaxc_forces.cpp               | 20 +++++++-------
 src/USER-REAXC/reaxc_hydrogen_bonds.cpp       |  2 +-
 src/USER-REAXC/reaxc_init_md.cpp              | 12 ++++-----
 src/USER-REAXC/reaxc_io_tools.cpp             |  2 +-
 src/USER-REAXC/reaxc_lookup.cpp               |  2 +-
 src/USER-REAXC/reaxc_multi_body.cpp           |  2 +-
 src/USER-REAXC/reaxc_nonbonded.cpp            |  4 +--
 src/USER-REAXC/reaxc_reset_tools.cpp          |  2 +-
 src/USER-REAXC/reaxc_torsion_angles.cpp       |  2 +-
 src/USER-REAXC/reaxc_traj.cpp                 |  6 ++---
 src/USER-REAXC/reaxc_valence_angles.cpp       |  2 +-
 src/USER-SMD/atom_vec_smd.cpp                 | 20 +++++++-------
 src/USER-SMD/fix_smd_adjust_dt.cpp            |  4 +--
 src/USER-SMD/fix_smd_integrate_tlsph.cpp      |  2 +-
 src/USER-SMD/fix_smd_integrate_ulsph.cpp      |  2 +-
 .../fix_smd_move_triangulated_surface.cpp     |  4 +--
 src/USER-SMD/fix_smd_setvel.cpp               |  2 +-
 .../fix_smd_tlsph_reference_configuration.cpp |  8 +++---
 src/USER-SMD/fix_smd_wall_surface.cpp         |  2 +-
 src/USER-SMD/pair_smd_hertz.cpp               |  2 +-
 src/USER-SMD/pair_smd_tlsph.cpp               |  8 +++---
 .../pair_smd_triangulated_surface.cpp         |  2 +-
 src/USER-SMD/pair_smd_ulsph.cpp               |  4 +--
 src/USER-SMD/smd_material_models.cpp          |  4 +--
 src/USER-SMTBQ/pair_smtbq.cpp                 | 18 ++++++-------
 src/USER-SPH/fix_meso.cpp                     |  4 +--
 src/USER-SPH/fix_meso_stationary.cpp          |  2 +-
 src/USER-SPH/pair_sph_heatconduction.cpp      |  6 ++---
 src/USER-SPH/pair_sph_idealgas.cpp            |  6 ++---
 src/USER-SPH/pair_sph_lj.cpp                  |  6 ++---
 src/USER-SPH/pair_sph_rhosum.cpp              |  6 ++---
 src/USER-SPH/pair_sph_taitwater.cpp           |  6 ++---
 src/USER-SPH/pair_sph_taitwater_morris.cpp    |  6 ++---
 src/USER-UEF/fix_nh_uef.cpp                   |  2 +-
 277 files changed, 594 insertions(+), 594 deletions(-)

diff --git a/src/ASPHERE/fix_nve_asphere.cpp b/src/ASPHERE/fix_nve_asphere.cpp
index a33848f1a1..61e3c35293 100644
--- a/src/ASPHERE/fix_nve_asphere.cpp
+++ b/src/ASPHERE/fix_nve_asphere.cpp
@@ -62,7 +62,7 @@ void FixNVEAsphere::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEAsphere::initial_integrate(int vflag)
+void FixNVEAsphere::initial_integrate(int /*vflag*/)
 {
   double dtfm;
   double inertia[3],omega[3];
diff --git a/src/ASPHERE/fix_nve_asphere_noforce.cpp b/src/ASPHERE/fix_nve_asphere_noforce.cpp
index d944b68f35..9cc430592a 100644
--- a/src/ASPHERE/fix_nve_asphere_noforce.cpp
+++ b/src/ASPHERE/fix_nve_asphere_noforce.cpp
@@ -64,7 +64,7 @@ void FixNVEAsphereNoforce::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEAsphereNoforce::initial_integrate(int vflag)
+void FixNVEAsphereNoforce::initial_integrate(int /*vflag*/)
 {
   AtomVecEllipsoid::Bonus *bonus;
   if (avec) bonus = avec->bonus;
diff --git a/src/ASPHERE/fix_nve_line.cpp b/src/ASPHERE/fix_nve_line.cpp
index c145e99fcb..51a502df89 100644
--- a/src/ASPHERE/fix_nve_line.cpp
+++ b/src/ASPHERE/fix_nve_line.cpp
@@ -81,7 +81,7 @@ void FixNVELine::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVELine::initial_integrate(int vflag)
+void FixNVELine::initial_integrate(int /*vflag*/)
 {
   double dtfm,dtirotate,length,theta;
 
diff --git a/src/ASPHERE/fix_nve_tri.cpp b/src/ASPHERE/fix_nve_tri.cpp
index d06063d905..fb9bf64c58 100644
--- a/src/ASPHERE/fix_nve_tri.cpp
+++ b/src/ASPHERE/fix_nve_tri.cpp
@@ -75,7 +75,7 @@ void FixNVETri::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVETri::initial_integrate(int vflag)
+void FixNVETri::initial_integrate(int /*vflag*/)
 {
   double dtfm;
   double omega[3];
diff --git a/src/BODY/body_nparticle.cpp b/src/BODY/body_nparticle.cpp
index 684e5768da..10529ad3af 100644
--- a/src/BODY/body_nparticle.cpp
+++ b/src/BODY/body_nparticle.cpp
@@ -195,7 +195,7 @@ void BodyNparticle::data_body(int ibonus, int ninteger, int ndouble,
    called by Molecule class which needs single body size
 ------------------------------------------------------------------------- */
 
-double BodyNparticle::radius_body(int ninteger, int ndouble,
+double BodyNparticle::radius_body(int /*ninteger*/, int ndouble,
                                   int *ifile, double *dfile)
 {
   int nsub = ifile[0];
@@ -258,7 +258,7 @@ void BodyNparticle::output(int ibonus, int m, double *values)
 
 /* ---------------------------------------------------------------------- */
 
-int BodyNparticle::image(int ibonus, double flag1, double flag2,
+int BodyNparticle::image(int ibonus, double flag1, double /*flag2*/,
                          int *&ivec, double **&darray)
 {
   double p[3][3];
diff --git a/src/BODY/body_rounded_polygon.cpp b/src/BODY/body_rounded_polygon.cpp
index 1e232f0f3f..00a09c912d 100644
--- a/src/BODY/body_rounded_polygon.cpp
+++ b/src/BODY/body_rounded_polygon.cpp
@@ -323,7 +323,7 @@ void BodyRoundedPolygon::data_body(int ibonus, int ninteger, int ndouble,
    called by Molecule class which needs single body size
 ------------------------------------------------------------------------- */
 
-double BodyRoundedPolygon::radius_body(int ninteger, int ndouble,
+double BodyRoundedPolygon::radius_body(int /*ninteger*/, int ndouble,
 				       int *ifile, double *dfile)
 {
   int nsub = ifile[0];
@@ -392,7 +392,7 @@ void BodyRoundedPolygon::output(int ibonus, int m, double *values)
 
 /* ---------------------------------------------------------------------- */
 
-int BodyRoundedPolygon::image(int ibonus, double flag1, double flag2,
+int BodyRoundedPolygon::image(int ibonus, double flag1, double /*flag2*/,
                               int *&ivec, double **&darray)
 {
   int j;
diff --git a/src/BODY/body_rounded_polyhedron.cpp b/src/BODY/body_rounded_polyhedron.cpp
index 6a9b97ae23..5ba4bce8e8 100644
--- a/src/BODY/body_rounded_polyhedron.cpp
+++ b/src/BODY/body_rounded_polyhedron.cpp
@@ -381,7 +381,7 @@ void BodyRoundedPolyhedron::data_body(int ibonus, int ninteger, int ndouble,
    called by Molecule class which needs single body size
 ------------------------------------------------------------------------- */
 
-double BodyRoundedPolyhedron::radius_body(int ninteger, int ndouble,
+double BodyRoundedPolyhedron::radius_body(int /*ninteger*/, int ndouble,
 				       int *ifile, double *dfile)
 {
   int nsub = ifile[0];
@@ -460,7 +460,7 @@ void BodyRoundedPolyhedron::output(int ibonus, int m, double *values)
 
 /* ---------------------------------------------------------------------- */
 
-int BodyRoundedPolyhedron::image(int ibonus, double flag1, double flag2,
+int BodyRoundedPolyhedron::image(int ibonus, double flag1, double /*flag2*/,
                               int *&ivec, double **&darray)
 {
   int j, nelements;
diff --git a/src/BODY/fix_nve_body.cpp b/src/BODY/fix_nve_body.cpp
index 0606723cb7..0c74facf34 100644
--- a/src/BODY/fix_nve_body.cpp
+++ b/src/BODY/fix_nve_body.cpp
@@ -54,7 +54,7 @@ void FixNVEBody::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEBody::initial_integrate(int vflag)
+void FixNVEBody::initial_integrate(int /*vflag*/)
 {
   double dtfm;
   double omega[3];
diff --git a/src/BODY/fix_wall_body_polygon.cpp b/src/BODY/fix_wall_body_polygon.cpp
index 0e7aaea1e1..f217db774e 100644
--- a/src/BODY/fix_wall_body_polygon.cpp
+++ b/src/BODY/fix_wall_body_polygon.cpp
@@ -204,7 +204,7 @@ void FixWallBodyPolygon::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixWallBodyPolygon::post_force(int vflag)
+void FixWallBodyPolygon::post_force(int /*vflag*/)
 {
   double vwall[3],dx,dy,dz,del1,del2,delxy,delr,rsq,eradi,rradi,wall_pos;
   int i,ni,npi,ifirst,nei,iefirst,side;
@@ -475,7 +475,7 @@ void FixWallBodyPolygon::body2space(int i)
 
 int FixWallBodyPolygon::vertex_against_wall(int i, double wall_pos,
                 double** x, double** f, double** torque, int side,
-                Contact* contact_list, int &num_contacts, double* facc)
+                Contact* contact_list, int &num_contacts, double* /*facc*/)
 {
   int ni, npi, ifirst, interact;
   double xpi[3], xpj[3], dist, eradi, rradi;
diff --git a/src/BODY/fix_wall_body_polyhedron.cpp b/src/BODY/fix_wall_body_polyhedron.cpp
index 17e9f0b8b5..b90731acf6 100644
--- a/src/BODY/fix_wall_body_polyhedron.cpp
+++ b/src/BODY/fix_wall_body_polyhedron.cpp
@@ -211,7 +211,7 @@ void FixWallBodyPolyhedron::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixWallBodyPolyhedron::post_force(int vflag)
+void FixWallBodyPolyhedron::post_force(int /*vflag*/)
 {
   double vwall[3],dx,dy,dz,del1,del2,delxy,delr,rsq,eradi,rradi,wall_pos;
   int i,ni,npi,ifirst,nei,iefirst,nfi,iffirst,side;
@@ -485,7 +485,7 @@ void FixWallBodyPolyhedron::body2space(int i)
 ---------------------------------------------------------------------- */
 
 int FixWallBodyPolyhedron::sphere_against_wall(int i, double wall_pos,
-     int side, double* vwall, double** x, double** v, double** f,
+     int /*side*/, double* vwall, double** x, double** v, double** f,
      double** angmom, double** torque)
 {
   int mode;
@@ -545,8 +545,8 @@ int FixWallBodyPolyhedron::sphere_against_wall(int i, double wall_pos,
 ---------------------------------------------------------------------- */
 
 int FixWallBodyPolyhedron::edge_against_wall(int i, double wall_pos,
-     int side, double* vwall, double** x, double** f, double** torque,
-     Contact* contact_list, int &num_contacts, double* facc)
+     int side, double* vwall, double** x, double** /*f*/, double** /*torque*/,
+     Contact* /*contact_list*/, int &/*num_contacts*/, double* /*facc*/)
 {
   int ni, nei, mode, contact;
   double rradi;
@@ -584,7 +584,7 @@ int FixWallBodyPolyhedron::edge_against_wall(int i, double wall_pos,
 
 int FixWallBodyPolyhedron::compute_distance_to_wall(int ibody, int edge_index,
                         double *xmi, double rounded_radius_i, double wall_pos, 
-                        int side, double* vwall, int &contact)
+                        int /*side*/, double* vwall, int &contact)
 {
   int mode,ifirst,iefirst,npi1,npi2;
   double d1,d2,xpi1[3],xpi2[3],hi[3];
@@ -698,7 +698,7 @@ int FixWallBodyPolyhedron::compute_distance_to_wall(int ibody, int edge_index,
 ------------------------------------------------------------------------- */
 
 void FixWallBodyPolyhedron::contact_forces(int ibody,
-  double j_a, double *xi, double *xj, double delx, double dely, double delz,
+  double j_a, double *xi, double */*xj*/, double delx, double dely, double delz,
   double fx, double fy, double fz, double** x, double** v, double** angmom,
   double** f, double** torque, double* vwall)
 {
diff --git a/src/BODY/pair_body_rounded_polygon.cpp b/src/BODY/pair_body_rounded_polygon.cpp
index 14ef70f476..97d3ad5606 100644
--- a/src/BODY/pair_body_rounded_polygon.cpp
+++ b/src/BODY/pair_body_rounded_polygon.cpp
@@ -598,7 +598,7 @@ void PairBodyRoundedPolygon::body2space(int i)
 
 void PairBodyRoundedPolygon::sphere_against_sphere(int i, int j,
                        double delx, double dely, double delz, double rsq,
-                       double k_n, double k_na, double** x, double** v,
+                       double k_n, double k_na, double** /*x*/, double** v,
                        double** f, int evflag)
 {
   double eradi,eradj,rradi,rradj;
@@ -1166,7 +1166,7 @@ int PairBodyRoundedPolygon::compute_distance_to_vertex(int ibody,
 
 void PairBodyRoundedPolygon::contact_forces(Contact& contact, double j_a,
                        double** x, double** v, double** angmom, double** f,
-                       double** torque, double &evdwl, double* facc)
+                       double** torque, double &/*evdwl*/, double* facc)
 {
   int ibody,jbody,ibonus,jbonus,ifirst,jefirst,ni,nj;
   double fx,fy,fz,delx,dely,delz,rsq,rsqinv;
diff --git a/src/CLASS2/bond_class2.cpp b/src/CLASS2/bond_class2.cpp
index c3dc09715c..af20313e0a 100644
--- a/src/CLASS2/bond_class2.cpp
+++ b/src/CLASS2/bond_class2.cpp
@@ -209,7 +209,7 @@ void BondClass2::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondClass2::single(int type, double rsq, int i, int j, double &fforce)
+double BondClass2::single(int type, double rsq, int /*i*/, int /*j*/, double &fforce)
 {
   double r = sqrt(rsq);
   double dr = r - r0[type];
diff --git a/src/CLASS2/improper_class2.cpp b/src/CLASS2/improper_class2.cpp
index 3b3811584d..77f594af9d 100644
--- a/src/CLASS2/improper_class2.cpp
+++ b/src/CLASS2/improper_class2.cpp
@@ -633,7 +633,7 @@ void ImproperClass2::read_restart(FILE *fp)
    angle-angle interactions within improper
 ------------------------------------------------------------------------- */
 
-void ImproperClass2::angleangle(int eflag, int vflag)
+void ImproperClass2::angleangle(int eflag, int /*vflag*/)
 {
   int i1,i2,i3,i4,i,j,k,n,type;
   double eimproper;
diff --git a/src/CLASS2/pair_lj_class2.cpp b/src/CLASS2/pair_lj_class2.cpp
index e255807ab6..6451921dc5 100644
--- a/src/CLASS2/pair_lj_class2.cpp
+++ b/src/CLASS2/pair_lj_class2.cpp
@@ -377,8 +377,8 @@ void PairLJClass2::write_data_all(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairLJClass2::single(int i, int j, int itype, int jtype, double rsq,
-                            double factor_coul, double factor_lj,
+double PairLJClass2::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                            double /*factor_coul*/, double factor_lj,
                             double &fforce)
 {
   double r2inv,rinv,r3inv,r6inv,forcelj,philj;
diff --git a/src/COLLOID/pair_colloid.cpp b/src/COLLOID/pair_colloid.cpp
index 4448d6e110..c16dbf41af 100644
--- a/src/COLLOID/pair_colloid.cpp
+++ b/src/COLLOID/pair_colloid.cpp
@@ -469,8 +469,8 @@ void PairColloid::write_data_all(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairColloid::single(int i, int j, int itype, int jtype, double rsq,
-                           double factor_coul, double factor_lj,
+double PairColloid::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                           double /*factor_coul*/, double factor_lj,
                            double &fforce)
 {
   double K[9],h[4],g[4];
diff --git a/src/COLLOID/pair_lubricate.cpp b/src/COLLOID/pair_lubricate.cpp
index f0f7ce8c14..fc1fa7acc5 100644
--- a/src/COLLOID/pair_lubricate.cpp
+++ b/src/COLLOID/pair_lubricate.cpp
@@ -749,7 +749,7 @@ void PairLubricate::read_restart_settings(FILE *fp)
 /* ---------------------------------------------------------------------- */
 
 int PairLubricate::pack_forward_comm(int n, int *list, double *buf,
-                                     int pbc_flag, int *pbc)
+                                     int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
@@ -797,7 +797,7 @@ void PairLubricate::unpack_forward_comm(int n, int first, double *buf)
    if type pair setting, return -2 if no type pairs are set
 ------------------------------------------------------------------------- */
 
-int PairLubricate::pre_adapt(char *name, int ilo, int ihi, int jlo, int jhi)
+int PairLubricate::pre_adapt(char *name, int /*ilo*/, int /*ihi*/, int /*jlo*/, int /*jhi*/)
 {
   if (strcmp(name,"mu") == 0) return 0;
   return -1;
@@ -809,7 +809,7 @@ int PairLubricate::pre_adapt(char *name, int ilo, int ihi, int jlo, int jhi)
    if type pair setting, set I-J and J-I coeffs
 ------------------------------------------------------------------------- */
 
-void PairLubricate::adapt(int which, int ilo, int ihi, int jlo, int jhi,
+void PairLubricate::adapt(int /*which*/, int /*ilo*/, int /*ihi*/, int /*jlo*/, int /*jhi*/,
                           double value)
 {
   mu = value;
diff --git a/src/COLLOID/pair_lubricateU.cpp b/src/COLLOID/pair_lubricateU.cpp
index 11fb213157..2d51f2e2b6 100644
--- a/src/COLLOID/pair_lubricateU.cpp
+++ b/src/COLLOID/pair_lubricateU.cpp
@@ -2010,7 +2010,7 @@ void PairLubricateU::copy_uo_vec(int inum, double **f, double **torque,
 /* ---------------------------------------------------------------------- */
 
 int PairLubricateU::pack_forward_comm(int n, int *list, double *buf,
-                                      int pbc_flag, int *pbc)
+                                      int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/COLLOID/pair_yukawa_colloid.cpp b/src/COLLOID/pair_yukawa_colloid.cpp
index 5965fd3aa8..d21bc43524 100644
--- a/src/COLLOID/pair_yukawa_colloid.cpp
+++ b/src/COLLOID/pair_yukawa_colloid.cpp
@@ -160,9 +160,9 @@ double PairYukawaColloid::init_one(int i, int j)
 
 /* ---------------------------------------------------------------------- */
 
-double PairYukawaColloid::single(int i, int j, int itype, int jtype,
+double PairYukawaColloid::single(int /*i*/, int /*j*/, int itype, int jtype,
                                  double rsq,
-                                 double factor_coul, double factor_lj,
+                                 double /*factor_coul*/, double factor_lj,
                                  double &fforce)
 {
   double r,rinv,screening,forceyukawa,phi;
diff --git a/src/KSPACE/pair_coul_long.cpp b/src/KSPACE/pair_coul_long.cpp
index 4b10782ee6..8db5979b39 100644
--- a/src/KSPACE/pair_coul_long.cpp
+++ b/src/KSPACE/pair_coul_long.cpp
@@ -338,9 +338,9 @@ void PairCoulLong::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairCoulLong::single(int i, int j, int itype, int jtype,
+double PairCoulLong::single(int i, int j, int /*itype*/, int /*jtype*/,
                             double rsq,
-                            double factor_coul, double factor_lj,
+                            double factor_coul, double /*factor_lj*/,
                             double &fforce)
 {
   double r2inv,r,grij,expm2,t,erfc,prefactor;
diff --git a/src/KSPACE/pair_coul_msm.cpp b/src/KSPACE/pair_coul_msm.cpp
index f5cd9a0445..ab59dfa4c1 100644
--- a/src/KSPACE/pair_coul_msm.cpp
+++ b/src/KSPACE/pair_coul_msm.cpp
@@ -169,9 +169,9 @@ void PairCoulMSM::compute(int eflag, int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-double PairCoulMSM::single(int i, int j, int itype, int jtype,
+double PairCoulMSM::single(int i, int j, int /*itype*/, int /*jtype*/,
                             double rsq,
-                            double factor_coul, double factor_lj,
+                            double factor_coul, double /*factor_lj*/,
                             double &fforce)
 {
   double r2inv,r,egamma,fgamma,prefactor;
diff --git a/src/KSPACE/pppm_disp.cpp b/src/KSPACE/pppm_disp.cpp
index aea57da326..b8cd52c5fe 100644
--- a/src/KSPACE/pppm_disp.cpp
+++ b/src/KSPACE/pppm_disp.cpp
@@ -8052,7 +8052,7 @@ void PPPMDisp::compute_rho_coeff(FFT_SCALAR **coeff , FFT_SCALAR **dcoeff,
    extended to non-neutral systems (J. Chem. Phys. 131, 094107).
 ------------------------------------------------------------------------- */
 
-void PPPMDisp::slabcorr(int eflag)
+void PPPMDisp::slabcorr(int /*eflag*/)
 {
   // compute local contribution to global dipole moment
 
diff --git a/src/KSPACE/remap.cpp b/src/KSPACE/remap.cpp
index 81dd692f4f..26541f121e 100644
--- a/src/KSPACE/remap.cpp
+++ b/src/KSPACE/remap.cpp
@@ -234,7 +234,7 @@ struct remap_plan_3d *remap_3d_create_plan(
   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 usecollective)
+  int nqty, int permute, int memory, int /*precision*/, int usecollective)
 
 {
 
diff --git a/src/LATTE/fix_latte.cpp b/src/LATTE/fix_latte.cpp
index 18502dd013..c9dd0465f8 100644
--- a/src/LATTE/fix_latte.cpp
+++ b/src/LATTE/fix_latte.cpp
@@ -189,7 +189,7 @@ void FixLatte::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixLatte::init_list(int id, NeighList *ptr)
+void FixLatte::init_list(int /*id*/, NeighList */*ptr*/)
 {
   // list = ptr;
 }
@@ -223,13 +223,13 @@ void FixLatte::setup_pre_reverse(int eflag, int vflag)
    integrate electronic degrees of freedom
 ------------------------------------------------------------------------- */
 
-void FixLatte::initial_integrate(int vflag) {}
+void FixLatte::initial_integrate(int /*vflag*/) {}
 
 /* ----------------------------------------------------------------------
    store eflag, so can use it in post_force to tally per-atom energies
 ------------------------------------------------------------------------- */
 
-void FixLatte::pre_reverse(int eflag, int vflag)
+void FixLatte::pre_reverse(int eflag, int /*vflag*/)
 {
   eflag_caller = eflag;
 }
diff --git a/src/MANYBODY/fix_qeq_comb.cpp b/src/MANYBODY/fix_qeq_comb.cpp
index b8d9c7e6df..61bf9bf11c 100644
--- a/src/MANYBODY/fix_qeq_comb.cpp
+++ b/src/MANYBODY/fix_qeq_comb.cpp
@@ -159,7 +159,7 @@ void FixQEQComb::min_post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEQComb::post_force(int vflag)
+void FixQEQComb::post_force(int /*vflag*/)
 {
   int i,ii,iloop,loopmax,inum,*ilist;
   double heatpq,qmass,dtq,dtq2;
@@ -276,7 +276,7 @@ void FixQEQComb::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEQComb::post_force_respa(int vflag, int ilevel, int iloop)
+void FixQEQComb::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
@@ -293,7 +293,7 @@ double FixQEQComb::memory_usage()
 /* ---------------------------------------------------------------------- */
 
 int FixQEQComb::pack_forward_comm(int n, int *list, double *buf,
-                                  int pbc_flag, int *pbc)
+                                  int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MANYBODY/pair_adp.cpp b/src/MANYBODY/pair_adp.cpp
index d0b4d19758..fd496fcae6 100644
--- a/src/MANYBODY/pair_adp.cpp
+++ b/src/MANYBODY/pair_adp.cpp
@@ -424,7 +424,7 @@ void PairADP::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairADP::settings(int narg, char **arg)
+void PairADP::settings(int narg, char **/*arg*/)
 {
   if (narg > 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -521,7 +521,7 @@ void PairADP::init_style()
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
 
-double PairADP::init_one(int i, int j)
+double PairADP::init_one(int /*i*/, int /*j*/)
 {
   // single global cutoff = max of cut from all files read in
   // for funcfl could be multiple files
@@ -935,7 +935,7 @@ void PairADP::grab(FILE *fp, int n, double *list)
 /* ---------------------------------------------------------------------- */
 
 int PairADP::pack_forward_comm(int n, int *list, double *buf,
-                               int pbc_flag, int *pbc)
+                               int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MANYBODY/pair_airebo.cpp b/src/MANYBODY/pair_airebo.cpp
index 3be27354c1..ac3ed36a83 100644
--- a/src/MANYBODY/pair_airebo.cpp
+++ b/src/MANYBODY/pair_airebo.cpp
@@ -425,7 +425,7 @@ void PairAIREBO::REBO_neigh()
    REBO forces and energy
 ------------------------------------------------------------------------- */
 
-void PairAIREBO::FREBO(int eflag, int vflag)
+void PairAIREBO::FREBO(int eflag, int /*vflag*/)
 {
   int i,j,k,m,ii,inum,itype,jtype;
   tagint itag,jtag;
@@ -524,7 +524,7 @@ void PairAIREBO::FREBO(int eflag, int vflag)
    find 3- and 4-step paths between atoms I,J via REBO neighbor lists
 ------------------------------------------------------------------------- */
 
-void PairAIREBO::FLJ(int eflag, int vflag)
+void PairAIREBO::FLJ(int eflag, int /*vflag*/)
 {
   int i,j,k,m,ii,jj,kk,mm,inum,jnum,itype,jtype,ktype,mtype;
   int atomi,atomj,atomk,atomm;
@@ -893,7 +893,7 @@ void PairAIREBO::FLJ(int eflag, int vflag)
    torsional forces and energy
 ------------------------------------------------------------------------- */
 
-void PairAIREBO::TORSION(int eflag, int vflag)
+void PairAIREBO::TORSION(int eflag, int /*vflag*/)
 {
   int i,j,k,l,ii,inum;
   tagint itag,jtag;
@@ -2116,7 +2116,7 @@ but of the vector r_ij.
 
 */
 
-double PairAIREBO::bondorderLJ(int i, int j, double rij_mod[3], double rijmag_mod,
+double PairAIREBO::bondorderLJ(int i, int j, double /*rij_mod*/[3], double rijmag_mod,
                                double VA, double rij[3], double rijmag,
                                double **f, int vflag_atom)
 {
diff --git a/src/MANYBODY/pair_comb.cpp b/src/MANYBODY/pair_comb.cpp
index de686d4bcf..b205fc46d3 100644
--- a/src/MANYBODY/pair_comb.cpp
+++ b/src/MANYBODY/pair_comb.cpp
@@ -432,7 +432,7 @@ void PairComb::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairComb::settings(int narg, char **arg)
+void PairComb::settings(int narg, char **/*arg*/)
 {
   if (narg > 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -1542,7 +1542,7 @@ void PairComb::potal_calc(double &calc1, double &calc2, double &calc3)
 
 void PairComb::tri_point(double rsq, int &mr1, int &mr2,
                          int &mr3, double &sr1, double &sr2,
-                         double &sr3, int &itype)
+                         double &sr3, int &/*itype*/)
 {
  double r, rin, dr, dd, rr1, rridr, rridr2;
 
@@ -1572,7 +1572,7 @@ void PairComb::tri_point(double rsq, int &mr1, int &mr2,
 void PairComb::direct(int inty, int mr1, int mr2, int mr3, double rsq,
                       double sr1, double sr2, double sr3,
                       double iq, double jq,
-                      double potal, double fac11, double fac11e,
+                      double /*potal*/, double fac11, double fac11e,
                       double &pot_tmp, double &pot_d)
 {
  double r,erfcc,fafbn1,potij,sme2,esucon;
@@ -2002,7 +2002,7 @@ void PairComb::Over_cor(Param *param, double rsq1, int NCoi,
 /* ---------------------------------------------------------------------- */
 
 int PairComb::pack_forward_comm(int n, int *list, double *buf,
-                                int pbc_flag, int *pbc)
+                                int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MANYBODY/pair_comb3.cpp b/src/MANYBODY/pair_comb3.cpp
index b4f9c02206..54fd13029b 100644
--- a/src/MANYBODY/pair_comb3.cpp
+++ b/src/MANYBODY/pair_comb3.cpp
@@ -1569,7 +1569,7 @@ void PairComb3::compute(int eflag, int vflag)
 /* ---------------------------------------------------------------------- */
 
 void PairComb3::repulsive(Param *parami, Param *paramj, double rsq,
-        double &fforce,int eflag, double &eng, double iq, double jq)
+        double &fforce,int /*eflag*/, double &eng, double iq, double jq)
 {
   double r,tmp_fc,tmp_fc_d,Di,Dj;
   double caj,vrcs,fvrcs;
@@ -1614,7 +1614,7 @@ void PairComb3::repulsive(Param *parami, Param *paramj, double rsq,
 /* ---------------------------------------------------------------------- */
 
 double PairComb3::zeta(Param *parami, Param *paramj, double rsqij,
-        double rsqik, double *delrij, double *delrik, int i, double xcn)
+        double rsqik, double *delrij, double *delrik, int /*i*/, double xcn)
 {
   double rij,rik,costheta,arg,ex_delr,rlm3;
 
@@ -1661,7 +1661,7 @@ void PairComb3::selfp6p(Param *parami, Param *paramj, double rsq,
 /* ---------------------------------------------------------------------- */
 
 double PairComb3::ep6p(Param *paramj, Param *paramk, double rsqij, double rsqik,
-                     double *delrij, double *delrik , double &zet_add)
+                     double *delrij, double *delrik , double &/*zet_add*/)
 {
   double comtt;
   double pplp0 = paramj->p6p0;
@@ -2109,7 +2109,7 @@ void PairComb3::coord(Param *param, double r, int i,
 
 void PairComb3::cntri_int(int tri_flag, double xval, double yval,
                 double zval, int ixmin, int iymin, int izmin, double &vval,
-                double &dvalx, double &dvaly, double &dvalz, Param *param)
+                double &dvalx, double &dvaly, double &dvalz, Param */*param*/)
 {
   double x;
   vval = 0.0; dvalx = 0.0; dvaly = 0.0; dvalz = 0.0;
@@ -2254,7 +2254,7 @@ void PairComb3::comb_gijk_d(double costheta, Param *param, double nco_tmp,
 void PairComb3::attractive(Param *parami, Param *paramj , Param *paramk, double prefac_ij1,
         double prefac_ij2, double prefac_ij3, double prefac_ij4,
         double prefac_ij5, double rsqij, double rsqik, double *delrij,
-        double *delrik, double *fi, double *fj,double *fk, int i, double xcn)
+        double *delrik, double *fi, double *fj,double *fk, int /*i*/, double xcn)
 {
   double rij_hat[3],rik_hat[3];
   double rij,rijinv,rik,rikinv;
@@ -2867,7 +2867,7 @@ void PairComb3::field(Param *parami, Param *paramj, double rsq, double iq,
 
 /* ---------------------------------------------------------------------- */
 
-double PairComb3::rad_init(double rsq2,Param *param,int i,
+double PairComb3::rad_init(double rsq2,Param *param,int /*i*/,
                 double &radtot, double cnconj)
 {
   double r, fc1k, radcut;
@@ -2882,7 +2882,7 @@ double PairComb3::rad_init(double rsq2,Param *param,int i,
 /* ---------------------------------------------------------------------- */
 
 void PairComb3::rad_calc(double r, Param *parami, Param *paramj,
-        double kconjug, double lconjug, int i, int j, double xcn, double ycn)
+        double kconjug, double lconjug, int /*i*/, int /*j*/, double xcn, double ycn)
 {
   int ixmin, iymin, izmin;
   int radindx;
@@ -3061,7 +3061,7 @@ double PairComb3::bbtor1(int torindx, Param *paramk, Param *paraml,
 /* ---------------------------------------------------------------------- */
 
 void PairComb3::tor_calc(double r, Param *parami, Param *paramj,
-        double kconjug, double lconjug, int i, int j, double xcn, double ycn)
+        double kconjug, double lconjug, int /*i*/, int /*j*/, double xcn, double ycn)
 {
   int ixmin, iymin, izmin;
   double vtor, dtorx, dtory, dtorz;
@@ -3589,7 +3589,7 @@ void PairComb3::qfo_dipole(double fac11, int mr1, int mr2, int mr3,
 
 void PairComb3::qfo_short(Param *parami, Param *paramj, double rsq,
         double iq, double jq, double &fqij, double &fqji,
-        int i, int j, int nj)
+        int i, int /*j*/, int nj)
 {
   double r, tmp_fc;
   double Di, Dj, dDi, dDj, Bsi, Bsj, dBsi, dBsj;
@@ -3863,7 +3863,7 @@ double PairComb3::switching_d(double rr)
 /* ---------------------------------------------------------------------- */
 
 int PairComb3::pack_forward_comm(int n, int *list, double *buf,
-                                 int pbc_flag, int *pbc)
+                                 int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MANYBODY/pair_eam.cpp b/src/MANYBODY/pair_eam.cpp
index 9e70b19eea..a861f33824 100644
--- a/src/MANYBODY/pair_eam.cpp
+++ b/src/MANYBODY/pair_eam.cpp
@@ -347,7 +347,7 @@ void PairEAM::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairEAM::settings(int narg, char **arg)
+void PairEAM::settings(int narg, char **/*arg*/)
 {
   if (narg > 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -795,7 +795,7 @@ void PairEAM::grab(FILE *fptr, int n, double *list)
 /* ---------------------------------------------------------------------- */
 
 double PairEAM::single(int i, int j, int itype, int jtype,
-                       double rsq, double factor_coul, double factor_lj,
+                       double rsq, double /*factor_coul*/, double /*factor_lj*/,
                        double &fforce)
 {
   int m;
@@ -829,7 +829,7 @@ double PairEAM::single(int i, int j, int itype, int jtype,
 /* ---------------------------------------------------------------------- */
 
 int PairEAM::pack_forward_comm(int n, int *list, double *buf,
-                               int pbc_flag, int *pbc)
+                               int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MANYBODY/pair_eam_cd.cpp b/src/MANYBODY/pair_eam_cd.cpp
index 66ebad6244..9b8fd29465 100644
--- a/src/MANYBODY/pair_eam_cd.cpp
+++ b/src/MANYBODY/pair_eam_cd.cpp
@@ -539,7 +539,7 @@ void PairEAMCD::read_h_coeff(char *filename)
 /* ---------------------------------------------------------------------- */
 
 int PairEAMCD::pack_forward_comm(int n, int *list, double *buf,
-                                 int pbc_flag, int *pbc)
+                                 int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MANYBODY/pair_eim.cpp b/src/MANYBODY/pair_eim.cpp
index b810d444fc..cc35004778 100644
--- a/src/MANYBODY/pair_eim.cpp
+++ b/src/MANYBODY/pair_eim.cpp
@@ -342,7 +342,7 @@ void PairEIM::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairEIM::settings(int narg, char **arg)
+void PairEIM::settings(int narg, char **/*arg*/)
 {
   if (narg > 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -850,7 +850,7 @@ void PairEIM::array2spline()
 /* ---------------------------------------------------------------------- */
 
 void PairEIM::interpolate(int n, double delta, double *f,
-                          double **spline, double origin)
+                          double **spline, double /*origin*/)
 {
   for (int m = 1; m <= n; m++) spline[m][6] = f[m];
 
@@ -1087,7 +1087,7 @@ double PairEIM::funccoul(int i, int j, double r)
 /* ---------------------------------------------------------------------- */
 
 int PairEIM::pack_forward_comm(int n, int *list, double *buf,
-                               int pbc_flag, int *pbc)
+                               int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MANYBODY/pair_gw.cpp b/src/MANYBODY/pair_gw.cpp
index 35f092b580..0aff4970bb 100644
--- a/src/MANYBODY/pair_gw.cpp
+++ b/src/MANYBODY/pair_gw.cpp
@@ -257,7 +257,7 @@ void PairGW::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairGW::settings(int narg, char **arg)
+void PairGW::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/MANYBODY/pair_lcbop.cpp b/src/MANYBODY/pair_lcbop.cpp
index d334defcc6..57373c4f85 100644
--- a/src/MANYBODY/pair_lcbop.cpp
+++ b/src/MANYBODY/pair_lcbop.cpp
@@ -121,7 +121,7 @@ void PairLCBOP::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairLCBOP::settings(int narg, char **arg) {
+void PairLCBOP::settings(int narg, char **/*arg*/) {
   if( narg != 0 ) error->all(FLERR,"Illegal pair_style command");
 }
 
@@ -353,7 +353,7 @@ void PairLCBOP::SR_neigh()
   Short range forces and energy
 ------------------------------------------------------------------------- */
 
-void PairLCBOP::FSR(int eflag, int vflag)
+void PairLCBOP::FSR(int eflag, int /*vflag*/)
 {
   int i,j,jj,ii,inum;
   tagint itag,jtag;
@@ -449,7 +449,7 @@ void PairLCBOP::FSR(int eflag, int vflag)
    compute long range forces and energy
 ------------------------------------------------------------------------- */
 
-void PairLCBOP::FLR(int eflag, int vflag)
+void PairLCBOP::FLR(int eflag, int /*vflag*/)
 {
   int i,j,jj,ii;
   tagint itag,jtag;
diff --git a/src/MANYBODY/pair_nb3b_harmonic.cpp b/src/MANYBODY/pair_nb3b_harmonic.cpp
index 36be9c2b90..a09f8a23e6 100644
--- a/src/MANYBODY/pair_nb3b_harmonic.cpp
+++ b/src/MANYBODY/pair_nb3b_harmonic.cpp
@@ -174,7 +174,7 @@ void PairNb3bHarmonic::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairNb3bHarmonic::settings(int narg, char **arg)
+void PairNb3bHarmonic::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -454,7 +454,7 @@ void PairNb3bHarmonic::setup_params()
 /* ---------------------------------------------------------------------- */
 
 
-void PairNb3bHarmonic::threebody(Param *paramij, Param *paramik,
+void PairNb3bHarmonic::threebody(Param */*paramij*/, Param */*paramik*/,
                                  Param *paramijk,
                                  double rsq1, double rsq2,
                                  double *delr1, double *delr2,
diff --git a/src/MANYBODY/pair_polymorphic.cpp b/src/MANYBODY/pair_polymorphic.cpp
index 2afb08b7a1..ce9af66d30 100644
--- a/src/MANYBODY/pair_polymorphic.cpp
+++ b/src/MANYBODY/pair_polymorphic.cpp
@@ -450,7 +450,7 @@ void PairPolymorphic::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairPolymorphic::settings(int narg, char **arg)
+void PairPolymorphic::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/MANYBODY/pair_rebo.cpp b/src/MANYBODY/pair_rebo.cpp
index 37948f3038..1f31c0b0cd 100644
--- a/src/MANYBODY/pair_rebo.cpp
+++ b/src/MANYBODY/pair_rebo.cpp
@@ -24,7 +24,7 @@ PairREBO::PairREBO(LAMMPS *lmp) : PairAIREBO(lmp) {}
    global settings
 ------------------------------------------------------------------------- */
 
-void PairREBO::settings(int narg, char **arg)
+void PairREBO::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp
index 6fbc00204c..da470d568a 100644
--- a/src/MANYBODY/pair_sw.cpp
+++ b/src/MANYBODY/pair_sw.cpp
@@ -239,7 +239,7 @@ void PairSW::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairSW::settings(int narg, char **arg)
+void PairSW::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/MANYBODY/pair_tersoff.cpp b/src/MANYBODY/pair_tersoff.cpp
index 507b07e29a..45068e5c2e 100644
--- a/src/MANYBODY/pair_tersoff.cpp
+++ b/src/MANYBODY/pair_tersoff.cpp
@@ -280,7 +280,7 @@ void PairTersoff::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairTersoff::settings(int narg, char **arg)
+void PairTersoff::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/MANYBODY/pair_vashishta.cpp b/src/MANYBODY/pair_vashishta.cpp
index 8506c9a69f..54b184ea39 100644
--- a/src/MANYBODY/pair_vashishta.cpp
+++ b/src/MANYBODY/pair_vashishta.cpp
@@ -245,7 +245,7 @@ void PairVashishta::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairVashishta::settings(int narg, char **arg)
+void PairVashishta::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/MC/fix_atom_swap.cpp b/src/MC/fix_atom_swap.cpp
index 4d9377022b..b795b71273 100644
--- a/src/MC/fix_atom_swap.cpp
+++ b/src/MC/fix_atom_swap.cpp
@@ -695,7 +695,7 @@ void FixAtomSwap::update_swap_atoms_list()
 
 /* ---------------------------------------------------------------------- */
 
-int FixAtomSwap::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc)
+int FixAtomSwap::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/MC/fix_bond_break.cpp b/src/MC/fix_bond_break.cpp
index 9a5b59b601..203d6b589b 100644
--- a/src/MC/fix_bond_break.cpp
+++ b/src/MC/fix_bond_break.cpp
@@ -693,7 +693,7 @@ int FixBondBreak::dedup(int nstart, int nstop, tagint *copy)
 
 /* ---------------------------------------------------------------------- */
 
-void FixBondBreak::post_integrate_respa(int ilevel, int iloop)
+void FixBondBreak::post_integrate_respa(int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_integrate();
 }
@@ -701,7 +701,7 @@ void FixBondBreak::post_integrate_respa(int ilevel, int iloop)
 /* ---------------------------------------------------------------------- */
 
 int FixBondBreak::pack_forward_comm(int n, int *list, double *buf,
-                                    int pbc_flag, int *pbc)
+                                    int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,k,m,ns;
 
diff --git a/src/MC/fix_bond_create.cpp b/src/MC/fix_bond_create.cpp
index 8e9db6a18b..17ea7fb3f2 100644
--- a/src/MC/fix_bond_create.cpp
+++ b/src/MC/fix_bond_create.cpp
@@ -258,14 +258,14 @@ void FixBondCreate::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixBondCreate::init_list(int id, NeighList *ptr)
+void FixBondCreate::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
 
 /* ---------------------------------------------------------------------- */
 
-void FixBondCreate::setup(int vflag)
+void FixBondCreate::setup(int /*vflag*/)
 {
   int i,j,m;
 
@@ -1206,7 +1206,7 @@ int FixBondCreate::dedup(int nstart, int nstop, tagint *copy)
 
 /* ---------------------------------------------------------------------- */
 
-void FixBondCreate::post_integrate_respa(int ilevel, int iloop)
+void FixBondCreate::post_integrate_respa(int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_integrate();
 }
@@ -1214,7 +1214,7 @@ void FixBondCreate::post_integrate_respa(int ilevel, int iloop)
 /* ---------------------------------------------------------------------- */
 
 int FixBondCreate::pack_forward_comm(int n, int *list, double *buf,
-                                     int pbc_flag, int *pbc)
+                                     int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,k,m,ns;
 
@@ -1347,7 +1347,7 @@ void FixBondCreate::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixBondCreate::copy_arrays(int i, int j, int delflag)
+void FixBondCreate::copy_arrays(int i, int j, int /*delflag*/)
 {
   bondcount[j] = bondcount[i];
 }
diff --git a/src/MC/fix_bond_swap.cpp b/src/MC/fix_bond_swap.cpp
index d6df4d9a96..9a72667907 100644
--- a/src/MC/fix_bond_swap.cpp
+++ b/src/MC/fix_bond_swap.cpp
@@ -182,7 +182,7 @@ void FixBondSwap::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixBondSwap::init_list(int id, NeighList *ptr)
+void FixBondSwap::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/MC/fix_tfmc.cpp b/src/MC/fix_tfmc.cpp
index b821710353..46c5e592ae 100644
--- a/src/MC/fix_tfmc.cpp
+++ b/src/MC/fix_tfmc.cpp
@@ -158,7 +158,7 @@ void FixTFMC::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixTFMC::initial_integrate(int vflag)
+void FixTFMC::initial_integrate(int /*vflag*/)
 {
   double boltz = force->boltz;
   double **x = atom->x;
diff --git a/src/MC/pair_dsmc.cpp b/src/MC/pair_dsmc.cpp
index 02f9754c2a..c71eaa2295 100644
--- a/src/MC/pair_dsmc.cpp
+++ b/src/MC/pair_dsmc.cpp
@@ -65,7 +65,7 @@ PairDSMC::~PairDSMC()
 
 /* ---------------------------------------------------------------------- */
 
-void PairDSMC::compute(int eflag, int vflag)
+void PairDSMC::compute(int /*eflag*/, int /*vflag*/)
 {
   double **x = atom->x;
   double *mass = atom->mass;
@@ -405,7 +405,7 @@ void PairDSMC::read_restart_settings(FILE *fp)
   the next nrezero timesteps
 -------------------------------------------------------------------------*/
 
-void PairDSMC::recompute_V_sigma_max(int icell)
+void PairDSMC::recompute_V_sigma_max(int /*icell*/)
 {
   int i,j,k;
   double Vsigma_max = 0;
@@ -459,7 +459,7 @@ double PairDSMC::V_sigma(int i, int j)
   generate new velocities for collided particles
 -------------------------------------------------------------------------*/
 
-void PairDSMC::scatter_random(int i, int j, int icell)
+void PairDSMC::scatter_random(int i, int j, int /*icell*/)
 {
   double mag_delv,cos_phi,cos_squared,r,theta;
   double delv[3],vcm[3];
diff --git a/src/MEAM/pair_meam.cpp b/src/MEAM/pair_meam.cpp
index 687055aa6a..41f1f4ce37 100644
--- a/src/MEAM/pair_meam.cpp
+++ b/src/MEAM/pair_meam.cpp
@@ -325,7 +325,7 @@ void PairMEAM::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairMEAM::settings(int narg, char **arg)
+void PairMEAM::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -448,7 +448,7 @@ void PairMEAM::init_list(int id, NeighList *ptr)
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
 
-double PairMEAM::init_one(int i, int j)
+double PairMEAM::init_one(int /*i*/, int /*j*/)
 {
   return cutmax;
 }
@@ -734,7 +734,7 @@ void PairMEAM::read_files(char *globalfile, char *userfile)
 /* ---------------------------------------------------------------------- */
 
 int PairMEAM::pack_forward_comm(int n, int *list, double *buf,
-                                int pbc_flag, int *pbc)
+                                int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,k,m;
 
diff --git a/src/MISC/fix_efield.cpp b/src/MISC/fix_efield.cpp
index 1fa141e2bf..004c8ad7bc 100644
--- a/src/MISC/fix_efield.cpp
+++ b/src/MISC/fix_efield.cpp
@@ -412,7 +412,7 @@ void FixEfield::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixEfield::post_force_respa(int vflag, int ilevel, int iloop)
+void FixEfield::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
diff --git a/src/MISC/fix_gld.cpp b/src/MISC/fix_gld.cpp
index 370730133e..2bf02889a5 100644
--- a/src/MISC/fix_gld.cpp
+++ b/src/MISC/fix_gld.cpp
@@ -217,7 +217,7 @@ void FixGLD::init()
    First half of a timestep (V^{n} -> V^{n+1/2}; X^{n} -> X^{n+1})
 ------------------------------------------------------------------------- */
 
-void FixGLD::initial_integrate(int vflag)
+void FixGLD::initial_integrate(int /*vflag*/)
 {
   double dtfm;
   double ftm2v = force->ftm2v;
@@ -444,7 +444,7 @@ void FixGLD::final_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixGLD::initial_integrate_respa(int vflag, int ilevel, int iloop)
+void FixGLD::initial_integrate_respa(int vflag, int ilevel, int /*iloop*/)
 {
   dtv = step_respa[ilevel];
   dtf = 0.5 * step_respa[ilevel] * (force->ftm2v);
@@ -458,7 +458,7 @@ void FixGLD::initial_integrate_respa(int vflag, int ilevel, int iloop)
 
 /* ---------------------------------------------------------------------- */
 
-void FixGLD::final_integrate_respa(int ilevel, int iloop)
+void FixGLD::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   dtf = 0.5 * step_respa[ilevel] * (force->ftm2v);
   final_integrate();
@@ -507,7 +507,7 @@ void FixGLD::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixGLD::copy_arrays(int i, int j, int delflag)
+void FixGLD::copy_arrays(int i, int j, int /*delflag*/)
 {
   for (int k = 0; k < 3*prony_terms; k++) {
     s_gld[j][k] = s_gld[i][k];
@@ -588,7 +588,7 @@ void FixGLD::unpack_restart(int nlocal, int nth)
    fixes on a given processor.
 ------------------------------------------------------------------------- */
 
-int FixGLD::size_restart(int nlocal)
+int FixGLD::size_restart(int /*nlocal*/)
 {
   return 3*prony_terms+1;
 }
diff --git a/src/MISC/fix_orient_bcc.cpp b/src/MISC/fix_orient_bcc.cpp
index c5ba6514a9..9b22e571fe 100644
--- a/src/MISC/fix_orient_bcc.cpp
+++ b/src/MISC/fix_orient_bcc.cpp
@@ -230,7 +230,7 @@ void FixOrientBCC::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixOrientBCC::init_list(int id, NeighList *ptr)
+void FixOrientBCC::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
@@ -250,7 +250,7 @@ void FixOrientBCC::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixOrientBCC::post_force(int vflag)
+void FixOrientBCC::post_force(int /*vflag*/)
 {
   int i,j,k,ii,jj,inum,jnum,m,n,nn,nsort;
   tagint id_self;
@@ -471,7 +471,7 @@ void FixOrientBCC::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixOrientBCC::post_force_respa(int vflag, int ilevel, int iloop)
+void FixOrientBCC::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
@@ -488,7 +488,7 @@ double FixOrientBCC::compute_scalar()
 /* ---------------------------------------------------------------------- */
 
 int FixOrientBCC::pack_forward_comm(int n, int *list, double *buf,
-                                    int pbc_flag, int *pbc)
+                                    int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,k,num;
   tagint id;
diff --git a/src/MISC/fix_orient_fcc.cpp b/src/MISC/fix_orient_fcc.cpp
index 5786571a89..b061627fd8 100644
--- a/src/MISC/fix_orient_fcc.cpp
+++ b/src/MISC/fix_orient_fcc.cpp
@@ -228,7 +228,7 @@ void FixOrientFCC::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixOrientFCC::init_list(int id, NeighList *ptr)
+void FixOrientFCC::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
@@ -248,7 +248,7 @@ void FixOrientFCC::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixOrientFCC::post_force(int vflag)
+void FixOrientFCC::post_force(int /*vflag*/)
 {
   int i,j,k,ii,jj,inum,jnum,m,n,nn,nsort;
   tagint id_self;
@@ -469,7 +469,7 @@ void FixOrientFCC::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixOrientFCC::post_force_respa(int vflag, int ilevel, int iloop)
+void FixOrientFCC::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
@@ -486,7 +486,7 @@ double FixOrientFCC::compute_scalar()
 /* ---------------------------------------------------------------------- */
 
 int FixOrientFCC::pack_forward_comm(int n, int *list, double *buf,
-                                    int pbc_flag, int *pbc)
+                                    int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,k,num;
   tagint id;
diff --git a/src/MISC/fix_ttm.cpp b/src/MISC/fix_ttm.cpp
index 7ffd979e50..c8f33c73b7 100644
--- a/src/MISC/fix_ttm.cpp
+++ b/src/MISC/fix_ttm.cpp
@@ -235,7 +235,7 @@ void FixTTM::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTM::post_force(int vflag)
+void FixTTM::post_force(int /*vflag*/)
 {
   double **x = atom->x;
   double **v = atom->v;
@@ -287,7 +287,7 @@ void FixTTM::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTM::post_force_setup(int vflag)
+void FixTTM::post_force_setup(int /*vflag*/)
 {
   double **f = atom->f;
   int *mask = atom->mask;
@@ -306,14 +306,14 @@ void FixTTM::post_force_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTM::post_force_respa(int vflag, int ilevel, int iloop)
+void FixTTM::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTM::post_force_respa_setup(int vflag, int ilevel, int iloop)
+void FixTTM::post_force_respa_setup(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force_setup(vflag);
 }
@@ -685,7 +685,7 @@ int FixTTM::maxsize_restart()
    size of atom nlocal's restart data
 ------------------------------------------------------------------------- */
 
-int FixTTM::size_restart(int nlocal)
+int FixTTM::size_restart(int /*nlocal*/)
 {
   return 4;
 }
diff --git a/src/MISC/pair_nm_cut.cpp b/src/MISC/pair_nm_cut.cpp
index a778d7a5b6..ce077a7a04 100644
--- a/src/MISC/pair_nm_cut.cpp
+++ b/src/MISC/pair_nm_cut.cpp
@@ -401,8 +401,8 @@ void PairNMCut::write_data_all(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairNMCut::single(int i, int j, int itype, int jtype,
-                      double rsq, double factor_coul, double factor_lj,
+double PairNMCut::single(int /*i*/, int /*j*/, int itype, int jtype,
+                      double rsq, double /*factor_coul*/, double factor_lj,
                       double &fforce)
 {
   double r2inv,r,forcenm,phinm;
diff --git a/src/MISC/xdr_compat.cpp b/src/MISC/xdr_compat.cpp
index 3987aa02fc..c67925d92a 100644
--- a/src/MISC/xdr_compat.cpp
+++ b/src/MISC/xdr_compat.cpp
@@ -650,7 +650,7 @@ xdrstdio_setpos (XDR *xdrs, unsigned int pos)
 }
 
 static xdr_int32_t *
-xdrstdio_inline (XDR *xdrs, int len)
+xdrstdio_inline (XDR */*xdrs*/, int /*len*/)
 {
   /*
    * Must do some work to implement this: must insure
diff --git a/src/MOLECULE/angle_cosine.cpp b/src/MOLECULE/angle_cosine.cpp
index e3472dfd7a..7fb7ce4c27 100644
--- a/src/MOLECULE/angle_cosine.cpp
+++ b/src/MOLECULE/angle_cosine.cpp
@@ -172,7 +172,7 @@ void AngleCosine::coeff(int narg, char **arg)
 
 /* ---------------------------------------------------------------------- */
 
-double AngleCosine::equilibrium_angle(int i)
+double AngleCosine::equilibrium_angle(int /*i*/)
 {
   return MY_PI;
 }
diff --git a/src/MOLECULE/angle_cosine_periodic.cpp b/src/MOLECULE/angle_cosine_periodic.cpp
index 4e620b436e..e8dd970b3b 100644
--- a/src/MOLECULE/angle_cosine_periodic.cpp
+++ b/src/MOLECULE/angle_cosine_periodic.cpp
@@ -222,7 +222,7 @@ void AngleCosinePeriodic::coeff(int narg, char **arg)
 
 /* ---------------------------------------------------------------------- */
 
-double AngleCosinePeriodic::equilibrium_angle(int i)
+double AngleCosinePeriodic::equilibrium_angle(int /*i*/)
 {
   return MY_PI;
 }
diff --git a/src/MOLECULE/bond_fene.cpp b/src/MOLECULE/bond_fene.cpp
index b6da72bfaf..671290b0ad 100644
--- a/src/MOLECULE/bond_fene.cpp
+++ b/src/MOLECULE/bond_fene.cpp
@@ -242,7 +242,7 @@ void BondFENE::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondFENE::single(int type, double rsq, int i, int j,
+double BondFENE::single(int type, double rsq, int /*i*/, int /*j*/,
                         double &fforce)
 {
   double r0sq = r0[type] * r0[type];
diff --git a/src/MOLECULE/bond_fene_expand.cpp b/src/MOLECULE/bond_fene_expand.cpp
index 26b699d7bf..3e191683fb 100644
--- a/src/MOLECULE/bond_fene_expand.cpp
+++ b/src/MOLECULE/bond_fene_expand.cpp
@@ -253,7 +253,7 @@ void BondFENEExpand::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondFENEExpand::single(int type, double rsq, int i, int j,
+double BondFENEExpand::single(int type, double rsq, int /*i*/, int /*j*/,
                         double &fforce)
 {
   double r = sqrt(rsq);
diff --git a/src/MOLECULE/bond_gromos.cpp b/src/MOLECULE/bond_gromos.cpp
index 8e989259af..279f4fb2d4 100644
--- a/src/MOLECULE/bond_gromos.cpp
+++ b/src/MOLECULE/bond_gromos.cpp
@@ -190,7 +190,7 @@ void BondGromos::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondGromos::single(int type, double rsq, int i, int j,
+double BondGromos::single(int type, double rsq, int /*i*/, int /*j*/,
                         double &fforce)
 {
   double dr = rsq - r0[type]*r0[type];
diff --git a/src/MOLECULE/bond_harmonic.cpp b/src/MOLECULE/bond_harmonic.cpp
index e7f510d2de..f795610b37 100644
--- a/src/MOLECULE/bond_harmonic.cpp
+++ b/src/MOLECULE/bond_harmonic.cpp
@@ -190,7 +190,7 @@ void BondHarmonic::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondHarmonic::single(int type, double rsq, int i, int j,
+double BondHarmonic::single(int type, double rsq, int /*i*/, int /*j*/,
                         double &fforce)
 {
   double r = sqrt(rsq);
diff --git a/src/MOLECULE/bond_morse.cpp b/src/MOLECULE/bond_morse.cpp
index 35be50e8df..06af28f2b0 100644
--- a/src/MOLECULE/bond_morse.cpp
+++ b/src/MOLECULE/bond_morse.cpp
@@ -196,7 +196,7 @@ void BondMorse::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondMorse::single(int type, double rsq, int i, int j,
+double BondMorse::single(int type, double rsq, int /*i*/, int /*j*/,
                          double &fforce)
 {
   double r = sqrt(rsq);
diff --git a/src/MOLECULE/bond_nonlinear.cpp b/src/MOLECULE/bond_nonlinear.cpp
index 3926c3494b..645b081779 100644
--- a/src/MOLECULE/bond_nonlinear.cpp
+++ b/src/MOLECULE/bond_nonlinear.cpp
@@ -191,7 +191,7 @@ void BondNonlinear::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondNonlinear::single(int type, double rsq, int i, int j,
+double BondNonlinear::single(int type, double rsq, int /*i*/, int /*j*/,
                              double &fforce)
 {
   double r = sqrt(rsq);
diff --git a/src/MOLECULE/bond_quartic.cpp b/src/MOLECULE/bond_quartic.cpp
index f581c7f331..f200030d6c 100644
--- a/src/MOLECULE/bond_quartic.cpp
+++ b/src/MOLECULE/bond_quartic.cpp
@@ -251,7 +251,7 @@ void BondQuartic::init_style()
    return an equilbrium bond length
 ------------------------------------------------------------------------- */
 
-double BondQuartic::equilibrium_distance(int i)
+double BondQuartic::equilibrium_distance(int /*i*/)
 {
   return 0.97;
 }
diff --git a/src/MOLECULE/bond_table.cpp b/src/MOLECULE/bond_table.cpp
index 7515f713df..a5c579042b 100644
--- a/src/MOLECULE/bond_table.cpp
+++ b/src/MOLECULE/bond_table.cpp
@@ -244,7 +244,7 @@ void BondTable::read_restart(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondTable::single(int type, double rsq, int i, int j,
+double BondTable::single(int type, double rsq, int /*i*/, int /*j*/,
                          double &fforce)
 {
   double r = sqrt(rsq);
diff --git a/src/MOLECULE/fix_cmap.cpp b/src/MOLECULE/fix_cmap.cpp
index 5ef2e662ab..2acb20de60 100644
--- a/src/MOLECULE/fix_cmap.cpp
+++ b/src/MOLECULE/fix_cmap.cpp
@@ -295,7 +295,7 @@ void FixCMAP::pre_neighbor()
    store eflag, so can use it in post_force to tally per-atom energies
 ------------------------------------------------------------------------- */
 
-void FixCMAP::pre_reverse(int eflag, int vflag)
+void FixCMAP::pre_reverse(int eflag, int /*vflag*/)
 {
   eflag_caller = eflag;
 }
@@ -604,7 +604,7 @@ void FixCMAP::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixCMAP::post_force_respa(int vflag, int ilevel, int iloop)
+void FixCMAP::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
@@ -1163,7 +1163,7 @@ void FixCMAP::read_data_section(char *keyword, int n, char *buf,
 
 /* ---------------------------------------------------------------------- */
 
-bigint FixCMAP::read_data_skip_lines(char *keyword)
+bigint FixCMAP::read_data_skip_lines(char */*keyword*/)
 {
   return ncmap;
 }
@@ -1173,7 +1173,7 @@ bigint FixCMAP::read_data_skip_lines(char *keyword)
    only called by proc 0
 ------------------------------------------------------------------------- */
 
-void FixCMAP::write_data_header(FILE *fp, int mth)
+void FixCMAP::write_data_header(FILE *fp, int /*mth*/)
 {
   fprintf(fp,BIGINT_FORMAT " cmap crossterms\n",ncmap);
 }
@@ -1186,7 +1186,7 @@ void FixCMAP::write_data_header(FILE *fp, int mth)
    ny = columns = type + 5 atom IDs
 ------------------------------------------------------------------------- */
 
-void FixCMAP::write_data_section_size(int mth, int &nx, int &ny)
+void FixCMAP::write_data_section_size(int /*mth*/, int &nx, int &ny)
 {
   int i,m;
 
@@ -1206,7 +1206,7 @@ void FixCMAP::write_data_section_size(int mth, int &nx, int &ny)
    buf allocated by caller as owned crossterms by 6
 ------------------------------------------------------------------------- */
 
-void FixCMAP::write_data_section_pack(int mth, double **buf)
+void FixCMAP::write_data_section_pack(int /*mth*/, double **buf)
 {
   int i,m;
 
@@ -1237,7 +1237,7 @@ void FixCMAP::write_data_section_pack(int mth, double **buf)
    only called by proc 0
 ------------------------------------------------------------------------- */
 
-void FixCMAP::write_data_section_keyword(int mth, FILE *fp)
+void FixCMAP::write_data_section_keyword(int /*mth*/, FILE *fp)
 {
   fprintf(fp,"\nCMAP\n\n");
 }
@@ -1249,7 +1249,7 @@ void FixCMAP::write_data_section_keyword(int mth, FILE *fp)
    only called by proc 0
 ------------------------------------------------------------------------- */
 
-void FixCMAP::write_data_section(int mth, FILE *fp,
+void FixCMAP::write_data_section(int /*mth*/, FILE *fp,
                                   int n, double **buf, int index)
 {
   for (int i = 0; i < n; i++)
@@ -1383,7 +1383,7 @@ void FixCMAP::grow_arrays(int nmax)
    copy values within local atom-based array
 ------------------------------------------------------------------------- */
 
-void FixCMAP::copy_arrays(int i, int j, int delflag)
+void FixCMAP::copy_arrays(int i, int j, int /*delflag*/)
 {
   num_crossterm[j] = num_crossterm[i];
 
diff --git a/src/MOLECULE/pair_hbond_dreiding_lj.cpp b/src/MOLECULE/pair_hbond_dreiding_lj.cpp
index 26ff499dec..c0c885d4d4 100644
--- a/src/MOLECULE/pair_hbond_dreiding_lj.cpp
+++ b/src/MOLECULE/pair_hbond_dreiding_lj.cpp
@@ -468,7 +468,7 @@ double PairHbondDreidingLJ::init_one(int i, int j)
 
 double PairHbondDreidingLJ::single(int i, int j, int itype, int jtype,
                                    double rsq,
-                                   double factor_coul, double factor_lj,
+                                   double /*factor_coul*/, double /*factor_lj*/,
                                    double &fforce)
 {
   int k,kk,ktype,knum,m;
diff --git a/src/MOLECULE/pair_hbond_dreiding_morse.cpp b/src/MOLECULE/pair_hbond_dreiding_morse.cpp
index 749053164c..f464d2c621 100644
--- a/src/MOLECULE/pair_hbond_dreiding_morse.cpp
+++ b/src/MOLECULE/pair_hbond_dreiding_morse.cpp
@@ -371,7 +371,7 @@ void PairHbondDreidingMorse::init_style()
 
 double PairHbondDreidingMorse::single(int i, int j, int itype, int jtype,
                                      double rsq,
-                                     double factor_coul, double factor_lj,
+                                     double /*factor_coul*/, double /*factor_lj*/,
                                      double &fforce)
 {
   int k,kk,ktype,knum,m;
diff --git a/src/MOLECULE/pair_tip4p_cut.cpp b/src/MOLECULE/pair_tip4p_cut.cpp
index e9f52b8724..79dd79b180 100644
--- a/src/MOLECULE/pair_tip4p_cut.cpp
+++ b/src/MOLECULE/pair_tip4p_cut.cpp
@@ -443,7 +443,7 @@ void PairTIP4PCut::init_style()
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
 
-double PairTIP4PCut::init_one(int i, int j)
+double PairTIP4PCut::init_one(int /*i*/, int /*j*/)
 {
   // include TIP4P qdist in full cutoff, qdist = 0.0 if not TIP4P
 
diff --git a/src/PERI/fix_peri_neigh.cpp b/src/PERI/fix_peri_neigh.cpp
index 42d86e14b2..2f5d4ac694 100644
--- a/src/PERI/fix_peri_neigh.cpp
+++ b/src/PERI/fix_peri_neigh.cpp
@@ -140,7 +140,7 @@ void FixPeriNeigh::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixPeriNeigh::init_list(int id, NeighList *ptr)
+void FixPeriNeigh::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
@@ -159,7 +159,7 @@ void FixPeriNeigh::min_setup(int vflag)
    must be done in setup (not init) since fix init comes before neigh init
 ------------------------------------------------------------------------- */
 
-void FixPeriNeigh::setup(int vflag)
+void FixPeriNeigh::setup(int /*vflag*/)
 {
   int i,j,ii,jj,itype,jtype,inum,jnum;
   double xtmp,ytmp,ztmp,delx,dely,delz,rsq;
@@ -441,7 +441,7 @@ void FixPeriNeigh::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixPeriNeigh::copy_arrays(int i, int j, int delflag)
+void FixPeriNeigh::copy_arrays(int i, int j, int /*delflag*/)
 {
   npartner[j] = npartner[i];
   for (int m = 0; m < npartner[j]; m++) {
@@ -514,7 +514,7 @@ int FixPeriNeigh::unpack_exchange(int nlocal, double *buf)
 /* ---------------------------------------------------------------------- */
 
 int FixPeriNeigh::pack_forward_comm(int n, int *list, double *buf,
-                                    int pbc_flag, int *pbc)
+                                    int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/PERI/pair_peri_eps.cpp b/src/PERI/pair_peri_eps.cpp
index 9950c36f41..fe2041d802 100644
--- a/src/PERI/pair_peri_eps.cpp
+++ b/src/PERI/pair_peri_eps.cpp
@@ -434,7 +434,7 @@ void PairPeriEPS::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairPeriEPS::settings(int narg, char **arg)
+void PairPeriEPS::settings(int narg, char **/*arg*/)
 {
   if (narg) error->all(FLERR,"Illegal pair_style command");
 }
@@ -799,7 +799,7 @@ double PairPeriEPS::compute_DeviatoricForceStateNorm(int i)
 ---------------------------------------------------------------------- */
 
 int PairPeriEPS::pack_forward_comm(int n, int *list, double *buf,
-                                   int pbc_flag, int *pbc)
+                                   int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/PERI/pair_peri_lps.cpp b/src/PERI/pair_peri_lps.cpp
index 4c48223b07..0ff0423801 100644
--- a/src/PERI/pair_peri_lps.cpp
+++ b/src/PERI/pair_peri_lps.cpp
@@ -364,7 +364,7 @@ void PairPeriLPS::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairPeriLPS::settings(int narg, char **arg)
+void PairPeriLPS::settings(int narg, char **/*arg*/)
 {
   if (narg) error->all(FLERR,"Illegal pair_style command");
 }
@@ -631,7 +631,7 @@ void PairPeriLPS::compute_dilatation()
  ---------------------------------------------------------------------- */
 
 int PairPeriLPS::pack_forward_comm(int n, int *list, double *buf,
-                                   int pbc_flag, int *pbc)
+                                   int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/PERI/pair_peri_pmb.cpp b/src/PERI/pair_peri_pmb.cpp
index 81461f0b83..772e47f2d6 100644
--- a/src/PERI/pair_peri_pmb.cpp
+++ b/src/PERI/pair_peri_pmb.cpp
@@ -297,7 +297,7 @@ void PairPeriPMB::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairPeriPMB::settings(int narg, char **arg)
+void PairPeriPMB::settings(int narg, char **/*arg*/)
 {
   if (narg) error->all(FLERR,"Illegal pair_style command");
 }
@@ -441,7 +441,7 @@ void PairPeriPMB::read_restart(FILE *fp)
 /* ---------------------------------------------------------------------- */
 
 double PairPeriPMB::single(int i, int j, int itype, int jtype, double rsq,
-                           double factor_coul, double factor_lj,
+                           double /*factor_coul*/, double /*factor_lj*/,
                            double &fforce)
 {
   double delx0,dely0,delz0,rsq0;
diff --git a/src/PERI/pair_peri_ves.cpp b/src/PERI/pair_peri_ves.cpp
index a9f620ef4b..a41d55b593 100644
--- a/src/PERI/pair_peri_ves.cpp
+++ b/src/PERI/pair_peri_ves.cpp
@@ -411,7 +411,7 @@ void PairPeriVES::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairPeriVES::settings(int narg, char **arg)
+void PairPeriVES::settings(int narg, char **/*arg*/)
 {
   if (narg) error->all(FLERR,"Illegal pair_style command");
 }
@@ -697,7 +697,7 @@ void PairPeriVES::compute_dilatation()
 ---------------------------------------------------------------------- */
 
 int PairPeriVES::pack_forward_comm(int n, int *list, double *buf,
-                                   int pbc_flag, int *pbc)
+                                   int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/QEQ/fix_qeq.cpp b/src/QEQ/fix_qeq.cpp
index 8acf4498f5..f6f41f57bd 100644
--- a/src/QEQ/fix_qeq.cpp
+++ b/src/QEQ/fix_qeq.cpp
@@ -274,7 +274,7 @@ void FixQEq::reallocate_matrix()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEq::init_list(int id, NeighList *ptr)
+void FixQEq::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
@@ -329,7 +329,7 @@ void FixQEq::init_storage()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEq::pre_force_respa(int vflag, int ilevel, int iloop)
+void FixQEq::pre_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) pre_force(vflag);
 }
@@ -471,7 +471,7 @@ void FixQEq::calculate_Q()
 /* ---------------------------------------------------------------------- */
 
 int FixQEq::pack_forward_comm(int n, int *list, double *buf,
-                          int pbc_flag, int *pbc)
+                          int /*pbc_flag*/, int */*pbc*/)
 {
   int m;
 
@@ -552,7 +552,7 @@ void FixQEq::grow_arrays(int nmax)
    copy values within fictitious charge arrays
 ------------------------------------------------------------------------- */
 
-void FixQEq::copy_arrays(int i, int j, int delflag)
+void FixQEq::copy_arrays(int i, int j, int /*delflag*/)
 {
   for (int m = 0; m < nprev; m++) {
     s_hist[j][m] = s_hist[i][m];
diff --git a/src/QEQ/fix_qeq_dynamic.cpp b/src/QEQ/fix_qeq_dynamic.cpp
index aeb8dd2c59..82112c5c11 100644
--- a/src/QEQ/fix_qeq_dynamic.cpp
+++ b/src/QEQ/fix_qeq_dynamic.cpp
@@ -88,7 +88,7 @@ void FixQEqDynamic::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqDynamic::pre_force(int vflag)
+void FixQEqDynamic::pre_force(int /*vflag*/)
 {
   int i,ii,iloop,inum,*ilist;
   double qmass,dtq2;
@@ -247,7 +247,7 @@ double FixQEqDynamic::compute_eneg()
 /* ---------------------------------------------------------------------- */
 
 int FixQEqDynamic::pack_forward_comm(int n, int *list, double *buf,
-                          int pbc_flag, int *pbc)
+                          int /*pbc_flag*/, int */*pbc*/)
 {
   int m=0;
 
diff --git a/src/QEQ/fix_qeq_fire.cpp b/src/QEQ/fix_qeq_fire.cpp
index db63bec206..d1683aa020 100644
--- a/src/QEQ/fix_qeq_fire.cpp
+++ b/src/QEQ/fix_qeq_fire.cpp
@@ -104,7 +104,7 @@ void FixQEqFire::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqFire::pre_force(int vflag)
+void FixQEqFire::pre_force(int /*vflag*/)
 {
   int inum, *ilist;
   int i,ii,iloop;
@@ -311,7 +311,7 @@ double FixQEqFire::compute_eneg()
 /* ---------------------------------------------------------------------- */
 
 int FixQEqFire::pack_forward_comm(int n, int *list, double *buf,
-                          int pbc_flag, int *pbc)
+                          int /*pbc_flag*/, int */*pbc*/)
 {
   int m = 0;
 
diff --git a/src/QEQ/fix_qeq_point.cpp b/src/QEQ/fix_qeq_point.cpp
index bf7130c1d6..db2d800c06 100644
--- a/src/QEQ/fix_qeq_point.cpp
+++ b/src/QEQ/fix_qeq_point.cpp
@@ -67,7 +67,7 @@ void FixQEqPoint::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqPoint::pre_force(int vflag)
+void FixQEqPoint::pre_force(int /*vflag*/)
 {
   if (update->ntimestep % nevery) return;
 
diff --git a/src/QEQ/fix_qeq_shielded.cpp b/src/QEQ/fix_qeq_shielded.cpp
index 70898fd96c..88cd1ab3ad 100644
--- a/src/QEQ/fix_qeq_shielded.cpp
+++ b/src/QEQ/fix_qeq_shielded.cpp
@@ -111,7 +111,7 @@ void FixQEqShielded::init_shielding()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqShielded::pre_force(int vflag)
+void FixQEqShielded::pre_force(int /*vflag*/)
 {
   if (update->ntimestep % nevery) return;
 
diff --git a/src/QEQ/fix_qeq_slater.cpp b/src/QEQ/fix_qeq_slater.cpp
index 4ddcf06357..81fdc73241 100644
--- a/src/QEQ/fix_qeq_slater.cpp
+++ b/src/QEQ/fix_qeq_slater.cpp
@@ -107,7 +107,7 @@ void FixQEqSlater::extract_streitz()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqSlater::pre_force(int vflag)
+void FixQEqSlater::pre_force(int /*vflag*/)
 {
   if (update->ntimestep % nevery) return;
 
diff --git a/src/REPLICA/fix_event.cpp b/src/REPLICA/fix_event.cpp
index 3b9b49ac57..8fc5de6b16 100644
--- a/src/REPLICA/fix_event.cpp
+++ b/src/REPLICA/fix_event.cpp
@@ -241,7 +241,7 @@ void FixEvent::grow_arrays(int nmax)
    copy values within local atom-based array
 ------------------------------------------------------------------------- */
 
-void FixEvent::copy_arrays(int i, int j, int delflag)
+void FixEvent::copy_arrays(int i, int j, int /*delflag*/)
 {
   xevent[j][0] = xevent[i][0];
   xevent[j][1] = xevent[i][1];
diff --git a/src/REPLICA/fix_neb.cpp b/src/REPLICA/fix_neb.cpp
index e5d24da392..dc86c70956 100644
--- a/src/REPLICA/fix_neb.cpp
+++ b/src/REPLICA/fix_neb.cpp
@@ -270,7 +270,7 @@ void FixNEB::min_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixNEB::min_post_force(int vflag)
+void FixNEB::min_post_force(int /*vflag*/)
 {
   double vprev,vnext;
   double delxp,delyp,delzp,delxn,delyn,delzn;
diff --git a/src/RIGID/fix_rattle.cpp b/src/RIGID/fix_rattle.cpp
index 7ade8d6848..403f3091c6 100644
--- a/src/RIGID/fix_rattle.cpp
+++ b/src/RIGID/fix_rattle.cpp
@@ -185,7 +185,7 @@ void FixRattle::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixRattle::post_force_respa(int vflag, int ilevel, int iloop)
+void FixRattle::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   // remember vflag for the coordinate correction in this->final_integrate
 
@@ -625,7 +625,7 @@ void FixRattle::update_v_half_nocons()
 
 /* ---------------------------------------------------------------------- */
 
-void FixRattle::update_v_half_nocons_respa(int ilevel)
+void FixRattle::update_v_half_nocons_respa(int /*ilevel*/)
 {
   // carry out unconstrained velocity update
 
diff --git a/src/RIGID/fix_rigid.cpp b/src/RIGID/fix_rigid.cpp
index 7104d30849..c0f33346bb 100644
--- a/src/RIGID/fix_rigid.cpp
+++ b/src/RIGID/fix_rigid.cpp
@@ -1096,7 +1096,7 @@ void FixRigid::compute_forces_and_torques()
 
 /* ---------------------------------------------------------------------- */
 
-void FixRigid::post_force(int vflag)
+void FixRigid::post_force(int /*vflag*/)
 {
   if (langflag) apply_langevin_thermostat();
   if (earlyflag) compute_forces_and_torques();
@@ -1141,7 +1141,7 @@ void FixRigid::final_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixRigid::initial_integrate_respa(int vflag, int ilevel, int iloop)
+void FixRigid::initial_integrate_respa(int vflag, int ilevel, int /*iloop*/)
 {
   dtv = step_respa[ilevel];
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
@@ -1153,7 +1153,7 @@ void FixRigid::initial_integrate_respa(int vflag, int ilevel, int iloop)
 
 /* ---------------------------------------------------------------------- */
 
-void FixRigid::final_integrate_respa(int ilevel, int iloop)
+void FixRigid::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
   final_integrate();
@@ -2478,7 +2478,7 @@ void FixRigid::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixRigid::copy_arrays(int i, int j, int delflag)
+void FixRigid::copy_arrays(int i, int j, int /*delflag*/)
 {
   body[j] = body[i];
   xcmimage[j] = xcmimage[i];
diff --git a/src/RIGID/fix_rigid_small.cpp b/src/RIGID/fix_rigid_small.cpp
index c1de89efc7..b2dbd27c46 100644
--- a/src/RIGID/fix_rigid_small.cpp
+++ b/src/RIGID/fix_rigid_small.cpp
@@ -867,7 +867,7 @@ void FixRigidSmall::enforce2d()
 
 /* ---------------------------------------------------------------------- */
 
-void FixRigidSmall::post_force(int vflag)
+void FixRigidSmall::post_force(int /*vflag*/)
 {
   if (langflag) apply_langevin_thermostat();
   if (earlyflag) compute_forces_and_torques();
@@ -1004,7 +1004,7 @@ void FixRigidSmall::final_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixRigidSmall::initial_integrate_respa(int vflag, int ilevel, int iloop)
+void FixRigidSmall::initial_integrate_respa(int vflag, int ilevel, int /*iloop*/)
 {
   dtv = step_respa[ilevel];
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
@@ -1016,7 +1016,7 @@ void FixRigidSmall::initial_integrate_respa(int vflag, int ilevel, int iloop)
 
 /* ---------------------------------------------------------------------- */
 
-void FixRigidSmall::final_integrate_respa(int ilevel, int iloop)
+void FixRigidSmall::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
   final_integrate();
@@ -2999,7 +2999,7 @@ int FixRigidSmall::unpack_exchange(int nlocal, double *buf)
 ------------------------------------------------------------------------- */
 
 int FixRigidSmall::pack_forward_comm(int n, int *list, double *buf,
-                                     int pbc_flag, int *pbc)
+                                     int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j;
   double *xcm,*vcm,*quat,*omega,*ex_space,*ey_space,*ez_space,*conjqm;
diff --git a/src/RIGID/fix_shake.cpp b/src/RIGID/fix_shake.cpp
index 0beef3bfa2..5c0139737c 100644
--- a/src/RIGID/fix_shake.cpp
+++ b/src/RIGID/fix_shake.cpp
@@ -2451,7 +2451,7 @@ void FixShake::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixShake::copy_arrays(int i, int j, int delflag)
+void FixShake::copy_arrays(int i, int j, int /*delflag*/)
 {
   int flag = shake_flag[j] = shake_flag[i];
   if (flag == 1) {
@@ -2528,7 +2528,7 @@ void FixShake::update_arrays(int i, int atom_offset)
 ------------------------------------------------------------------------- */
 
 void FixShake::set_molecule(int nlocalprev, tagint tagprev, int imol,
-                            double *xgeom, double *vcm, double *quat)
+                            double */*xgeom*/, double */*vcm*/, double */*quat*/)
 {
   int m,flag;
 
diff --git a/src/SHOCK/fix_append_atoms.cpp b/src/SHOCK/fix_append_atoms.cpp
index d898d2a790..2e515839c5 100644
--- a/src/SHOCK/fix_append_atoms.cpp
+++ b/src/SHOCK/fix_append_atoms.cpp
@@ -231,7 +231,7 @@ int FixAppendAtoms::setmask()
 
 /* ---------------------------------------------------------------------- */
 
-void FixAppendAtoms::initial_integrate(int vflag)
+void FixAppendAtoms::initial_integrate(int /*vflag*/)
 {
   if (update->ntimestep % freq == 0) next_reneighbor = update->ntimestep;
 }
@@ -331,7 +331,7 @@ int FixAppendAtoms::get_spatial()
 
 /* ---------------------------------------------------------------------- */
 
-void FixAppendAtoms::post_force(int vflag)
+void FixAppendAtoms::post_force(int /*vflag*/)
 {
   double **f = atom->f;
   double **v = atom->v;
diff --git a/src/SHOCK/fix_msst.cpp b/src/SHOCK/fix_msst.cpp
index a7890c3afa..c800e8a85d 100644
--- a/src/SHOCK/fix_msst.cpp
+++ b/src/SHOCK/fix_msst.cpp
@@ -357,7 +357,7 @@ void FixMSST::init()
    compute T,P before integrator starts
 ------------------------------------------------------------------------- */
 
-void FixMSST::setup(int vflag)
+void FixMSST::setup(int /*vflag*/)
 {
   lagrangian_position = 0.0;
 
@@ -442,7 +442,7 @@ void FixMSST::setup(int vflag)
    1st half of Verlet update
 ------------------------------------------------------------------------- */
 
-void FixMSST::initial_integrate(int vflag)
+void FixMSST::initial_integrate(int /*vflag*/)
 {
   int i,k;
   double p_msst;                       // MSST driving pressure
diff --git a/src/SHOCK/fix_wall_piston.cpp b/src/SHOCK/fix_wall_piston.cpp
index 7146b46c1e..eb89e19517 100644
--- a/src/SHOCK/fix_wall_piston.cpp
+++ b/src/SHOCK/fix_wall_piston.cpp
@@ -171,7 +171,7 @@ int FixWallPiston::setmask()
 
 /* ---------------------------------------------------------------------- */
 
-void FixWallPiston::initial_integrate(int vflag)
+void FixWallPiston::initial_integrate(int /*vflag*/)
 {
   next_reneighbor = update->ntimestep;
 }
diff --git a/src/SNAP/compute_sna_atom.cpp b/src/SNAP/compute_sna_atom.cpp
index 0d8b0bae14..a2c1f55788 100644
--- a/src/SNAP/compute_sna_atom.cpp
+++ b/src/SNAP/compute_sna_atom.cpp
@@ -184,7 +184,7 @@ void ComputeSNAAtom::init()
 
 /* ---------------------------------------------------------------------- */
 
-void ComputeSNAAtom::init_list(int id, NeighList *ptr)
+void ComputeSNAAtom::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/SNAP/compute_snad_atom.cpp b/src/SNAP/compute_snad_atom.cpp
index b0fef8e1e3..800d1942e3 100644
--- a/src/SNAP/compute_snad_atom.cpp
+++ b/src/SNAP/compute_snad_atom.cpp
@@ -186,7 +186,7 @@ void ComputeSNADAtom::init()
 
 /* ---------------------------------------------------------------------- */
 
-void ComputeSNADAtom::init_list(int id, NeighList *ptr)
+void ComputeSNADAtom::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/SNAP/compute_snav_atom.cpp b/src/SNAP/compute_snav_atom.cpp
index cf66b1c136..2b823f7b8b 100644
--- a/src/SNAP/compute_snav_atom.cpp
+++ b/src/SNAP/compute_snav_atom.cpp
@@ -181,7 +181,7 @@ void ComputeSNAVAtom::init()
 
 /* ---------------------------------------------------------------------- */
 
-void ComputeSNAVAtom::init_list(int id, NeighList *ptr)
+void ComputeSNAVAtom::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp
index 3150573043..7ed1bc1e23 100644
--- a/src/SNAP/sna.cpp
+++ b/src/SNAP/sna.cpp
@@ -1231,7 +1231,7 @@ void SNA::compute_uarray(double x, double y, double z,
 }
 
 void SNA::compute_uarray_omp(double x, double y, double z,
-                             double z0, double r, int sub_threads)
+                             double z0, double r, int /*sub_threads*/)
 {
   double r0inv;
   double a_r, b_r, a_i, b_i;
diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp
index 6460a6185f..24c4480e04 100644
--- a/src/SPIN/atom_vec_spin.cpp
+++ b/src/SPIN/atom_vec_spin.cpp
@@ -943,7 +943,7 @@ bigint AtomVecSpin::memory_usage()
   return bytes;
 }
 
-void AtomVecSpin::force_clear(int n, size_t nbytes)
+void AtomVecSpin::force_clear(int /*n*/, size_t nbytes)
 {
   memset(&atom->f[0][0],0,3*nbytes);
   memset(&atom->fm[0][0],0,3*nbytes);
diff --git a/src/SPIN/fix_langevin_spin.cpp b/src/SPIN/fix_langevin_spin.cpp
index cb34465482..55b4d8dfec 100644
--- a/src/SPIN/fix_langevin_spin.cpp
+++ b/src/SPIN/fix_langevin_spin.cpp
@@ -192,7 +192,7 @@ void FixLangevinSpin::add_temperature(double fmi[3])
 
 /* ---------------------------------------------------------------------- */
 
-void FixLangevinSpin::post_force_respa(int vflag, int ilevel, int iloop)
+void FixLangevinSpin::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
diff --git a/src/SPIN/fix_nve_spin.cpp b/src/SPIN/fix_nve_spin.cpp
index b75f03212a..898eb95396 100644
--- a/src/SPIN/fix_nve_spin.cpp
+++ b/src/SPIN/fix_nve_spin.cpp
@@ -258,7 +258,7 @@ void FixNVESpin::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVESpin::initial_integrate(int vflag)
+void FixNVESpin::initial_integrate(int /*vflag*/)
 {
   double dtfm;
 	
diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp
index b908478952..d3edb3ae8a 100644
--- a/src/SPIN/fix_precession_spin.cpp
+++ b/src/SPIN/fix_precession_spin.cpp
@@ -169,7 +169,7 @@ void FixPrecessionSpin::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixPrecessionSpin::post_force(int vflag)
+void FixPrecessionSpin::post_force(int /*vflag*/)
 {
   // update mag field with time (potential improvement)
 
@@ -245,7 +245,7 @@ void FixPrecessionSpin::compute_anisotropy(double spi[3], double fmi[3])
 
 /* ---------------------------------------------------------------------- */
 
-void FixPrecessionSpin::post_force_respa(int vflag, int ilevel, int iloop)
+void FixPrecessionSpin::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
diff --git a/src/SPIN/pair_spin.cpp b/src/SPIN/pair_spin.cpp
index 398206b26e..929b79bef3 100644
--- a/src/SPIN/pair_spin.cpp
+++ b/src/SPIN/pair_spin.cpp
@@ -63,7 +63,7 @@ PairSpin::~PairSpin() {}
    global settings
 ------------------------------------------------------------------------- */
 
-void PairSpin::settings(int narg, char **arg)
+void PairSpin::settings(int narg, char **/*arg*/)
 {
   if (narg < 1 || narg > 2)
     error->all(FLERR,"Incorrect number of args in pair_style pair/spin command");
diff --git a/src/SPIN/pair_spin_dmi.cpp b/src/SPIN/pair_spin_dmi.cpp
index 08e2c63e7f..6f8114042e 100644
--- a/src/SPIN/pair_spin_dmi.cpp
+++ b/src/SPIN/pair_spin_dmi.cpp
@@ -414,7 +414,7 @@ void PairSpinDmi::compute_dmi(int i, int j, double eij[3], double fmi[3], double
    compute the mechanical force due to the dmi interaction between atom i and atom j
 ------------------------------------------------------------------------- */
 
-void PairSpinDmi::compute_dmi_mech(int i, int j, double rsq, double eij[3], 
+void PairSpinDmi::compute_dmi_mech(int i, int j, double rsq, double /*eij*/[3], 
     double fi[3],  double spi[3], double spj[3])
 {
   int *type = atom->type;
diff --git a/src/SPIN/pair_spin_magelec.cpp b/src/SPIN/pair_spin_magelec.cpp
index 6bc1f71947..570c995754 100644
--- a/src/SPIN/pair_spin_magelec.cpp
+++ b/src/SPIN/pair_spin_magelec.cpp
@@ -380,7 +380,7 @@ void PairSpinMagelec::compute_single_pair(int ii, double fmi[3])
 
 /* ---------------------------------------------------------------------- */
 
-void PairSpinMagelec::compute_magelec(int i, int j, double rsq, double eij[3], double fmi[3], double spj[3])
+void PairSpinMagelec::compute_magelec(int i, int j, double /*rsq*/, double eij[3], double fmi[3], double spj[3])
 {
   int *type = atom->type;
   int itype, jtype;
diff --git a/src/SRD/fix_srd.cpp b/src/SRD/fix_srd.cpp
index 564c1e98d7..d6053f4aa4 100644
--- a/src/SRD/fix_srd.cpp
+++ b/src/SRD/fix_srd.cpp
@@ -440,7 +440,7 @@ void FixSRD::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixSRD::setup(int vflag)
+void FixSRD::setup(int /*vflag*/)
 {
   setup_bounds();
 
@@ -703,7 +703,7 @@ void FixSRD::pre_neighbor()
    when collision occurs, change x,v of SRD, force,torque of BIG particle
 ------------------------------------------------------------------------- */
 
-void FixSRD::post_force(int vflag)
+void FixSRD::post_force(int /*vflag*/)
 {
   int i,m,ix,iy,iz;
 
@@ -2168,8 +2168,8 @@ void FixSRD::collision_ellipsoid_inexact(double *xs, double *xb,
    norm = surface normal of collision pt at time of collision
 ------------------------------------------------------------------------- */
 
-double FixSRD::collision_line_exact(double *xs, double *xb,
-                                    double *vs, double *vb, Big *big,
+double FixSRD::collision_line_exact(double */*xs*/, double */*xb*/,
+                                    double */*vs*/, double */*vb*/, Big */*big*/,
                                     double dt_step,
                                     double *xscoll, double *xbcoll,
                                     double *norm)
@@ -2197,8 +2197,8 @@ double FixSRD::collision_line_exact(double *xs, double *xb,
    norm = surface normal of collision pt at time of collision
 ------------------------------------------------------------------------- */
 
-double FixSRD::collision_tri_exact(double *xs, double *xb,
-                                   double *vs, double *vb, Big *big,
+double FixSRD::collision_tri_exact(double */*xs*/, double */*xb*/,
+                                   double */*vs*/, double */*vb*/, Big */*big*/,
                                    double dt_step,
                                    double *xscoll, double *xbcoll,
                                    double *norm)
diff --git a/src/USER-BOCS/fix_bocs.cpp b/src/USER-BOCS/fix_bocs.cpp
index 7fb8a27110..eacfc83b40 100644
--- a/src/USER-BOCS/fix_bocs.cpp
+++ b/src/USER-BOCS/fix_bocs.cpp
@@ -790,7 +790,7 @@ void FixBocs::build_cubic_splines( double **data )
    compute T,P before integrator starts
 ------------------------------------------------------------------------- */
 
-void FixBocs::setup(int vflag)
+void FixBocs::setup(int /*vflag*/)
 {
   // tdof needed by compute_temp_target()
 
@@ -875,7 +875,7 @@ void FixBocs::setup(int vflag)
    1st half of Verlet update
 ------------------------------------------------------------------------- */
 
-void FixBocs::initial_integrate(int vflag)
+void FixBocs::initial_integrate(int /*vflag*/)
 {
   // update eta_press_dot
 
@@ -970,7 +970,7 @@ void FixBocs::final_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixBocs::initial_integrate_respa(int vflag, int ilevel, int iloop)
+void FixBocs::initial_integrate_respa(int /*vflag*/, int ilevel, int /*iloop*/)
 {
   // set timesteps by level
 
@@ -1039,7 +1039,7 @@ void FixBocs::initial_integrate_respa(int vflag, int ilevel, int iloop)
 
 /* ---------------------------------------------------------------------- */
 
-void FixBocs::final_integrate_respa(int ilevel, int iloop)
+void FixBocs::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   // set timesteps by level
 
diff --git a/src/USER-CGDNA/bond_oxdna_fene.cpp b/src/USER-CGDNA/bond_oxdna_fene.cpp
index 47d8d8f60b..34a25a9b5a 100644
--- a/src/USER-CGDNA/bond_oxdna_fene.cpp
+++ b/src/USER-CGDNA/bond_oxdna_fene.cpp
@@ -56,7 +56,7 @@ BondOxdnaFene::~BondOxdnaFene()
     compute vector COM-sugar-phosphate backbone interaction site in oxDNA
 ------------------------------------------------------------------------- */
 void BondOxdnaFene::compute_interaction_sites(double e1[3],
-  double e2[3], double r[3])
+  double /*e2*/[3], double r[3])
 {
   double d_cs=-0.4;
 
@@ -316,7 +316,7 @@ void BondOxdnaFene::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondOxdnaFene::single(int type, double rsq, int i, int j,
+double BondOxdnaFene::single(int type, double rsq, int /*i*/, int /*j*/,
                         double &fforce)
 {
   double r = sqrt(rsq);
diff --git a/src/USER-CGDNA/fix_nve_dot.cpp b/src/USER-CGDNA/fix_nve_dot.cpp
index 63f38a4e12..72b3388793 100644
--- a/src/USER-CGDNA/fix_nve_dot.cpp
+++ b/src/USER-CGDNA/fix_nve_dot.cpp
@@ -62,7 +62,7 @@ void FixNVEDot::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEDot::initial_integrate(int vflag)
+void FixNVEDot::initial_integrate(int /*vflag*/)
 {
   double *shape,*quat;
   double fquat[4],conjqm[4],inertia[3];
diff --git a/src/USER-CGDNA/fix_nve_dotc_langevin.cpp b/src/USER-CGDNA/fix_nve_dotc_langevin.cpp
index 90f7b1caeb..c73801c97a 100644
--- a/src/USER-CGDNA/fix_nve_dotc_langevin.cpp
+++ b/src/USER-CGDNA/fix_nve_dotc_langevin.cpp
@@ -127,7 +127,7 @@ void FixNVEDotcLangevin::compute_target()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEDotcLangevin::initial_integrate(int vflag)
+void FixNVEDotcLangevin::initial_integrate(int /*vflag*/)
 {
   double *shape,*quat;
   double fquat[4],conjqm[4],inertia[3];
diff --git a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp
index 151e752692..d31890ea52 100644
--- a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp
+++ b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp
@@ -542,7 +542,7 @@ void PairOxdna2Coaxstk::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairOxdna2Coaxstk::settings(int narg, char **arg)
+void PairOxdna2Coaxstk::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/USER-CGDNA/pair_oxdna2_dh.cpp b/src/USER-CGDNA/pair_oxdna2_dh.cpp
index 974ade89c1..da6e1f8bbd 100644
--- a/src/USER-CGDNA/pair_oxdna2_dh.cpp
+++ b/src/USER-CGDNA/pair_oxdna2_dh.cpp
@@ -264,7 +264,7 @@ void PairOxdna2Dh::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairOxdna2Dh::settings(int narg, char **arg)
+void PairOxdna2Dh::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp
index 0eb75fbb43..ca03bcb35c 100644
--- a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp
+++ b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp
@@ -666,7 +666,7 @@ void PairOxdnaCoaxstk::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairOxdnaCoaxstk::settings(int narg, char **arg)
+void PairOxdnaCoaxstk::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/USER-CGDNA/pair_oxdna_excv.cpp b/src/USER-CGDNA/pair_oxdna_excv.cpp
index e2b8334078..719a63b5f4 100644
--- a/src/USER-CGDNA/pair_oxdna_excv.cpp
+++ b/src/USER-CGDNA/pair_oxdna_excv.cpp
@@ -92,7 +92,7 @@ PairOxdnaExcv::~PairOxdnaExcv()
     compute vector COM-excluded volume interaction sites in oxDNA
 ------------------------------------------------------------------------- */
 void PairOxdnaExcv::compute_interaction_sites(double e1[3],
-  double e2[3], double rs[3], double rb[3])
+  double /*e2*/[3], double rs[3], double rb[3])
 {
   double d_cs=-0.4, d_cb=+0.4;
 
@@ -441,7 +441,7 @@ void PairOxdnaExcv::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairOxdnaExcv::settings(int narg, char **arg)
+void PairOxdnaExcv::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/USER-CGDNA/pair_oxdna_hbond.cpp b/src/USER-CGDNA/pair_oxdna_hbond.cpp
index ce1bfe036a..cb9f61bd7e 100644
--- a/src/USER-CGDNA/pair_oxdna_hbond.cpp
+++ b/src/USER-CGDNA/pair_oxdna_hbond.cpp
@@ -601,7 +601,7 @@ void PairOxdnaHbond::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairOxdnaHbond::settings(int narg, char **arg)
+void PairOxdnaHbond::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/USER-CGDNA/pair_oxdna_stk.cpp b/src/USER-CGDNA/pair_oxdna_stk.cpp
index 8c4498e627..f713e4d27c 100644
--- a/src/USER-CGDNA/pair_oxdna_stk.cpp
+++ b/src/USER-CGDNA/pair_oxdna_stk.cpp
@@ -647,7 +647,7 @@ void PairOxdnaStk::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairOxdnaStk::settings(int narg, char **arg)
+void PairOxdnaStk::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/USER-CGDNA/pair_oxdna_xstk.cpp b/src/USER-CGDNA/pair_oxdna_xstk.cpp
index e5b9de81c0..c4c23bf2c9 100644
--- a/src/USER-CGDNA/pair_oxdna_xstk.cpp
+++ b/src/USER-CGDNA/pair_oxdna_xstk.cpp
@@ -611,7 +611,7 @@ void PairOxdnaXstk::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairOxdnaXstk::settings(int narg, char **arg)
+void PairOxdnaXstk::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/USER-DIFFRACTION/fix_saed_vtk.cpp b/src/USER-DIFFRACTION/fix_saed_vtk.cpp
index 45bfeca48b..ad9c76ac6b 100644
--- a/src/USER-DIFFRACTION/fix_saed_vtk.cpp
+++ b/src/USER-DIFFRACTION/fix_saed_vtk.cpp
@@ -325,7 +325,7 @@ void FixSAEDVTK::init()
    only does something if nvalid = current timestep
 ------------------------------------------------------------------------- */
 
-void FixSAEDVTK::setup(int vflag)
+void FixSAEDVTK::setup(int /*vflag*/)
 {
   end_of_step();
 }
diff --git a/src/USER-DPD/fix_dpd_energy.cpp b/src/USER-DPD/fix_dpd_energy.cpp
index d89ea7759a..5759a164f5 100644
--- a/src/USER-DPD/fix_dpd_energy.cpp
+++ b/src/USER-DPD/fix_dpd_energy.cpp
@@ -57,7 +57,7 @@ int FixDPDenergy::setmask()
    allow for both per-type and per-atom mass
 ------------------------------------------------------------------------- */
 
-void FixDPDenergy::initial_integrate(int vflag)
+void FixDPDenergy::initial_integrate(int /*vflag*/)
 {
   int nlocal = atom->nlocal;
   if (igroup == atom->firstgroup) nlocal = atom->nfirst;
diff --git a/src/USER-DPD/fix_eos_table_rx.cpp b/src/USER-DPD/fix_eos_table_rx.cpp
index 73144c0a0f..0bb96d7664 100644
--- a/src/USER-DPD/fix_eos_table_rx.cpp
+++ b/src/USER-DPD/fix_eos_table_rx.cpp
@@ -178,7 +178,7 @@ int FixEOStableRX::setmask()
 
 /* ---------------------------------------------------------------------- */
 
-void FixEOStableRX::setup(int vflag)
+void FixEOStableRX::setup(int /*vflag*/)
 {
   int nlocal = atom->nlocal;
   int *mask = atom->mask;
@@ -803,7 +803,7 @@ void FixEOStableRX::temperature_lookup(int id, double ui, double &thetai)
 
 /* ---------------------------------------------------------------------- */
 
-int FixEOStableRX::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc)
+int FixEOStableRX::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/)
 {
   int ii,jj,m;
   double *uChem = atom->uChem;
diff --git a/src/USER-DPD/fix_rx.cpp b/src/USER-DPD/fix_rx.cpp
index be78989bb5..4dae89b491 100644
--- a/src/USER-DPD/fix_rx.cpp
+++ b/src/USER-DPD/fix_rx.cpp
@@ -668,7 +668,7 @@ void FixRX::init_list(int, class NeighList* ptr)
 
 /* ---------------------------------------------------------------------- */
 
-void FixRX::setup_pre_force(int vflag)
+void FixRX::setup_pre_force(int /*vflag*/)
 {
   int nlocal = atom->nlocal;
   int nghost = atom->nghost;
@@ -727,7 +727,7 @@ void FixRX::setup_pre_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixRX::pre_force(int vflag)
+void FixRX::pre_force(int /*vflag*/)
 {
   TimerType timer_start = getTimeStamp();
 
@@ -1191,7 +1191,7 @@ void FixRX::rkf45_step (const int neq, const double h, double y[], double y_out[
    return;
 }
 
-int FixRX::rkf45_h0 (const int neq, const double t, const double t_stop,
+int FixRX::rkf45_h0 (const int neq, const double t, const double /*t_stop*/,
                      const double hmin, const double hmax,
                      double& h0, double y[], double rwk[], void* v_params)
 {
@@ -1668,7 +1668,7 @@ int FixRX::rhs(double t, const double *y, double *dydt, void *params)
 
 /* ---------------------------------------------------------------------- */
 
-int FixRX::rhs_dense(double t, const double *y, double *dydt, void *params)
+int FixRX::rhs_dense(double /*t*/, const double *y, double *dydt, void *params)
 {
   UserRHSData *userData = (UserRHSData *) params;
 
@@ -1702,7 +1702,7 @@ int FixRX::rhs_dense(double t, const double *y, double *dydt, void *params)
 
 /* ---------------------------------------------------------------------- */
 
-int FixRX::rhs_sparse(double t, const double *y, double *dydt, void *v_params) const
+int FixRX::rhs_sparse(double /*t*/, const double *y, double *dydt, void *v_params) const
 {
    UserRHSData *userData = (UserRHSData *) v_params;
 
@@ -1885,7 +1885,7 @@ void FixRX::computeLocalTemperature()
 
 /* ---------------------------------------------------------------------- */
 
-int FixRX::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc)
+int FixRX::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/)
 {
   int ii,jj,m;
   double tmp;
diff --git a/src/USER-DPD/fix_shardlow.cpp b/src/USER-DPD/fix_shardlow.cpp
index 7fe865c8e6..9e8ee41533 100644
--- a/src/USER-DPD/fix_shardlow.cpp
+++ b/src/USER-DPD/fix_shardlow.cpp
@@ -145,14 +145,14 @@ void FixShardlow::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixShardlow::init_list(int id, NeighList *ptr)
+void FixShardlow::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
 
 /* ---------------------------------------------------------------------- */
 
-void FixShardlow::setup(int vflag)
+void FixShardlow::setup(int /*vflag*/)
 {
   bool fixShardlow = false;
 
@@ -527,7 +527,7 @@ while (ct-- > 0) {
   rand_state[id] = RNGstate;
 }
 
-void FixShardlow::initial_integrate(int vflag)
+void FixShardlow::initial_integrate(int /*vflag*/)
 {
   int ii;
 
@@ -646,7 +646,7 @@ fprintf(stdout, "\n%6d %6d,%6d %6d: "
 
 /* ---------------------------------------------------------------------- */
 
-int FixShardlow::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc)
+int FixShardlow::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/)
 {
   int ii,jj,m;
   double **v  = atom->v;
diff --git a/src/USER-DPD/pair_dpd_fdt.cpp b/src/USER-DPD/pair_dpd_fdt.cpp
index aeade16e7c..12e6d9f257 100644
--- a/src/USER-DPD/pair_dpd_fdt.cpp
+++ b/src/USER-DPD/pair_dpd_fdt.cpp
@@ -433,8 +433,8 @@ void PairDPDfdt::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairDPDfdt::single(int i, int j, int itype, int jtype, double rsq,
-                       double factor_coul, double factor_dpd, double &fforce)
+double PairDPDfdt::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                       double /*factor_coul*/, double factor_dpd, double &fforce)
 {
   double r,rinv,wr,wd,phi;
 
diff --git a/src/USER-DPD/pair_dpd_fdt_energy.cpp b/src/USER-DPD/pair_dpd_fdt_energy.cpp
index 05dc52eac7..42c23e3ad2 100644
--- a/src/USER-DPD/pair_dpd_fdt_energy.cpp
+++ b/src/USER-DPD/pair_dpd_fdt_energy.cpp
@@ -534,8 +534,8 @@ void PairDPDfdtEnergy::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairDPDfdtEnergy::single(int i, int j, int itype, int jtype, double rsq,
-                       double factor_coul, double factor_dpd, double &fforce)
+double PairDPDfdtEnergy::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                       double /*factor_coul*/, double factor_dpd, double &fforce)
 {
   double r,rinv,wr,wd,phi;
 
diff --git a/src/USER-DPD/pair_multi_lucy.cpp b/src/USER-DPD/pair_multi_lucy.cpp
index 3d204a849e..a7701f4d93 100644
--- a/src/USER-DPD/pair_multi_lucy.cpp
+++ b/src/USER-DPD/pair_multi_lucy.cpp
@@ -781,7 +781,7 @@ void PairMultiLucy::computeLocalDensity()
 }
 /* ---------------------------------------------------------------------- */
 
-int PairMultiLucy::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc)
+int PairMultiLucy::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
   double *rho = atom->rho;
diff --git a/src/USER-DPD/pair_multi_lucy_rx.cpp b/src/USER-DPD/pair_multi_lucy_rx.cpp
index 0070ca82d9..744c1ff64d 100644
--- a/src/USER-DPD/pair_multi_lucy_rx.cpp
+++ b/src/USER-DPD/pair_multi_lucy_rx.cpp
@@ -1019,7 +1019,7 @@ void PairMultiLucyRX::getMixingWeights(int id, double &mixWtSite1old, double &mi
 
 /* ---------------------------------------------------------------------- */
 
-int PairMultiLucyRX::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc)
+int PairMultiLucyRX::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
   double *rho = atom->rho;
diff --git a/src/USER-DPD/pair_table_rx.cpp b/src/USER-DPD/pair_table_rx.cpp
index 221944edc5..1e7bc440d1 100644
--- a/src/USER-DPD/pair_table_rx.cpp
+++ b/src/USER-DPD/pair_table_rx.cpp
@@ -439,7 +439,7 @@ void PairTableRX::coeff(int narg, char **arg)
 /* ---------------------------------------------------------------------- */
 
 double PairTableRX::single(int i, int j, int itype, int jtype, double rsq,
-                         double factor_coul, double factor_lj,
+                         double /*factor_coul*/, double factor_lj,
                          double &fforce)
 {
   int itable;
diff --git a/src/USER-DRUDE/fix_drude.cpp b/src/USER-DRUDE/fix_drude.cpp
index 19fd775715..7800efe7ff 100644
--- a/src/USER-DRUDE/fix_drude.cpp
+++ b/src/USER-DRUDE/fix_drude.cpp
@@ -235,7 +235,7 @@ void FixDrude::grow_arrays(int nmax)
    copy values within local atom-based array
 ------------------------------------------------------------------------- */
 
-void FixDrude::copy_arrays(int i, int j, int delflag)
+void FixDrude::copy_arrays(int i, int j, int /*delflag*/)
 {
     drudeid[j] = drudeid[i];
 }
diff --git a/src/USER-DRUDE/fix_langevin_drude.cpp b/src/USER-DRUDE/fix_langevin_drude.cpp
index 235c5d224b..b9d1139f83 100644
--- a/src/USER-DRUDE/fix_langevin_drude.cpp
+++ b/src/USER-DRUDE/fix_langevin_drude.cpp
@@ -157,7 +157,7 @@ void FixLangevinDrude::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixLangevinDrude::setup(int vflag)
+void FixLangevinDrude::setup(int /*vflag*/)
 {
   if (!strstr(update->integrate_style,"verlet"))
     error->all(FLERR,"RESPA style not compatible with fix langevin/drude");
diff --git a/src/USER-DRUDE/pair_thole.cpp b/src/USER-DRUDE/pair_thole.cpp
index 8c20ee8c42..6901ad1f2d 100644
--- a/src/USER-DRUDE/pair_thole.cpp
+++ b/src/USER-DRUDE/pair_thole.cpp
@@ -363,7 +363,7 @@ void PairThole::read_restart_settings(FILE *fp)
 /* ---------------------------------------------------------------------- */
 
 double PairThole::single(int i, int j, int itype, int jtype,
-                         double rsq, double factor_coul, double factor_lj,
+                         double rsq, double factor_coul, double /*factor_lj*/,
                          double &fforce)
 {
   double r2inv,rinv,r,phicoul;
diff --git a/src/USER-EFF/compute_temp_deform_eff.cpp b/src/USER-EFF/compute_temp_deform_eff.cpp
index d3856e431d..23abb4f99d 100644
--- a/src/USER-EFF/compute_temp_deform_eff.cpp
+++ b/src/USER-EFF/compute_temp_deform_eff.cpp
@@ -290,7 +290,7 @@ void ComputeTempDeformEff::remove_bias_all()
    assume remove_bias() was previously called
 ------------------------------------------------------------------------- */
 
-void ComputeTempDeformEff::restore_bias(int i, double *v)
+void ComputeTempDeformEff::restore_bias(int /*i*/, double *v)
 {
   v[0] += vbias[0];
   v[1] += vbias[1];
diff --git a/src/USER-EFF/compute_temp_region_eff.cpp b/src/USER-EFF/compute_temp_region_eff.cpp
index 4548914ce1..659bdfca5e 100644
--- a/src/USER-EFF/compute_temp_region_eff.cpp
+++ b/src/USER-EFF/compute_temp_region_eff.cpp
@@ -263,7 +263,7 @@ void ComputeTempRegionEff::remove_bias_all()
    assume remove_bias() was previously called
 ------------------------------------------------------------------------- */
 
-void ComputeTempRegionEff::restore_bias(int i, double *v)
+void ComputeTempRegionEff::restore_bias(int /*i*/, double *v)
 {
   v[0] += vbias[0];
   v[1] += vbias[1];
diff --git a/src/USER-EFF/fix_langevin_eff.cpp b/src/USER-EFF/fix_langevin_eff.cpp
index 2d0eef8e85..d362113997 100644
--- a/src/USER-EFF/fix_langevin_eff.cpp
+++ b/src/USER-EFF/fix_langevin_eff.cpp
@@ -63,7 +63,7 @@ FixLangevinEff::~FixLangevinEff()
 
 /* ---------------------------------------------------------------------- */
 
-void FixLangevinEff::post_force(int vflag)
+void FixLangevinEff::post_force(int /*vflag*/)
 {
   if (tallyflag) post_force_tally();
   else post_force_no_tally();
diff --git a/src/USER-EFF/fix_nve_eff.cpp b/src/USER-EFF/fix_nve_eff.cpp
index 584714a44e..699dd9f949 100644
--- a/src/USER-EFF/fix_nve_eff.cpp
+++ b/src/USER-EFF/fix_nve_eff.cpp
@@ -68,7 +68,7 @@ void FixNVEEff::init()
    allow for both per-type and per-atom mass
 ------------------------------------------------------------------------- */
 
-void FixNVEEff::initial_integrate(int vflag)
+void FixNVEEff::initial_integrate(int /*vflag*/)
 {
   double dtfm;
 
@@ -145,7 +145,7 @@ void FixNVEEff::final_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEEff::initial_integrate_respa(int vflag, int ilevel, int iloop)
+void FixNVEEff::initial_integrate_respa(int vflag, int ilevel, int /*iloop*/)
 {
   dtv = step_respa[ilevel];
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
@@ -159,7 +159,7 @@ void FixNVEEff::initial_integrate_respa(int vflag, int ilevel, int iloop)
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEEff::final_integrate_respa(int ilevel, int iloop)
+void FixNVEEff::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
   final_integrate();
diff --git a/src/USER-EFF/pair_eff_cut.cpp b/src/USER-EFF/pair_eff_cut.cpp
index 0379c0264b..b4e9011e33 100644
--- a/src/USER-EFF/pair_eff_cut.cpp
+++ b/src/USER-EFF/pair_eff_cut.cpp
@@ -1009,7 +1009,7 @@ void PairEffCut::read_restart_settings(FILE *fp)
    these arrays are stored locally by pair style
 ------------------------------------------------------------------------- */
 
-void PairEffCut::min_xf_pointers(int ignore, double **xextra, double **fextra)
+void PairEffCut::min_xf_pointers(int /*ignore*/, double **xextra, double **fextra)
 {
   // grow arrays if necessary
   // need to be atom->nmax in length
@@ -1031,7 +1031,7 @@ void PairEffCut::min_xf_pointers(int ignore, double **xextra, double **fextra)
    calculate and store in min_eradius and min_erforce
 ------------------------------------------------------------------------- */
 
-void PairEffCut::min_xf_get(int ignore)
+void PairEffCut::min_xf_get(int /*ignore*/)
 {
   double *eradius = atom->eradius;
   double *erforce = atom->erforce;
@@ -1050,7 +1050,7 @@ void PairEffCut::min_xf_get(int ignore)
    propagate the change back to eradius
 ------------------------------------------------------------------------- */
 
-void PairEffCut::min_x_set(int ignore)
+void PairEffCut::min_x_set(int /*ignore*/)
 {
   double *eradius = atom->eradius;
   int *spin = atom->spin;
diff --git a/src/USER-FEP/fix_adapt_fep.cpp b/src/USER-FEP/fix_adapt_fep.cpp
index 3b8c9d4201..7304bc4ef6 100644
--- a/src/USER-FEP/fix_adapt_fep.cpp
+++ b/src/USER-FEP/fix_adapt_fep.cpp
@@ -387,7 +387,7 @@ void FixAdaptFEP::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixAdaptFEP::setup_pre_force(int vflag)
+void FixAdaptFEP::setup_pre_force(int /*vflag*/)
 {
   change_settings();
 }
@@ -402,7 +402,7 @@ void FixAdaptFEP::setup_pre_force_respa(int vflag, int ilevel)
 
 /* ---------------------------------------------------------------------- */
 
-void FixAdaptFEP::pre_force(int vflag)
+void FixAdaptFEP::pre_force(int /*vflag*/)
 {
   if (nevery == 0) return;
 
diff --git a/src/USER-FEP/pair_coul_cut_soft.cpp b/src/USER-FEP/pair_coul_cut_soft.cpp
index 5bcb5a7522..529ffe6b09 100644
--- a/src/USER-FEP/pair_coul_cut_soft.cpp
+++ b/src/USER-FEP/pair_coul_cut_soft.cpp
@@ -347,7 +347,7 @@ void PairCoulCutSoft::write_data_all(FILE *fp)
 /* ---------------------------------------------------------------------- */
 
 double PairCoulCutSoft::single(int i, int j, int itype, int jtype,
-                           double rsq, double factor_coul, double factor_lj,
+                           double rsq, double factor_coul, double /*factor_lj*/,
                            double &fforce)
 {
   double forcecoul,phicoul;
diff --git a/src/USER-FEP/pair_coul_long_soft.cpp b/src/USER-FEP/pair_coul_long_soft.cpp
index 94bb3659fa..e45dbe72d6 100644
--- a/src/USER-FEP/pair_coul_long_soft.cpp
+++ b/src/USER-FEP/pair_coul_long_soft.cpp
@@ -348,7 +348,7 @@ void PairCoulLongSoft::read_restart_settings(FILE *fp)
 
 double PairCoulLongSoft::single(int i, int j, int itype, int jtype,
                             double rsq,
-                            double factor_coul, double factor_lj,
+                            double factor_coul, double /*factor_lj*/,
                             double &fforce)
 {
   double r,grij,expm2,t,erfc,prefactor;
diff --git a/src/USER-FEP/pair_lj_cut_soft.cpp b/src/USER-FEP/pair_lj_cut_soft.cpp
index 4aaa5c2925..a33445f6f8 100644
--- a/src/USER-FEP/pair_lj_cut_soft.cpp
+++ b/src/USER-FEP/pair_lj_cut_soft.cpp
@@ -735,8 +735,8 @@ void PairLJCutSoft::write_data_all(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairLJCutSoft::single(int i, int j, int itype, int jtype, double rsq,
-                         double factor_coul, double factor_lj,
+double PairLJCutSoft::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                         double /*factor_coul*/, double factor_lj,
                          double &fforce)
 {
   double forcelj,philj;
diff --git a/src/USER-FEP/pair_morse_soft.cpp b/src/USER-FEP/pair_morse_soft.cpp
index 7a897e1870..965d570863 100644
--- a/src/USER-FEP/pair_morse_soft.cpp
+++ b/src/USER-FEP/pair_morse_soft.cpp
@@ -360,8 +360,8 @@ void PairMorseSoft::write_data_all(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairMorseSoft::single(int i, int j, int itype, int jtype, double rsq,
-                             double factor_coul, double factor_lj,
+double PairMorseSoft::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                             double /*factor_coul*/, double factor_lj,
                              double &fforce)
 {
   double r, dr, dexp, dexp2, dexp3, phi;
diff --git a/src/USER-INTEL/angle_charmm_intel.cpp b/src/USER-INTEL/angle_charmm_intel.cpp
index 672b70b6f6..eddef5bce8 100644
--- a/src/USER-INTEL/angle_charmm_intel.cpp
+++ b/src/USER-INTEL/angle_charmm_intel.cpp
@@ -332,7 +332,7 @@ void AngleCharmmIntel::init_style()
 
 template <class flt_t, class acc_t>
 void AngleCharmmIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                        IntelBuffers<flt_t,acc_t> *buffers)
+                                        IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->nangletypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/angle_harmonic_intel.cpp b/src/USER-INTEL/angle_harmonic_intel.cpp
index 74639f3aeb..077825332c 100644
--- a/src/USER-INTEL/angle_harmonic_intel.cpp
+++ b/src/USER-INTEL/angle_harmonic_intel.cpp
@@ -314,7 +314,7 @@ void AngleHarmonicIntel::init_style()
 
 template <class flt_t, class acc_t>
 void AngleHarmonicIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                        IntelBuffers<flt_t,acc_t> *buffers)
+                                        IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->nangletypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/bond_fene_intel.cpp b/src/USER-INTEL/bond_fene_intel.cpp
index 2d70049a89..88fa65f555 100644
--- a/src/USER-INTEL/bond_fene_intel.cpp
+++ b/src/USER-INTEL/bond_fene_intel.cpp
@@ -291,7 +291,7 @@ void BondFENEIntel::init_style()
 
 template <class flt_t, class acc_t>
 void BondFENEIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                         IntelBuffers<flt_t,acc_t> *buffers)
+                                         IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->nbondtypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/bond_harmonic_intel.cpp b/src/USER-INTEL/bond_harmonic_intel.cpp
index ed9cab082e..f4ab991b1c 100644
--- a/src/USER-INTEL/bond_harmonic_intel.cpp
+++ b/src/USER-INTEL/bond_harmonic_intel.cpp
@@ -262,7 +262,7 @@ void BondHarmonicIntel::init_style()
 
 template <class flt_t, class acc_t>
 void BondHarmonicIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                         IntelBuffers<flt_t,acc_t> *buffers)
+                                         IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->nbondtypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/dihedral_fourier_intel.cpp b/src/USER-INTEL/dihedral_fourier_intel.cpp
index 6ad25f1ce4..7494fef3bf 100644
--- a/src/USER-INTEL/dihedral_fourier_intel.cpp
+++ b/src/USER-INTEL/dihedral_fourier_intel.cpp
@@ -401,7 +401,7 @@ void DihedralFourierIntel::init_style()
 
 template <class flt_t, class acc_t>
 void DihedralFourierIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                            IntelBuffers<flt_t,acc_t> *buffers)
+                                            IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->ndihedraltypes + 1;
   fc.set_ntypes(bp1, setflag, nterms, memory);
diff --git a/src/USER-INTEL/dihedral_harmonic_intel.cpp b/src/USER-INTEL/dihedral_harmonic_intel.cpp
index b2bf54102c..57361b9527 100644
--- a/src/USER-INTEL/dihedral_harmonic_intel.cpp
+++ b/src/USER-INTEL/dihedral_harmonic_intel.cpp
@@ -396,7 +396,7 @@ void DihedralHarmonicIntel::init_style()
 
 template <class flt_t, class acc_t>
 void DihedralHarmonicIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                             IntelBuffers<flt_t,acc_t> *buffers)
+                                             IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->ndihedraltypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/dihedral_opls_intel.cpp b/src/USER-INTEL/dihedral_opls_intel.cpp
index 832ce7ed50..ae2810f662 100644
--- a/src/USER-INTEL/dihedral_opls_intel.cpp
+++ b/src/USER-INTEL/dihedral_opls_intel.cpp
@@ -416,7 +416,7 @@ void DihedralOPLSIntel::init_style()
 
 template <class flt_t, class acc_t>
 void DihedralOPLSIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                             IntelBuffers<flt_t,acc_t> *buffers)
+                                             IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->ndihedraltypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/fix_intel.cpp b/src/USER-INTEL/fix_intel.cpp
index 7a206f472a..4c703da833 100644
--- a/src/USER-INTEL/fix_intel.cpp
+++ b/src/USER-INTEL/fix_intel.cpp
@@ -349,7 +349,7 @@ void FixIntel::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixIntel::setup(int vflag)
+void FixIntel::setup(int /*vflag*/)
 {
   if (neighbor->style != Neighbor::BIN)
     error->all(FLERR,
@@ -539,7 +539,7 @@ void FixIntel::check_neighbor_intel()
 
 /* ---------------------------------------------------------------------- */
 
-void FixIntel::pre_reverse(int eflag, int vflag)
+void FixIntel::pre_reverse(int /*eflag*/, int /*vflag*/)
 {
   if (_force_array_m != 0) {
     if (_need_reduce) {
@@ -652,7 +652,7 @@ template <class ft, class acc_t>
 void FixIntel::add_results(const ft * _noalias const f_in,
                            const acc_t * _noalias const ev_global,
                            const int eatom, const int vatom,
-                           const int offload) {
+                           const int /*offload*/) {
   start_watch(TIME_PACK);
   int f_length;
   #ifdef _LMP_INTEL_OFFLOAD
@@ -719,7 +719,7 @@ void FixIntel::add_results(const ft * _noalias const f_in,
 template <class ft, class acc_t>
 void FixIntel::add_oresults(const ft * _noalias const f_in,
                             const acc_t * _noalias const ev_global,
-                            const int eatom, const int vatom,
+                            const int eatom, const int /*vatom*/,
                             const int out_offset, const int nall) {
   lmp_ft * _noalias const f = (lmp_ft *) lmp->atom->f[0] + out_offset;
   if (atom->torque) {
diff --git a/src/USER-INTEL/fix_intel.h b/src/USER-INTEL/fix_intel.h
index 79fb23ab3d..e6e09be503 100644
--- a/src/USER-INTEL/fix_intel.h
+++ b/src/USER-INTEL/fix_intel.h
@@ -74,7 +74,7 @@ class FixIntel : public Fix {
   inline int nbor_pack_width() const { return _nbor_pack_width; }
   inline void nbor_pack_width(const int w) { _nbor_pack_width = w; }
   inline int three_body_neighbor() { return _three_body_neighbor; }
-  inline void three_body_neighbor(const int i) { _three_body_neighbor = 1; }
+  inline void three_body_neighbor(const int /*i*/) { _three_body_neighbor = 1; }
 
   inline int need_zero(const int tid) {
     if (_need_reduce == 0 && tid > 0) return 1;
@@ -159,8 +159,8 @@ class FixIntel : public Fix {
   inline int host_start_neighbor() { return 0; }
   inline int host_start_pair() { return 0; }
   inline void zero_timers() {}
-  inline void start_watch(const int which) {}
-  inline double stop_watch(const int which) { return 0.0; }
+  inline void start_watch(const int /*which*/) {}
+  inline double stop_watch(const int /*which*/) { return 0.0; }
   double * off_watch_pair() { return NULL; }
   double * off_watch_neighbor() { return NULL; }
   inline void balance_stamp() {}
@@ -238,7 +238,7 @@ class FixIntel : public Fix {
 
 /* ---------------------------------------------------------------------- */
 
-void FixIntel::get_buffern(const int offload, int &nlocal, int &nall,
+void FixIntel::get_buffern(const int /*offload*/, int &nlocal, int &nall,
                            int &minlocal) {
   #ifdef _LMP_INTEL_OFFLOAD
   if (_separate_buffers) {
@@ -273,7 +273,7 @@ void FixIntel::get_buffern(const int offload, int &nlocal, int &nall,
 /* ---------------------------------------------------------------------- */
 
 void FixIntel::add_result_array(IntelBuffers<double,double>::vec3_acc_t *f_in,
-                                double *ev_in, const int offload,
+                                double *ev_in, const int /*offload*/,
                                 const int eatom, const int vatom,
                                 const int rflag) {
   #ifdef _LMP_INTEL_OFFLOAD
@@ -301,7 +301,7 @@ void FixIntel::add_result_array(IntelBuffers<double,double>::vec3_acc_t *f_in,
 /* ---------------------------------------------------------------------- */
 
 void FixIntel::add_result_array(IntelBuffers<float,double>::vec3_acc_t *f_in,
-                                double *ev_in, const int offload,
+                                double *ev_in, const int /*offload*/,
                                 const int eatom, const int vatom,
                                 const int rflag) {
   #ifdef _LMP_INTEL_OFFLOAD
@@ -329,7 +329,7 @@ void FixIntel::add_result_array(IntelBuffers<float,double>::vec3_acc_t *f_in,
 /* ---------------------------------------------------------------------- */
 
 void FixIntel::add_result_array(IntelBuffers<float,float>::vec3_acc_t *f_in,
-                                float *ev_in, const int offload,
+                                float *ev_in, const int /*offload*/,
                                 const int eatom, const int vatom,
                                 const int rflag) {
   #ifdef _LMP_INTEL_OFFLOAD
diff --git a/src/USER-INTEL/fix_nve_asphere_intel.cpp b/src/USER-INTEL/fix_nve_asphere_intel.cpp
index 17bbcff771..a83306def5 100644
--- a/src/USER-INTEL/fix_nve_asphere_intel.cpp
+++ b/src/USER-INTEL/fix_nve_asphere_intel.cpp
@@ -79,7 +79,7 @@ void FixNVEAsphereIntel::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVEAsphereIntel::initial_integrate(int vflag)
+void FixNVEAsphereIntel::initial_integrate(int /*vflag*/)
 {
   double dtfm;
   double inertia[3],omega[3];
diff --git a/src/USER-INTEL/fix_nve_intel.cpp b/src/USER-INTEL/fix_nve_intel.cpp
index c0f6da06ae..7dee31d2f4 100644
--- a/src/USER-INTEL/fix_nve_intel.cpp
+++ b/src/USER-INTEL/fix_nve_intel.cpp
@@ -56,7 +56,7 @@ void FixNVEIntel::setup(int vflag)
    allow for both per-type and per-atom mass
 ------------------------------------------------------------------------- */
 
-void FixNVEIntel::initial_integrate(int vflag)
+void FixNVEIntel::initial_integrate(int /*vflag*/)
 {
   // update v and x of atoms in group
 
diff --git a/src/USER-INTEL/improper_cvff_intel.cpp b/src/USER-INTEL/improper_cvff_intel.cpp
index e0ef2162d1..025206dc67 100644
--- a/src/USER-INTEL/improper_cvff_intel.cpp
+++ b/src/USER-INTEL/improper_cvff_intel.cpp
@@ -428,7 +428,7 @@ void ImproperCvffIntel::init_style()
 
 template <class flt_t, class acc_t>
 void ImproperCvffIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                             IntelBuffers<flt_t,acc_t> *buffers)
+                                             IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->nimpropertypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/improper_harmonic_intel.cpp b/src/USER-INTEL/improper_harmonic_intel.cpp
index 60cbe16358..dde67e1d76 100644
--- a/src/USER-INTEL/improper_harmonic_intel.cpp
+++ b/src/USER-INTEL/improper_harmonic_intel.cpp
@@ -384,7 +384,7 @@ void ImproperHarmonicIntel::init_style()
 
 template <class flt_t, class acc_t>
 void ImproperHarmonicIntel::pack_force_const(ForceConst<flt_t> &fc,
-                                             IntelBuffers<flt_t,acc_t> *buffers)
+                                             IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   const int bp1 = atom->nimpropertypes + 1;
   fc.set_ntypes(bp1,memory);
diff --git a/src/USER-INTEL/intel_buffers.cpp b/src/USER-INTEL/intel_buffers.cpp
index 0f32cb48b2..ada70a18a4 100644
--- a/src/USER-INTEL/intel_buffers.cpp
+++ b/src/USER-INTEL/intel_buffers.cpp
@@ -109,7 +109,7 @@ void IntelBuffers<flt_t, acc_t>::free_buffers()
 template <class flt_t, class acc_t>
 void IntelBuffers<flt_t, acc_t>::_grow(const int nall, const int nlocal,
                                        const int nthreads,
-                                       const int offload_end)
+                                       const int /*offload_end*/)
 {
   free_buffers();
   _buf_size = static_cast<double>(nall) * 1.1 + 1;
@@ -200,7 +200,7 @@ void IntelBuffers<flt_t, acc_t>::free_nmax()
 /* ---------------------------------------------------------------------- */
 
 template <class flt_t, class acc_t>
-void IntelBuffers<flt_t, acc_t>::_grow_nmax(const int offload_end)
+void IntelBuffers<flt_t, acc_t>::_grow_nmax(const int /*offload_end*/)
 {
   #ifdef _LMP_INTEL_OFFLOAD
   free_nmax();
@@ -264,7 +264,7 @@ void IntelBuffers<flt_t, acc_t>::free_list_local()
 
 template <class flt_t, class acc_t>
 void IntelBuffers<flt_t, acc_t>::_grow_list_local(NeighList *list,
-                                                  const int offload_end)
+                                                  const int /*offload_end*/)
 {
   free_list_local();
   int size = list->get_maxlocal();
@@ -310,10 +310,10 @@ void IntelBuffers<flt_t, acc_t>::free_nbor_list()
 /* ---------------------------------------------------------------------- */
 
 template <class flt_t, class acc_t>
-void IntelBuffers<flt_t, acc_t>::_grow_nbor_list(NeighList *list,
+void IntelBuffers<flt_t, acc_t>::_grow_nbor_list(NeighList */*list*/,
                                                  const int nlocal,
                                                  const int nthreads,
-                                                 const int offload_end,
+                                                 const int /*offload_end*/,
                                                  const int pack_width)
 {
   free_nbor_list();
@@ -382,7 +382,7 @@ void IntelBuffers<flt_t, acc_t>::free_ccache()
 /* ---------------------------------------------------------------------- */
 
 template <class flt_t, class acc_t>
-void IntelBuffers<flt_t, acc_t>::grow_ccache(const int off_flag,
+void IntelBuffers<flt_t, acc_t>::grow_ccache(const int /*off_flag*/,
         const int nthreads,
         const int width)
 {
@@ -481,7 +481,7 @@ void IntelBuffers<flt_t, acc_t>::free_ncache()
 /* ---------------------------------------------------------------------- */
 
 template <class flt_t, class acc_t>
-void IntelBuffers<flt_t, acc_t>::grow_ncache(const int off_flag,
+void IntelBuffers<flt_t, acc_t>::grow_ncache(const int /*off_flag*/,
                                              const int nthreads)
 {
   const int nsize = get_max_nbors() * 3;
diff --git a/src/USER-INTEL/intel_buffers.h b/src/USER-INTEL/intel_buffers.h
index 8040715b2e..397fa77a7e 100644
--- a/src/USER-INTEL/intel_buffers.h
+++ b/src/USER-INTEL/intel_buffers.h
@@ -135,24 +135,24 @@ class IntelBuffers {
 
   void set_ntypes(const int ntypes, const int use_ghost_cut = 0);
 
-  inline int * firstneigh(const NeighList *list) { return _list_alloc; }
-  inline int * cnumneigh(const NeighList *list) { return _cnumneigh; }
+  inline int * firstneigh(const NeighList */*list*/) { return _list_alloc; }
+  inline int * cnumneigh(const NeighList */*list*/) { return _cnumneigh; }
   inline int * get_atombin() { return _atombin; }
   inline int * get_binpacked() { return _binpacked; }
 
-  inline atom_t * get_x(const int offload = 1) {
+  inline atom_t * get_x(const int /*offload*/ = 1) {
     #ifdef _LMP_INTEL_OFFLOAD
     if (_separate_buffers && offload == 0) return _host_x;
     #endif
     return _x;
   }
-  inline flt_t * get_q(const int offload = 1) {
+  inline flt_t * get_q(const int /*offload*/ = 1) {
     #ifdef _LMP_INTEL_OFFLOAD
     if (_separate_buffers && offload == 0) return _host_q;
     #endif
     return _q;
   }
-  inline quat_t * get_quat(const int offload = 1) {
+  inline quat_t * get_quat(const int /*offload*/ = 1) {
     #ifdef _LMP_INTEL_OFFLOAD
     if (_separate_buffers && offload == 0) return _host_quat;
     #endif
diff --git a/src/USER-INTEL/intel_intrinsics_airebo.h b/src/USER-INTEL/intel_intrinsics_airebo.h
index 4a86d8db29..2c86ad3520 100644
--- a/src/USER-INTEL/intel_intrinsics_airebo.h
+++ b/src/USER-INTEL/intel_intrinsics_airebo.h
@@ -2057,8 +2057,8 @@ public:
   }
 
   VEC_INLINE static ivec set(
-      int i15, int i14, int i13, int i12, int i11, int i10, int i9, int i8,
-      int i7, int i6, int i5, int i4, int i3, int i2, int i1, int i0
+      int /*i15*/, int /*i14*/, int /*i13*/, int /*i12*/, int /*i11*/, int /*i10*/, int /*i9*/, int /*i8*/,
+      int /*i7*/, int /*i6*/, int /*i5*/, int /*i4*/, int /*i3*/, int /*i2*/, int /*i1*/, int i0
   ) {
     return i0;
   }
diff --git a/src/USER-INTEL/npair_full_bin_ghost_intel.cpp b/src/USER-INTEL/npair_full_bin_ghost_intel.cpp
index ae961e84b5..8be2165deb 100644
--- a/src/USER-INTEL/npair_full_bin_ghost_intel.cpp
+++ b/src/USER-INTEL/npair_full_bin_ghost_intel.cpp
@@ -106,7 +106,7 @@ void NPairFullBinGhostIntel::fbi(NeighList * list,
 /* ---------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int need_ic>
-void NPairFullBinGhostIntel::fbi(const int offload, NeighList * list,
+void NPairFullBinGhostIntel::fbi(const int /*offload*/, NeighList * list,
                                  IntelBuffers<flt_t,acc_t> * buffers,
                                  const int pstart, const int pend) {
   if (pend-pstart == 0) return;
diff --git a/src/USER-INTEL/npair_intel.cpp b/src/USER-INTEL/npair_intel.cpp
index 355c8db199..d59cd2304a 100644
--- a/src/USER-INTEL/npair_intel.cpp
+++ b/src/USER-INTEL/npair_intel.cpp
@@ -54,10 +54,10 @@ NPairIntel::~NPairIntel() {
 
 template <class flt_t, class acc_t, int offload_noghost, int need_ic,
           int FULL, int TRI, int THREE>
-void NPairIntel::bin_newton(const int offload, NeighList *list,
+void NPairIntel::bin_newton(const int /*offload*/, NeighList *list,
                             IntelBuffers<flt_t,acc_t> *buffers,
                             const int astart, const int aend,
-                            const int offload_end) {
+                            const int /*offload_end*/) {
 
   if (aend-astart == 0) return;
 
diff --git a/src/USER-INTEL/pair_airebo_intel.cpp b/src/USER-INTEL/pair_airebo_intel.cpp
index 07f33f7ebe..601144a3c0 100644
--- a/src/USER-INTEL/pair_airebo_intel.cpp
+++ b/src/USER-INTEL/pair_airebo_intel.cpp
@@ -2200,7 +2200,7 @@ typedef typename intr_types<flt_t, acc_t>::bvec bvec;
 VEC_INLINE inline
 static void aut_loadatoms_vec(
     AtomAIREBOT<flt_t> * atoms, ivec j_vec,
-    fvec *x, fvec * y, fvec * z, bvec * type_mask, int * map, ivec map_i,
+    fvec *x, fvec * y, fvec * z, bvec * type_mask, int * /*map*/, ivec map_i,
     ivec c_1
 ) {
   const ivec c_4 = ivec::set1(4);
@@ -2413,7 +2413,7 @@ static fvec aut_eval_poly_lin_pd_2(int n, flt_t * vals, ivec idx, fvec x,
 }
 
 static fvec aut_mask_gSpline_pd_2(KernelArgsAIREBOT<flt_t,acc_t> * ka,
-                                  bvec active_mask, int itype, fvec cosjik,
+                                  bvec /*active_mask*/, int itype, fvec cosjik,
                                   fvec Nij, fvec *dgdc, fvec *dgdN) {
   int i;
   flt_t * gDom = NULL;
@@ -2835,7 +2835,7 @@ static void aut_frebo_data_writeback(
 static void aut_frebo_N_spline_force(
      KernelArgsAIREBOT<flt_t,acc_t> * _noalias ka,
      struct aut_frebo_data * _noalias data, int itype, int jtype, ivec vi,
-     ivec vj, fvec VA, fvec dN, fvec dNconj, fvec Nconj) {
+     ivec /*vj*/, fvec VA, fvec dN, fvec dNconj, fvec Nconj) {
   ivec c_i1 = ivec::set1(1);
   fvec c_2 = fvec::set1(2);
   fvec c_TOL = fvec::set1(TOL);
@@ -2999,8 +2999,8 @@ static fvec aut_frebo_sum_omega(
     KernelArgsAIREBOT<flt_t,acc_t> * _noalias ka,
     struct aut_frebo_data * _noalias i_data,
     struct aut_frebo_data * _noalias j_data,
-    int itype, int jtype,
-    ivec vi, ivec vj,
+    int /*itype*/, int /*jtype*/,
+    ivec /*vi*/, ivec /*vj*/,
     fvec r23x, fvec r23y, fvec r23z, fvec r23mag,
     fvec VA, fvec fij[3]
 ) {
@@ -3284,7 +3284,7 @@ static void aut_torsion_vec(
     KernelArgsAIREBOT<flt_t,acc_t> * ka,
     struct aut_frebo_data * i_data,
     struct aut_frebo_data * j_data,
-    ivec i, ivec j, fvec wij, fvec dwij
+    ivec /*i*/, ivec /*j*/, fvec wij, fvec dwij
 ) {
   AtomAIREBOT<flt_t> * x = ka->x;
   int * map = ka->map;
@@ -4134,7 +4134,7 @@ exceed_limits:
 /*
  * Attempt to look up an element in the hash-map.
  */
-static fvec aut_airebo_lj_tap_test_path(KernelArgsAIREBOT<flt_t,acc_t> * ka,
+static fvec aut_airebo_lj_tap_test_path(KernelArgsAIREBOT<flt_t,acc_t> * /*ka*/,
   struct aut_airebo_lj_test_path_result_data * test_path_result,
   bvec need_search, ivec i_bc, ivec j,
   LennardJonesPathAIREBOT<flt_t> path[fvec::VL]
diff --git a/src/USER-INTEL/pair_eam_intel.cpp b/src/USER-INTEL/pair_eam_intel.cpp
index 201277e68d..11ae442c0e 100644
--- a/src/USER-INTEL/pair_eam_intel.cpp
+++ b/src/USER-INTEL/pair_eam_intel.cpp
@@ -784,7 +784,7 @@ void PairEAMIntel::ForceConst<flt_t>::set_ntypes(const int ntypes,
 /* ---------------------------------------------------------------------- */
 
 int PairEAMIntel::pack_forward_comm(int n, int *list, double *buf,
-                                    int pbc_flag, int *pbc)
+                                    int /*pbc_flag*/, int */*pbc*/)
 {
   if (fix->precision() == FixIntel::PREC_MODE_DOUBLE)
     return pack_forward_comm(n, list, buf, fp);
diff --git a/src/USER-INTEL/pair_rebo_intel.cpp b/src/USER-INTEL/pair_rebo_intel.cpp
index bc7197000b..3decc0154b 100644
--- a/src/USER-INTEL/pair_rebo_intel.cpp
+++ b/src/USER-INTEL/pair_rebo_intel.cpp
@@ -28,7 +28,7 @@ PairREBOIntel::PairREBOIntel(LAMMPS *lmp) : PairAIREBOIntel(lmp) {}
    global settings
 ------------------------------------------------------------------------- */
 
-void PairREBOIntel::settings(int narg, char **arg)
+void PairREBOIntel::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 
diff --git a/src/USER-INTEL/pair_sw_intel.cpp b/src/USER-INTEL/pair_sw_intel.cpp
index d1d52270be..aff8ba88a7 100644
--- a/src/USER-INTEL/pair_sw_intel.cpp
+++ b/src/USER-INTEL/pair_sw_intel.cpp
@@ -173,7 +173,7 @@ template <int SPQ,int ONETYPE,int EFLAG,class flt_t,class acc_t>
 void PairSWIntel::eval(const int offload, const int vflag,
                        IntelBuffers<flt_t,acc_t> *buffers,
                        const ForceConst<flt_t> &fc, const int astart,
-                       const int aend, const int pad_width)
+                       const int aend, const int /*pad_width*/)
 {
   const int inum = aend - astart;
   if (inum == 0) return;
diff --git a/src/USER-INTEL/pppm_disp_intel.cpp b/src/USER-INTEL/pppm_disp_intel.cpp
index 0a41e5d8a5..c7edc15a49 100644
--- a/src/USER-INTEL/pppm_disp_intel.cpp
+++ b/src/USER-INTEL/pppm_disp_intel.cpp
@@ -723,7 +723,7 @@ void PPPMDispIntel::particle_map(double delx, double dely, double delz,
                                  double sft, int** p2g, int nup, int nlow,
                                  int nxlo, int nylo, int nzlo,
                                  int nxhi, int nyhi, int nzhi,
-                                 IntelBuffers<flt_t,acc_t> *buffers)
+                                 IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   int nlocal = atom->nlocal;
   int nthr = comm->nthreads;
@@ -790,7 +790,7 @@ void PPPMDispIntel::particle_map(double delx, double dely, double delz,
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::make_rho_c(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::make_rho_c(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   // clear 3d density array
 
@@ -940,7 +940,7 @@ void PPPMDispIntel::make_rho_c(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::make_rho_g(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::make_rho_g(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   // clear 3d density array
 
@@ -1091,7 +1091,7 @@ void PPPMDispIntel::make_rho_g(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::make_rho_a(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::make_rho_a(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   // clear 3d density array
 
@@ -1225,7 +1225,7 @@ void PPPMDispIntel::make_rho_a(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::make_rho_none(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::make_rho_none(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   FFT_SCALAR * _noalias global_density = &(density_brick_none[0][nzlo_out_6][nylo_out_6][nxlo_out_6]);
@@ -1373,7 +1373,7 @@ void PPPMDispIntel::make_rho_none(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_c_ik(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_c_ik(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   // loop over my charges, interpolate electric field from nearby grid points
@@ -1520,7 +1520,7 @@ void PPPMDispIntel::fieldforce_c_ik(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_c_ad(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_c_ad(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   // loop over my charges, interpolate electric field from nearby grid points
@@ -1725,7 +1725,7 @@ void PPPMDispIntel::fieldforce_c_ad(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_g_ik(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_g_ik(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   // loop over my charges, interpolate electric field from nearby grid points
@@ -1869,7 +1869,7 @@ void PPPMDispIntel::fieldforce_g_ik(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_g_ad(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_g_ad(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   // loop over my charges, interpolate electric field from nearby grid points
@@ -2069,7 +2069,7 @@ void PPPMDispIntel::fieldforce_g_ad(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_a_ik(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_a_ik(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   // loop over my charges, interpolate electric field from nearby grid points
@@ -2282,7 +2282,7 @@ void PPPMDispIntel::fieldforce_a_ik(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_a_ad(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_a_ad(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   // loop over my charges, interpolate electric field from nearby grid points
@@ -2594,7 +2594,7 @@ void PPPMDispIntel::fieldforce_a_ad(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_none_ik(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_none_ik(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
 
   // loop over my charges, interpolate electric field from nearby grid points
@@ -2755,7 +2755,7 @@ void PPPMDispIntel::fieldforce_none_ik(IntelBuffers<flt_t,acc_t> *buffers)
 ------------------------------------------------------------------------- */
 
 template<class flt_t, class acc_t, int use_table>
-void PPPMDispIntel::fieldforce_none_ad(IntelBuffers<flt_t,acc_t> *buffers)
+void PPPMDispIntel::fieldforce_none_ad(IntelBuffers<flt_t,acc_t> */*buffers*/)
 {
   // loop over my charges, interpolate electric field from nearby grid points
   // (nx,ny,nz) = global coords of grid pt to "lower left" of charge
diff --git a/src/USER-INTEL/pppm_intel.cpp b/src/USER-INTEL/pppm_intel.cpp
index 46a55e558a..e5540e6377 100644
--- a/src/USER-INTEL/pppm_intel.cpp
+++ b/src/USER-INTEL/pppm_intel.cpp
@@ -255,7 +255,7 @@ void PPPMIntel::compute_first(int eflag, int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void PPPMIntel::compute_second(int eflag, int vflag)
+void PPPMIntel::compute_second(int /*eflag*/, int /*vflag*/)
 {
   int i,j;
 
diff --git a/src/USER-LB/fix_lb_fluid.cpp b/src/USER-LB/fix_lb_fluid.cpp
index 7a0bd0572e..fecd6f2b25 100644
--- a/src/USER-LB/fix_lb_fluid.cpp
+++ b/src/USER-LB/fix_lb_fluid.cpp
@@ -646,7 +646,7 @@ void FixLbFluid::init(void)
 
 }
 
-void FixLbFluid::setup(int vflag)
+void FixLbFluid::setup(int /*vflag*/)
 {
   //--------------------------------------------------------------------------
   // Need to calculate the force on the fluid for a restart run.
@@ -655,7 +655,7 @@ void FixLbFluid::setup(int vflag)
     calc_fluidforce();
 }
 
-void FixLbFluid::initial_integrate(int vflag)
+void FixLbFluid::initial_integrate(int /*vflag*/)
 {
   //--------------------------------------------------------------------------
   // Print a header labelling any output printed to the screen.
@@ -711,7 +711,7 @@ void FixLbFluid::initial_integrate(int vflag)
     streamout();
 
 }
-void FixLbFluid::post_force(int vflag)
+void FixLbFluid::post_force(int /*vflag*/)
 {
   if(fixviscouslb==1)
     calc_fluidforce();
@@ -741,7 +741,7 @@ void FixLbFluid::grow_arrays(int nmax)
 //==========================================================================
 //   copy values within local atom-based array
 //==========================================================================
-void FixLbFluid::copy_arrays(int i, int j, int delflag)
+void FixLbFluid::copy_arrays(int i, int j, int /*delflag*/)
 {
   hydroF[j][0] = hydroF[i][0];
   hydroF[j][1] = hydroF[i][1];
diff --git a/src/USER-LB/fix_lb_pc.cpp b/src/USER-LB/fix_lb_pc.cpp
index 9fd0dab51d..c5c12d6c11 100644
--- a/src/USER-LB/fix_lb_pc.cpp
+++ b/src/USER-LB/fix_lb_pc.cpp
@@ -118,7 +118,7 @@ void FixLbPC::init()
 }
 
 /* ---------------------------------------------------------------------- */
-void FixLbPC::initial_integrate(int vflag) {
+void FixLbPC::initial_integrate(int /*vflag*/) {
 
   double dtfm;
 
@@ -285,7 +285,7 @@ void FixLbPC::grow_arrays(int nmax)
    copy values within local atom-based array
 ------------------------------------------------------------------------- */
 
-void FixLbPC::copy_arrays(int i, int j, int delflag)
+void FixLbPC::copy_arrays(int i, int j, int /*delflag*/)
 {
 
   force_old[j][0] = force_old[i][0];
diff --git a/src/USER-LB/fix_lb_rigid_pc_sphere.cpp b/src/USER-LB/fix_lb_rigid_pc_sphere.cpp
index dddd060fa4..2601539727 100644
--- a/src/USER-LB/fix_lb_rigid_pc_sphere.cpp
+++ b/src/USER-LB/fix_lb_rigid_pc_sphere.cpp
@@ -1454,7 +1454,7 @@ void FixLbRigidPCSphere::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixLbRigidPCSphere::copy_arrays(int i, int j, int delflag)
+void FixLbRigidPCSphere::copy_arrays(int i, int j, int /*delflag*/)
 {
   body[j] = body[i];
   up[j][0] = up[i][0];
diff --git a/src/USER-LB/fix_lb_viscous.cpp b/src/USER-LB/fix_lb_viscous.cpp
index 8ee4d8419e..afe23477be 100644
--- a/src/USER-LB/fix_lb_viscous.cpp
+++ b/src/USER-LB/fix_lb_viscous.cpp
@@ -109,7 +109,7 @@ void FixLbViscous::min_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixLbViscous::post_force(int vflag)
+void FixLbViscous::post_force(int /*vflag*/)
 {
   // apply drag force to atoms in group
   // direction is opposed to velocity vector
@@ -132,7 +132,7 @@ void FixLbViscous::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixLbViscous::post_force_respa(int vflag, int ilevel, int iloop)
+void FixLbViscous::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
diff --git a/src/USER-MANIFOLD/fix_manifoldforce.cpp b/src/USER-MANIFOLD/fix_manifoldforce.cpp
index 04172d5c92..4e717ce556 100644
--- a/src/USER-MANIFOLD/fix_manifoldforce.cpp
+++ b/src/USER-MANIFOLD/fix_manifoldforce.cpp
@@ -149,7 +149,7 @@ void FixManifoldForce::min_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixManifoldForce::post_force(int vflag)
+void FixManifoldForce::post_force(int /*vflag*/)
 {
   double **x = atom->x;
   double **f = atom->f;
@@ -177,7 +177,7 @@ void FixManifoldForce::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixManifoldForce::post_force_respa(int vflag, int ilevel, int iloop)
+void FixManifoldForce::post_force_respa(int vflag, int /*ilevel*/, int /*iloop*/)
 {
   post_force(vflag);
 }
diff --git a/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp b/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp
index 4dcc3f9704..3c6c70f6df 100644
--- a/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp
+++ b/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp
@@ -307,7 +307,7 @@ void FixNVEManifoldRattle::update_var_params()
 
 /* -----------------------------------------------------------------------------
    ---------------------------------------------------------------------------*/
-int FixNVEManifoldRattle::dof(int igroup)
+int FixNVEManifoldRattle::dof(int /*igroup*/)
 {
   int *mask = atom->mask;
   int nlocal = atom->nlocal;
@@ -348,7 +348,7 @@ double FixNVEManifoldRattle::memory_usage()
 
 /* -----------------------------------------------------------------------------
    ---------------------------------------------------------------------------*/
-void FixNVEManifoldRattle::initial_integrate(int vflag)
+void FixNVEManifoldRattle::initial_integrate(int /*vflag*/)
 {
   update_var_params();
   nve_x_rattle(igroup, groupbit);
diff --git a/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp b/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp
index 973a5bcf43..2a204d2048 100644
--- a/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp
+++ b/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp
@@ -229,7 +229,7 @@ void FixNVTManifoldRattle::init()
 
 
 
-void FixNVTManifoldRattle::setup(int vflag)
+void FixNVTManifoldRattle::setup(int /*vflag*/)
 {
   compute_temp_target();
 
@@ -371,7 +371,7 @@ void FixNVTManifoldRattle::nh_v_temp()
 
 
 // Most of this logic is based on fix_nh:
-void FixNVTManifoldRattle::initial_integrate(int vflag)
+void FixNVTManifoldRattle::initial_integrate(int /*vflag*/)
 {
 
   update_var_params();
diff --git a/src/USER-MANIFOLD/manifold.h b/src/USER-MANIFOLD/manifold.h
index 6eb09010ef..b0727c346d 100644
--- a/src/USER-MANIFOLD/manifold.h
+++ b/src/USER-MANIFOLD/manifold.h
@@ -61,7 +61,7 @@ namespace user_manifold {
 
     virtual const char *id() = 0;
 
-    virtual void set_atom_id( tagint a_id ){}
+    virtual void set_atom_id( tagint /*a_id*/ ){}
     virtual int nparams() = 0;
     // double *get_params(){ return params; };
 
diff --git a/src/USER-MANIFOLD/manifold_cylinder.cpp b/src/USER-MANIFOLD/manifold_cylinder.cpp
index c13581c640..28062d7a27 100644
--- a/src/USER-MANIFOLD/manifold_cylinder.cpp
+++ b/src/USER-MANIFOLD/manifold_cylinder.cpp
@@ -5,8 +5,8 @@ using namespace LAMMPS_NS;
 using namespace user_manifold;
 
 
-manifold_cylinder::manifold_cylinder( LAMMPS *lmp, int argc,
-                                      char **argv ) : manifold(lmp)
+manifold_cylinder::manifold_cylinder( LAMMPS *lmp, int /*argc*/,
+                                      char **/*argv*/ ) : manifold(lmp)
 {}
 
 
diff --git a/src/USER-MANIFOLD/manifold_cylinder_dent.cpp b/src/USER-MANIFOLD/manifold_cylinder_dent.cpp
index 21d4087d7c..4df4c833d3 100644
--- a/src/USER-MANIFOLD/manifold_cylinder_dent.cpp
+++ b/src/USER-MANIFOLD/manifold_cylinder_dent.cpp
@@ -8,8 +8,8 @@ using namespace LAMMPS_NS;
 
 using namespace user_manifold;
 
-manifold_cylinder_dent::manifold_cylinder_dent( LAMMPS *lmp, int argc,
-                                                char **argv ) : manifold(lmp)
+manifold_cylinder_dent::manifold_cylinder_dent( LAMMPS *lmp, int /*argc*/,
+                                                char **/*argv*/ ) : manifold(lmp)
 {}
 
 
diff --git a/src/USER-MANIFOLD/manifold_dumbbell.cpp b/src/USER-MANIFOLD/manifold_dumbbell.cpp
index fa7edc6e4a..c40a5fff9f 100644
--- a/src/USER-MANIFOLD/manifold_dumbbell.cpp
+++ b/src/USER-MANIFOLD/manifold_dumbbell.cpp
@@ -6,7 +6,7 @@ using namespace LAMMPS_NS;
 
 using namespace user_manifold;
 
-manifold_dumbbell::manifold_dumbbell( LAMMPS *lmp, int argc, char **argv ) : manifold(lmp)
+manifold_dumbbell::manifold_dumbbell( LAMMPS *lmp, int /*argc*/, char **/*argv*/ ) : manifold(lmp)
 {}
 
 
diff --git a/src/USER-MANIFOLD/manifold_ellipsoid.cpp b/src/USER-MANIFOLD/manifold_ellipsoid.cpp
index f590123dc3..d5e7bb146e 100644
--- a/src/USER-MANIFOLD/manifold_ellipsoid.cpp
+++ b/src/USER-MANIFOLD/manifold_ellipsoid.cpp
@@ -4,7 +4,7 @@ using namespace LAMMPS_NS;
 
 using namespace user_manifold;
 
-manifold_ellipsoid::manifold_ellipsoid( LAMMPS *lmp, int narg, char **argv ) : manifold(lmp)
+manifold_ellipsoid::manifold_ellipsoid( LAMMPS *lmp, int /*narg*/, char **/*argv*/ ) : manifold(lmp)
 {}
 
 
diff --git a/src/USER-MANIFOLD/manifold_gaussian_bump.cpp b/src/USER-MANIFOLD/manifold_gaussian_bump.cpp
index cbb47ef92d..b95162740b 100644
--- a/src/USER-MANIFOLD/manifold_gaussian_bump.cpp
+++ b/src/USER-MANIFOLD/manifold_gaussian_bump.cpp
@@ -133,7 +133,7 @@ public:
 
 // Manifold itself:
 manifold_gaussian_bump::manifold_gaussian_bump(class LAMMPS* lmp,
-                                               int narg, char **arg)
+                                               int /*narg*/, char **/*arg*/)
         : manifold(lmp), lut_z(NULL), lut_zp(NULL) {}
 
 
diff --git a/src/USER-MANIFOLD/manifold_plane.cpp b/src/USER-MANIFOLD/manifold_plane.cpp
index d33617fbfb..45a1f4b46e 100644
--- a/src/USER-MANIFOLD/manifold_plane.cpp
+++ b/src/USER-MANIFOLD/manifold_plane.cpp
@@ -4,7 +4,7 @@ using namespace LAMMPS_NS;
 
 using namespace user_manifold;
 
-manifold_plane::manifold_plane( LAMMPS *lmp, int argc, char **argv ) :
+manifold_plane::manifold_plane( LAMMPS *lmp, int /*argc*/, char **/*argv*/ ) :
   manifold(lmp)
 {}
 
@@ -16,7 +16,7 @@ double manifold_plane::g( const double *x )
 }
 
 
-void manifold_plane::n( const double *x, double *n )
+void manifold_plane::n( const double */*x*/, double *n )
 {
   n[0] = params[0];
   n[1] = params[1];
diff --git a/src/USER-MANIFOLD/manifold_plane_wiggle.cpp b/src/USER-MANIFOLD/manifold_plane_wiggle.cpp
index ccf0a794da..983702b6f3 100644
--- a/src/USER-MANIFOLD/manifold_plane_wiggle.cpp
+++ b/src/USER-MANIFOLD/manifold_plane_wiggle.cpp
@@ -5,7 +5,7 @@
 using namespace LAMMPS_NS;
 using namespace user_manifold;
 
-manifold_plane_wiggle::manifold_plane_wiggle( LAMMPS *lmp, int argc, char **argv ) :
+manifold_plane_wiggle::manifold_plane_wiggle( LAMMPS *lmp, int /*argc*/, char **/*argv*/ ) :
   manifold(lmp)
 {}
 
diff --git a/src/USER-MANIFOLD/manifold_spine.cpp b/src/USER-MANIFOLD/manifold_spine.cpp
index 308190c528..0ca4c67002 100644
--- a/src/USER-MANIFOLD/manifold_spine.cpp
+++ b/src/USER-MANIFOLD/manifold_spine.cpp
@@ -8,7 +8,7 @@ using namespace user_manifold;
 
 
 
-manifold_spine::manifold_spine( LAMMPS *lmp, int argc, char **argv )
+manifold_spine::manifold_spine( LAMMPS *lmp, int /*argc*/, char **/*argv*/ )
   : manifold(lmp)
 {
   power = 4;
diff --git a/src/USER-MANIFOLD/manifold_thylakoid.cpp b/src/USER-MANIFOLD/manifold_thylakoid.cpp
index b7eb155ba2..16c4e696d5 100644
--- a/src/USER-MANIFOLD/manifold_thylakoid.cpp
+++ b/src/USER-MANIFOLD/manifold_thylakoid.cpp
@@ -12,7 +12,7 @@ using namespace LAMMPS_NS;
 using namespace user_manifold;
 
 
-manifold_thylakoid::manifold_thylakoid( LAMMPS *lmp, int narg, char ** arg)
+manifold_thylakoid::manifold_thylakoid( LAMMPS *lmp, int /*narg*/, char ** /*arg*/)
   : manifold(lmp)
 {
   // You can NOT depend on proper construction of the domains in
@@ -117,7 +117,7 @@ void   manifold_thylakoid::n( const double *x, double *n )
   }
 }
 
-thyla_part *manifold_thylakoid::get_thyla_part( const double *x, int *err_flag, std::size_t *idx )
+thyla_part *manifold_thylakoid::get_thyla_part( const double *x, int */*err_flag*/, std::size_t *idx )
 {
 
   for( std::size_t i = 0; i < parts.size(); ++i ){
diff --git a/src/USER-MANIFOLD/manifold_torus.cpp b/src/USER-MANIFOLD/manifold_torus.cpp
index 44a17725b5..0b4ca24370 100644
--- a/src/USER-MANIFOLD/manifold_torus.cpp
+++ b/src/USER-MANIFOLD/manifold_torus.cpp
@@ -6,7 +6,7 @@ using namespace LAMMPS_NS;
 using namespace user_manifold;
 
 
-manifold_torus::manifold_torus( LAMMPS *lmp, int argc, char **argv ) : manifold(lmp)
+manifold_torus::manifold_torus( LAMMPS *lmp, int /*argc*/, char **/*argv*/ ) : manifold(lmp)
 {}
 
 
diff --git a/src/USER-MEAMC/meam_dens_final.cpp b/src/USER-MEAMC/meam_dens_final.cpp
index de188e497d..2be215c282 100644
--- a/src/USER-MEAMC/meam_dens_final.cpp
+++ b/src/USER-MEAMC/meam_dens_final.cpp
@@ -5,7 +5,7 @@ using namespace LAMMPS_NS;
 
 void
 MEAM::meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_atom, double* eng_vdwl,
-                      double* eatom, int ntype, int* type, int* fmap, int& errorflag)
+                      double* eatom, int /*ntype*/, int* type, int* fmap, int& errorflag)
 {
   int i, elti;
   int m;
diff --git a/src/USER-MEAMC/meam_dens_init.cpp b/src/USER-MEAMC/meam_dens_init.cpp
index e1a7509ab3..4bbaa42596 100644
--- a/src/USER-MEAMC/meam_dens_init.cpp
+++ b/src/USER-MEAMC/meam_dens_init.cpp
@@ -93,7 +93,7 @@ MEAM::meam_dens_init(int i, int ntype, int* type, int* fmap, double** x,
 
 void
 MEAM::getscreen(int i, double* scrfcn, double* dscrfcn, double* fcpair, double** x, int numneigh,
-                int* firstneigh, int numneigh_full, int* firstneigh_full, int ntype, int* type, int* fmap)
+                int* firstneigh, int numneigh_full, int* firstneigh_full, int /*ntype*/, int* type, int* fmap)
 {
   int jn, j, kn, k;
   int elti, eltj, eltk;
@@ -256,7 +256,7 @@ MEAM::getscreen(int i, double* scrfcn, double* dscrfcn, double* fcpair, double**
 // ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
 
 void
-MEAM::calc_rho1(int i, int ntype, int* type, int* fmap, double** x, int numneigh, int* firstneigh,
+MEAM::calc_rho1(int i, int /*ntype*/, int* type, int* fmap, double** x, int numneigh, int* firstneigh,
                 double* scrfcn, double* fcpair)
 {
   int jn, j, m, n, p, elti, eltj;
diff --git a/src/USER-MEAMC/meam_force.cpp b/src/USER-MEAMC/meam_force.cpp
index 85314dd8a2..06fbb57adb 100644
--- a/src/USER-MEAMC/meam_force.cpp
+++ b/src/USER-MEAMC/meam_force.cpp
@@ -7,7 +7,7 @@ using namespace LAMMPS_NS;
 
 void
 MEAM::meam_force(int i, int eflag_either, int eflag_global, int eflag_atom, int vflag_atom, double* eng_vdwl,
-                 double* eatom, int ntype, int* type, int* fmap, double** x, int numneigh, int* firstneigh,
+                 double* eatom, int /*ntype*/, int* type, int* fmap, double** x, int numneigh, int* firstneigh,
                  int numneigh_full, int* firstneigh_full, int fnoffset, double** f, double** vatom)
 {
   int j, jn, k, kn, kk, m, n, p, q;
diff --git a/src/USER-MEAMC/meam_setup_global.cpp b/src/USER-MEAMC/meam_setup_global.cpp
index 7f8ad3d81f..503ee65496 100644
--- a/src/USER-MEAMC/meam_setup_global.cpp
+++ b/src/USER-MEAMC/meam_setup_global.cpp
@@ -3,7 +3,7 @@
 using namespace LAMMPS_NS;
 
 void
-MEAM::meam_setup_global(int nelt, lattice_t* lat, double* z, int* ielement, double* atwt, double* alpha,
+MEAM::meam_setup_global(int nelt, lattice_t* lat, double* z, int* ielement, double* /*atwt*/, double* alpha,
                         double* b0, double* b1, double* b2, double* b3, double* alat, double* esub,
                         double* asub, double* t0, double* t1, double* t2, double* t3, double* rozero,
                         int* ibar)
diff --git a/src/USER-MEAMC/pair_meamc.cpp b/src/USER-MEAMC/pair_meamc.cpp
index 027e4c27a7..da0e4c1d28 100644
--- a/src/USER-MEAMC/pair_meamc.cpp
+++ b/src/USER-MEAMC/pair_meamc.cpp
@@ -195,7 +195,7 @@ void PairMEAMC::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairMEAMC::settings(int narg, char **arg)
+void PairMEAMC::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -312,7 +312,7 @@ void PairMEAMC::init_list(int id, NeighList *ptr)
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
 
-double PairMEAMC::init_one(int i, int j)
+double PairMEAMC::init_one(int /*i*/, int /*j*/)
 {
   return cutmax;
 }
@@ -598,7 +598,7 @@ void PairMEAMC::read_files(char *globalfile, char *userfile)
 /* ---------------------------------------------------------------------- */
 
 int PairMEAMC::pack_forward_comm(int n, int *list, double *buf,
-                                int pbc_flag, int *pbc)
+                                int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,k,m;
 
diff --git a/src/USER-MESO/fix_edpd_source.cpp b/src/USER-MESO/fix_edpd_source.cpp
index 8b03e05181..24bef2b1f7 100644
--- a/src/USER-MESO/fix_edpd_source.cpp
+++ b/src/USER-MESO/fix_edpd_source.cpp
@@ -87,7 +87,7 @@ void FixEDPDSource::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixEDPDSource::post_force(int vflag)
+void FixEDPDSource::post_force(int /*vflag*/)
 {
   double **x = atom->x;
   double *edpd_flux = atom->edpd_flux;
diff --git a/src/USER-MESO/fix_mvv_dpd.cpp b/src/USER-MESO/fix_mvv_dpd.cpp
index c97a2d779c..f663165f78 100644
--- a/src/USER-MESO/fix_mvv_dpd.cpp
+++ b/src/USER-MESO/fix_mvv_dpd.cpp
@@ -72,7 +72,7 @@ void FixMvvDPD::init()
    allow for both per-type and per-atom mass
 ------------------------------------------------------------------------- */
 
-void FixMvvDPD::initial_integrate(int vflag)
+void FixMvvDPD::initial_integrate(int /*vflag*/)
 {
   double dtfm;
   double **x = atom->x;
diff --git a/src/USER-MESO/fix_mvv_edpd.cpp b/src/USER-MESO/fix_mvv_edpd.cpp
index 89a831e121..8719d0d262 100644
--- a/src/USER-MESO/fix_mvv_edpd.cpp
+++ b/src/USER-MESO/fix_mvv_edpd.cpp
@@ -78,7 +78,7 @@ void FixMvvEDPD::init()
    allow for both per-type and per-atom mass
 ------------------------------------------------------------------------- */
 
-void FixMvvEDPD::initial_integrate(int vflag)
+void FixMvvEDPD::initial_integrate(int /*vflag*/)
 {
   double dtfm,dtT;
   // update v and x and cc of atoms in group
diff --git a/src/USER-MESO/fix_mvv_tdpd.cpp b/src/USER-MESO/fix_mvv_tdpd.cpp
index e16171800b..24b1bbcf48 100644
--- a/src/USER-MESO/fix_mvv_tdpd.cpp
+++ b/src/USER-MESO/fix_mvv_tdpd.cpp
@@ -76,7 +76,7 @@ void FixMvvTDPD::init()
    allow for both per-type and per-atom mass
 ------------------------------------------------------------------------- */
 
-void FixMvvTDPD::initial_integrate(int vflag)
+void FixMvvTDPD::initial_integrate(int /*vflag*/)
 {
   double dtfm;
   // update v and x and cc of atoms in group
diff --git a/src/USER-MESO/fix_tdpd_source.cpp b/src/USER-MESO/fix_tdpd_source.cpp
index 64964a4c98..89e8005b43 100644
--- a/src/USER-MESO/fix_tdpd_source.cpp
+++ b/src/USER-MESO/fix_tdpd_source.cpp
@@ -88,7 +88,7 @@ void FixTDPDSource::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixTDPDSource::post_force(int vflag)
+void FixTDPDSource::post_force(int /*vflag*/)
 {
   double **x = atom->x;
   double **cc_flux = atom->cc_flux;
diff --git a/src/USER-MESO/pair_edpd.cpp b/src/USER-MESO/pair_edpd.cpp
index 351637a842..5ed63a2a8b 100644
--- a/src/USER-MESO/pair_edpd.cpp
+++ b/src/USER-MESO/pair_edpd.cpp
@@ -530,7 +530,7 @@ void PairEDPD::read_restart_settings(FILE *fp)
 /* ---------------------------------------------------------------------- */
 
 double PairEDPD::single(int i, int j, int itype, int jtype, double rsq,
-                       double factor_coul, double factor_dpd, double &fforce)
+                       double /*factor_coul*/, double factor_dpd, double &fforce)
 {
   double r,rinv,wc,phi;
   double *T = atom->edpd_temp;
diff --git a/src/USER-MESO/pair_mdpd_rhosum.cpp b/src/USER-MESO/pair_mdpd_rhosum.cpp
index 1264d03ed3..d705285584 100644
--- a/src/USER-MESO/pair_mdpd_rhosum.cpp
+++ b/src/USER-MESO/pair_mdpd_rhosum.cpp
@@ -186,7 +186,7 @@ void PairMDPDRhoSum::allocate() {
  global settings
  ------------------------------------------------------------------------- */
 
-void PairMDPDRhoSum::settings(int narg, char **arg) {
+void PairMDPDRhoSum::settings(int narg, char **/*arg*/) {
   if (narg != 0)
     error->all(FLERR,"Illegal number of setting arguments for pair_style mdpd/rhosum");
 }
@@ -236,8 +236,8 @@ double PairMDPDRhoSum::init_one(int i, int j) {
 
 /* ---------------------------------------------------------------------- */
 
-double PairMDPDRhoSum::single(int i, int j, int itype, int jtype, double rsq,
-    double factor_coul, double factor_lj, double &fforce) {
+double PairMDPDRhoSum::single(int /*i*/, int /*j*/, int /*itype*/, int /*jtype*/, double /*rsq*/,
+    double /*factor_coul*/, double /*factor_lj*/, double &fforce) {
   fforce = 0.0;
 
   return 0.0;
@@ -246,7 +246,7 @@ double PairMDPDRhoSum::single(int i, int j, int itype, int jtype, double rsq,
 /* ---------------------------------------------------------------------- */
 
 int PairMDPDRhoSum::pack_forward_comm(int n, int *list, double *buf,
-                                     int pbc_flag, int *pbc) {
+                                     int /*pbc_flag*/, int */*pbc*/) {
   int i, j, m;
   double *rho = atom->rho;
 
diff --git a/src/USER-MESO/pair_tdpd.cpp b/src/USER-MESO/pair_tdpd.cpp
index b8bbf6d622..821d8c0486 100644
--- a/src/USER-MESO/pair_tdpd.cpp
+++ b/src/USER-MESO/pair_tdpd.cpp
@@ -465,8 +465,8 @@ void PairTDPD::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairTDPD::single(int i, int j, int itype, int jtype, double rsq,
-                       double factor_coul, double factor_dpd, double &fforce)
+double PairTDPD::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                       double /*factor_coul*/, double factor_dpd, double &fforce)
 {
   double r,rinv,wc,phi;
 
diff --git a/src/USER-MGPT/pair_mgpt.cpp b/src/USER-MGPT/pair_mgpt.cpp
index bac405bcbb..347bc9cc69 100644
--- a/src/USER-MGPT/pair_mgpt.cpp
+++ b/src/USER-MGPT/pair_mgpt.cpp
@@ -79,7 +79,7 @@ static double gettime(int x = 0) {
     return 0.0;
 }
 #else
-static double gettime(int x = 0) { return 0.0; }
+static double gettime(int /*x*/ = 0) { return 0.0; }
 #endif
 
 
@@ -1805,7 +1805,7 @@ void PairMGPT::allocate()
 /* ----------------------------------------------------------------------
    global settings
 ------------------------------------------------------------------------- */
-void PairMGPT::settings(int narg, char **arg)
+void PairMGPT::settings(int narg, char **/*arg*/)
 {
   if(narg != 0) error->all(__FILE__,__LINE__,"Illegal pair_style command");
 }
@@ -2025,7 +2025,7 @@ void PairMGPT::init_list(int id, NeighList *ptr)
 /* ----------------------------------------------------------------------
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
-double PairMGPT::init_one(int i, int j)
+double PairMGPT::init_one(int /*i*/, int /*j*/)
 {
 	return cutoff;
 }
diff --git a/src/USER-MISC/angle_dipole.cpp b/src/USER-MISC/angle_dipole.cpp
index bcb631c61f..c4186da472 100644
--- a/src/USER-MISC/angle_dipole.cpp
+++ b/src/USER-MISC/angle_dipole.cpp
@@ -229,7 +229,7 @@ void AngleDipole::write_data(FILE *fp)
    used by ComputeAngleLocal
 ------------------------------------------------------------------------- */
 
-double AngleDipole::single(int type, int iRef, int iDip, int iDummy)
+double AngleDipole::single(int type, int iRef, int iDip, int /*iDummy*/)
 {
   double **x = atom->x; // position vector
   double **mu = atom->mu; // point-dipole components and moment magnitude
diff --git a/src/USER-MISC/bond_harmonic_shift.cpp b/src/USER-MISC/bond_harmonic_shift.cpp
index 7148c5438d..b34f71e888 100644
--- a/src/USER-MISC/bond_harmonic_shift.cpp
+++ b/src/USER-MISC/bond_harmonic_shift.cpp
@@ -203,7 +203,7 @@ void BondHarmonicShift::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondHarmonicShift::single(int type, double rsq, int i, int j,
+double BondHarmonicShift::single(int type, double rsq, int /*i*/, int /*j*/,
                                  double &fforce)
 {
   double r = sqrt(rsq);
diff --git a/src/USER-MISC/bond_harmonic_shift_cut.cpp b/src/USER-MISC/bond_harmonic_shift_cut.cpp
index 20c8a1a300..a58df70878 100644
--- a/src/USER-MISC/bond_harmonic_shift_cut.cpp
+++ b/src/USER-MISC/bond_harmonic_shift_cut.cpp
@@ -205,7 +205,7 @@ void BondHarmonicShiftCut::write_data(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double BondHarmonicShiftCut::single(int type, double rsq, int i, int j,
+double BondHarmonicShiftCut::single(int type, double rsq, int /*i*/, int /*j*/,
                                     double &fforce)
 {
   fforce = 0.0;
diff --git a/src/USER-MISC/compute_ackland_atom.cpp b/src/USER-MISC/compute_ackland_atom.cpp
index a17aefe71b..bcf41591eb 100644
--- a/src/USER-MISC/compute_ackland_atom.cpp
+++ b/src/USER-MISC/compute_ackland_atom.cpp
@@ -105,7 +105,7 @@ void ComputeAcklandAtom::init()
 
 /* ---------------------------------------------------------------------- */
 
-void ComputeAcklandAtom::init_list(int id, NeighList *ptr)
+void ComputeAcklandAtom::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/USER-MISC/compute_basal_atom.cpp b/src/USER-MISC/compute_basal_atom.cpp
index 4d8627a11f..3b9b38343d 100644
--- a/src/USER-MISC/compute_basal_atom.cpp
+++ b/src/USER-MISC/compute_basal_atom.cpp
@@ -85,7 +85,7 @@ void ComputeBasalAtom::init()
 
 /* ---------------------------------------------------------------------- */
 
-void ComputeBasalAtom::init_list(int id, NeighList *ptr)
+void ComputeBasalAtom::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/USER-MISC/compute_cnp_atom.cpp b/src/USER-MISC/compute_cnp_atom.cpp
index 51cf3ab07a..6fa16f1a9a 100644
--- a/src/USER-MISC/compute_cnp_atom.cpp
+++ b/src/USER-MISC/compute_cnp_atom.cpp
@@ -121,7 +121,7 @@ void ComputeCNPAtom::init()
 
 /* ---------------------------------------------------------------------- */
 
-void ComputeCNPAtom::init_list(int id, NeighList *ptr)
+void ComputeCNPAtom::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/USER-MISC/compute_entropy_atom.cpp b/src/USER-MISC/compute_entropy_atom.cpp
index 922f2aaf5e..4946bc437e 100644
--- a/src/USER-MISC/compute_entropy_atom.cpp
+++ b/src/USER-MISC/compute_entropy_atom.cpp
@@ -151,7 +151,7 @@ void ComputeEntropyAtom::init()
 
 /* ---------------------------------------------------------------------- */
 
-void ComputeEntropyAtom::init_list(int id, NeighList *ptr)
+void ComputeEntropyAtom::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
diff --git a/src/USER-MISC/fix_addtorque.cpp b/src/USER-MISC/fix_addtorque.cpp
index 654911769c..2cd1ac7527 100644
--- a/src/USER-MISC/fix_addtorque.cpp
+++ b/src/USER-MISC/fix_addtorque.cpp
@@ -164,7 +164,7 @@ void FixAddTorque::min_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixAddTorque::post_force(int vflag)
+void FixAddTorque::post_force(int /*vflag*/)
 {
   double **x = atom->x;
   double **f = atom->f;
@@ -252,7 +252,7 @@ void FixAddTorque::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixAddTorque::post_force_respa(int vflag, int ilevel, int iloop)
+void FixAddTorque::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
diff --git a/src/USER-MISC/fix_ave_correlate_long.cpp b/src/USER-MISC/fix_ave_correlate_long.cpp
index da6d041287..0ce6121bf9 100644
--- a/src/USER-MISC/fix_ave_correlate_long.cpp
+++ b/src/USER-MISC/fix_ave_correlate_long.cpp
@@ -412,7 +412,7 @@ void FixAveCorrelateLong::init()
    only does something if nvalid = current timestep
 ------------------------------------------------------------------------- */
 
-void FixAveCorrelateLong::setup(int vflag)
+void FixAveCorrelateLong::setup(int /*vflag*/)
 {
   end_of_step();
 }
diff --git a/src/USER-MISC/fix_bond_react.cpp b/src/USER-MISC/fix_bond_react.cpp
index 5ce1f11475..cd7918f4dd 100644
--- a/src/USER-MISC/fix_bond_react.cpp
+++ b/src/USER-MISC/fix_bond_react.cpp
@@ -588,7 +588,7 @@ void FixBondReact::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixBondReact::init_list(int id, NeighList *ptr)
+void FixBondReact::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
@@ -2621,7 +2621,7 @@ double FixBondReact::compute_vector(int n)
 
 /* ---------------------------------------------------------------------- */
 
-void FixBondReact::post_integrate_respa(int ilevel, int iloop)
+void FixBondReact::post_integrate_respa(int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_integrate();
 }
@@ -2629,7 +2629,7 @@ void FixBondReact::post_integrate_respa(int ilevel, int iloop)
 /* ---------------------------------------------------------------------- */
 
 int FixBondReact::pack_forward_comm(int n, int *list, double *buf,
-                                    int pbc_flag, int *pbc)
+                                    int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,k,m,ns;
 
diff --git a/src/USER-MISC/fix_filter_corotate.cpp b/src/USER-MISC/fix_filter_corotate.cpp
index 91c7033513..4a6b3226d4 100644
--- a/src/USER-MISC/fix_filter_corotate.cpp
+++ b/src/USER-MISC/fix_filter_corotate.cpp
@@ -705,7 +705,7 @@ double FixFilterCorotate::compute_array(int,int)
   return 1;
 }
 
-void FixFilterCorotate::pre_force_respa(int vflag, int ilevel, int iloop)
+void FixFilterCorotate::pre_force_respa(int /*vflag*/, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1)
   {
@@ -717,7 +717,7 @@ void FixFilterCorotate::pre_force_respa(int vflag, int ilevel, int iloop)
   }
 }
 
-void FixFilterCorotate::post_force_respa(int vflag, int ilevel, int iloop)
+void FixFilterCorotate::post_force_respa(int /*vflag*/, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1)
   {
@@ -1699,7 +1699,7 @@ void FixFilterCorotate::general_cluster(int index, int index_in_list)
 }
 
 int FixFilterCorotate::pack_forward_comm(int n, int *list, double *buf,
-                                         int pbc_flag, int *pbc)
+                                         int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
   double**f = atom->f;
@@ -1839,7 +1839,7 @@ double FixFilterCorotate::memory_usage()
  *  copy values within local atom-based arrays
  * ------------------------------------------------------------------------- */
 
-void FixFilterCorotate::copy_arrays(int i, int j, int delflag)
+void FixFilterCorotate::copy_arrays(int i, int j, int /*delflag*/)
 {
   int flag = shake_flag[j] = shake_flag[i];
   if (flag == 1) {
diff --git a/src/USER-MISC/fix_flow_gauss.cpp b/src/USER-MISC/fix_flow_gauss.cpp
index 6a1e508030..b6366ec509 100644
--- a/src/USER-MISC/fix_flow_gauss.cpp
+++ b/src/USER-MISC/fix_flow_gauss.cpp
@@ -155,7 +155,7 @@ void FixFlowGauss::setup(int vflag)
 /* ----------------------------------------------------------------------
    this is where Gaussian dynamics constraint is applied
    ------------------------------------------------------------------------- */
-void FixFlowGauss::post_force(int vflag)
+void FixFlowGauss::post_force(int /*vflag*/)
 {
   double **f   = atom->f;
   double **v   = atom->v;
@@ -222,7 +222,7 @@ void FixFlowGauss::post_force(int vflag)
 
 }
 
-void FixFlowGauss::post_force_respa(int vflag, int ilevel, int iloop)
+void FixFlowGauss::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
diff --git a/src/USER-MISC/fix_gle.cpp b/src/USER-MISC/fix_gle.cpp
index 584b33bfe7..0b08fab4ca 100644
--- a/src/USER-MISC/fix_gle.cpp
+++ b/src/USER-MISC/fix_gle.cpp
@@ -582,7 +582,7 @@ void FixGLE::gle_integrate()
   energy += deltae*0.5*force->mvv2e;
 }
 
-void FixGLE::initial_integrate(int vflag)
+void FixGLE::initial_integrate(int /*vflag*/)
 {
   double dtfm;
 
@@ -685,7 +685,7 @@ void FixGLE::final_integrate()
 }
 /* ---------------------------------------------------------------------- */
 
-void FixGLE::initial_integrate_respa(int vflag, int ilevel, int iloop)
+void FixGLE::initial_integrate_respa(int vflag, int ilevel, int /*iloop*/)
 {
   dtv = step_respa[ilevel];
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
@@ -699,7 +699,7 @@ void FixGLE::initial_integrate_respa(int vflag, int ilevel, int iloop)
   else { final_integrate();}
 }
 
-void FixGLE::final_integrate_respa(int ilevel, int iloop)
+void FixGLE::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   dtv = step_respa[ilevel];
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
@@ -793,7 +793,7 @@ void FixGLE::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixGLE::copy_arrays(int i, int j, int delflag)
+void FixGLE::copy_arrays(int i, int j, int /*delflag*/)
 {
   for (int k = 0; k < 3*ns; k++) gle_s[j][k] = gle_s[i][k];
 }
@@ -868,7 +868,7 @@ void FixGLE::unpack_restart(int nlocal, int nth)
    fixes on a given processor.
 ------------------------------------------------------------------------- */
 
-int FixGLE::size_restart(int nlocal)
+int FixGLE::size_restart(int /*nlocal*/)
 {
   return 3*ns+1;
 }
diff --git a/src/USER-MISC/fix_grem.cpp b/src/USER-MISC/fix_grem.cpp
index a5f8c34448..635acf705c 100644
--- a/src/USER-MISC/fix_grem.cpp
+++ b/src/USER-MISC/fix_grem.cpp
@@ -256,7 +256,7 @@ void FixGrem::min_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixGrem::post_force(int vflag)
+void FixGrem::post_force(int /*vflag*/)
 {
   double **f = atom->f;
   int *mask = atom->mask;
diff --git a/src/USER-MISC/fix_imd.cpp b/src/USER-MISC/fix_imd.cpp
index abf9e7cb0b..1c3eafdc46 100644
--- a/src/USER-MISC/fix_imd.cpp
+++ b/src/USER-MISC/fix_imd.cpp
@@ -811,7 +811,7 @@ void FixIMD::ioworker()
 /* ---------------------------------------------------------------------- */
 /* Main IMD protocol handler:
  * Send coodinates, energies, and add IMD forces to atoms. */
-void FixIMD::post_force(int vflag)
+void FixIMD::post_force(int /*vflag*/)
 {
   /* check for reconnect */
   if (imd_inactive) {
@@ -1153,7 +1153,7 @@ void FixIMD::post_force(int vflag)
 }
 
 /* ---------------------------------------------------------------------- */
-void FixIMD::post_force_respa(int vflag, int ilevel, int iloop)
+void FixIMD::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   /* only process IMD on the outmost RESPA level. */
   if (ilevel == nlevels_respa-1) post_force(vflag);
diff --git a/src/USER-MISC/fix_ipi.cpp b/src/USER-MISC/fix_ipi.cpp
index c4750ce49e..32892d87a8 100644
--- a/src/USER-MISC/fix_ipi.cpp
+++ b/src/USER-MISC/fix_ipi.cpp
@@ -269,7 +269,7 @@ void FixIPI::init()
   neighbor->every = 1;
 }
 
-void FixIPI::initial_integrate(int vflag)
+void FixIPI::initial_integrate(int /*vflag*/)
 {
   /* This is called at the beginning of the integration loop,
    * and will be used to read positions from the socket. Then,
diff --git a/src/USER-MISC/fix_nvk.cpp b/src/USER-MISC/fix_nvk.cpp
index dbf7b56fe2..2ac2a7c9fc 100644
--- a/src/USER-MISC/fix_nvk.cpp
+++ b/src/USER-MISC/fix_nvk.cpp
@@ -94,7 +94,7 @@ void FixNVK::init()
    allow for both per-type and per-atom mass
 ------------------------------------------------------------------------- */
 
-void FixNVK::initial_integrate(int vflag)
+void FixNVK::initial_integrate(int /*vflag*/)
 {
   double sm;
   double a,b,sqtb,s,sdot;
@@ -190,7 +190,7 @@ void FixNVK::final_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVK::initial_integrate_respa(int vflag, int ilevel, int iloop)
+void FixNVK::initial_integrate_respa(int vflag, int ilevel, int /*iloop*/)
 {
   dtv = step_respa[ilevel];
   dtf = 0.5 * step_respa[ilevel];
@@ -204,7 +204,7 @@ void FixNVK::initial_integrate_respa(int vflag, int ilevel, int iloop)
 
 /* ---------------------------------------------------------------------- */
 
-void FixNVK::final_integrate_respa(int ilevel, int iloop)
+void FixNVK::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   dtf = 0.5 * step_respa[ilevel];
   final_integrate();
diff --git a/src/USER-MISC/fix_pimd.cpp b/src/USER-MISC/fix_pimd.cpp
index e65ae6ae28..506590f02c 100644
--- a/src/USER-MISC/fix_pimd.cpp
+++ b/src/USER-MISC/fix_pimd.cpp
@@ -214,7 +214,7 @@ void FixPIMD::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixPIMD::initial_integrate(int vflag)
+void FixPIMD::initial_integrate(int /*vflag*/)
 {
   nhc_update_v();
   nhc_update_x();
@@ -229,7 +229,7 @@ void FixPIMD::final_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixPIMD::post_force(int flag)
+void FixPIMD::post_force(int /*flag*/)
 {
   for(int i=0; i<atom->nlocal; i++) for(int j=0; j<3; j++) atom->f[i][j] /= np;
 
@@ -686,7 +686,7 @@ void FixPIMD::comm_exec(double **ptr)
 /* ---------------------------------------------------------------------- */
 
 int FixPIMD::pack_forward_comm(int n, int *list, double *buf,
-                             int pbc_flag, int *pbc)
+                             int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
@@ -744,7 +744,7 @@ void FixPIMD::grow_arrays(int nmax)
 
 /* ---------------------------------------------------------------------- */
 
-void FixPIMD::copy_arrays(int i, int j, int delflag)
+void FixPIMD::copy_arrays(int i, int j, int /*delflag*/)
 {
   int i_pos = i*3;
   int j_pos = j*3;
@@ -832,7 +832,7 @@ int FixPIMD::maxsize_restart()
 
 /* ---------------------------------------------------------------------- */
 
-int FixPIMD::size_restart(int nlocal)
+int FixPIMD::size_restart(int /*nlocal*/)
 {
   return size_peratom_cols+1;
 }
diff --git a/src/USER-MISC/fix_rhok.cpp b/src/USER-MISC/fix_rhok.cpp
index bbc4ce417a..78d63b79a8 100644
--- a/src/USER-MISC/fix_rhok.cpp
+++ b/src/USER-MISC/fix_rhok.cpp
@@ -144,7 +144,7 @@ FixRhok::min_setup( int inVFlag )
 
 // Modify the forces calculated in the main force loop of ordinary MD
 void
-FixRhok::post_force( int inVFlag )
+FixRhok::post_force( int /*inVFlag*/ )
 {
   double **x = atom->x;
   double **f = atom->f;
@@ -206,7 +206,7 @@ FixRhok::post_force( int inVFlag )
 
 // Forces in RESPA loop
 void
-FixRhok::post_force_respa( int inVFlag, int inILevel, int inILoop )
+FixRhok::post_force_respa( int inVFlag, int inILevel, int /*inILoop*/ )
 {
   if( inILevel == mNLevelsRESPA - 1 )
     post_force( inVFlag );
diff --git a/src/USER-MISC/fix_smd.cpp b/src/USER-MISC/fix_smd.cpp
index a42690c280..cbebdebdbf 100644
--- a/src/USER-MISC/fix_smd.cpp
+++ b/src/USER-MISC/fix_smd.cpp
@@ -461,7 +461,7 @@ void FixSMD::restart(char *buf)
 
 /* ---------------------------------------------------------------------- */
 
-void FixSMD::post_force_respa(int vflag, int ilevel, int iloop)
+void FixSMD::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == ilevel_respa) post_force(vflag);
 }
diff --git a/src/USER-MISC/fix_srp.cpp b/src/USER-MISC/fix_srp.cpp
index e4d85e8674..ebc161ff99 100644
--- a/src/USER-MISC/fix_srp.cpp
+++ b/src/USER-MISC/fix_srp.cpp
@@ -145,7 +145,7 @@ void FixSRP::init()
    insert bond particles
 ------------------------------------------------------------------------- */
 
-void FixSRP::setup_pre_force(int zz)
+void FixSRP::setup_pre_force(int /*zz*/)
 {
   double **x = atom->x;
   double **xold;
@@ -394,7 +394,7 @@ void FixSRP::grow_arrays(int nmax)
    called when move to new proc
 ------------------------------------------------------------------------- */
 
-void FixSRP::copy_arrays(int i, int j, int delflag)
+void FixSRP::copy_arrays(int i, int j, int /*delflag*/)
 {
   for (int m = 0; m < 2; m++)
     array[j][m] = array[i][m];
@@ -589,7 +589,7 @@ int FixSRP::maxsize_restart()
    size of atom nlocal's restart data
 ------------------------------------------------------------------------- */
 
-int FixSRP::size_restart(int nlocal)
+int FixSRP::size_restart(int /*nlocal*/)
 {
   return 3;
 }
@@ -632,7 +632,7 @@ void FixSRP::restart(char *buf)
    pair srp sets the bond type in this fix
 ------------------------------------------------------------------------- */
 
-int FixSRP::modify_param(int narg, char **arg)
+int FixSRP::modify_param(int /*narg*/, char **arg)
 {
   if (strcmp(arg[0],"btype") == 0) {
     btype = atoi(arg[1]);
diff --git a/src/USER-MISC/fix_ti_spring.cpp b/src/USER-MISC/fix_ti_spring.cpp
index 5812142763..305e29e033 100644
--- a/src/USER-MISC/fix_ti_spring.cpp
+++ b/src/USER-MISC/fix_ti_spring.cpp
@@ -167,7 +167,7 @@ void FixTISpring::min_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTISpring::post_force(int vflag)
+void FixTISpring::post_force(int /*vflag*/)
 {
   // do not calculate forces during equilibration
   if ((update->ntimestep - t0) < t_equil) return;
@@ -200,7 +200,7 @@ void FixTISpring::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTISpring::post_force_respa(int vflag, int ilevel, int iloop)
+void FixTISpring::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
@@ -214,7 +214,7 @@ void FixTISpring::min_post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTISpring::initial_integrate(int vflag)
+void FixTISpring::initial_integrate(int /*vflag*/)
 {
   // Update the coupling parameter value if needed
   if ((update->ntimestep - t0) < t_equil) return;
@@ -278,7 +278,7 @@ void FixTISpring::grow_arrays(int nmax)
      copy values within local atom-based array
 ------------------------------------------------------------------------- */
 
-void FixTISpring::copy_arrays(int i, int j, int delflag)
+void FixTISpring::copy_arrays(int i, int j, int /*delflag*/)
 {
   xoriginal[j][0] = xoriginal[i][0];
   xoriginal[j][1] = xoriginal[i][1];
@@ -354,7 +354,7 @@ int FixTISpring::maxsize_restart()
      size of atom nlocal's restart data
 ------------------------------------------------------------------------- */
 
-int FixTISpring::size_restart(int nlocal)
+int FixTISpring::size_restart(int /*nlocal*/)
 {
   return 4;
 }
diff --git a/src/USER-MISC/fix_ttm_mod.cpp b/src/USER-MISC/fix_ttm_mod.cpp
index 1e1e62b638..65f8e90ec3 100644
--- a/src/USER-MISC/fix_ttm_mod.cpp
+++ b/src/USER-MISC/fix_ttm_mod.cpp
@@ -357,7 +357,7 @@ void FixTTMMod::setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTMMod::post_force(int vflag)
+void FixTTMMod::post_force(int /*vflag*/)
 {
   double **x = atom->x;
   double **v = atom->v;
@@ -451,7 +451,7 @@ void FixTTMMod::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTMMod::post_force_setup(int vflag)
+void FixTTMMod::post_force_setup(int /*vflag*/)
 {
   double **f = atom->f;
   int *mask = atom->mask;
@@ -468,14 +468,14 @@ void FixTTMMod::post_force_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTMMod::post_force_respa(int vflag, int ilevel, int iloop)
+void FixTTMMod::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
 
 /* ---------------------------------------------------------------------- */
 
-void FixTTMMod::post_force_respa_setup(int vflag, int ilevel, int iloop)
+void FixTTMMod::post_force_respa_setup(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force_setup(vflag);
 }
@@ -916,7 +916,7 @@ int FixTTMMod::maxsize_restart()
    size of atom nlocal's restart data
 ------------------------------------------------------------------------- */
 
-int FixTTMMod::size_restart(int nlocal)
+int FixTTMMod::size_restart(int /*nlocal*/)
 {
   return 4;
 }
diff --git a/src/USER-MISC/fix_wall_region_ees.cpp b/src/USER-MISC/fix_wall_region_ees.cpp
index 82a78d3e73..33bf636e64 100644
--- a/src/USER-MISC/fix_wall_region_ees.cpp
+++ b/src/USER-MISC/fix_wall_region_ees.cpp
@@ -149,7 +149,7 @@ void FixWallRegionEES::min_setup(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixWallRegionEES::post_force(int vflag)
+void FixWallRegionEES::post_force(int /*vflag*/)
 {
   //sth is needed here, but I dont know what
   //that is calculation of sn
@@ -246,7 +246,7 @@ void FixWallRegionEES::post_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixWallRegionEES::post_force_respa(int vflag, int ilevel, int iloop)
+void FixWallRegionEES::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
diff --git a/src/USER-MISC/pair_agni.cpp b/src/USER-MISC/pair_agni.cpp
index 11bf2ae01e..3bba690e19 100644
--- a/src/USER-MISC/pair_agni.cpp
+++ b/src/USER-MISC/pair_agni.cpp
@@ -246,7 +246,7 @@ void PairAGNI::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairAGNI::settings(int narg, char **arg)
+void PairAGNI::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/USER-MISC/pair_buck_mdf.cpp b/src/USER-MISC/pair_buck_mdf.cpp
index 457d75bc77..61d32892fc 100644
--- a/src/USER-MISC/pair_buck_mdf.cpp
+++ b/src/USER-MISC/pair_buck_mdf.cpp
@@ -391,8 +391,8 @@ void PairBuckMDF::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairBuckMDF::single(int i, int j, int itype, int jtype,
-                        double rsq, double factor_coul, double factor_lj,
+double PairBuckMDF::single(int /*i*/, int /*j*/, int itype, int jtype,
+                        double rsq, double /*factor_coul*/, double factor_lj,
                         double &fforce)
 {
   double r2inv,r6inv,r,rexp,forcebuck,phibuck;
diff --git a/src/USER-MISC/pair_coul_diel.cpp b/src/USER-MISC/pair_coul_diel.cpp
index 3f07df3d98..0154e89731 100644
--- a/src/USER-MISC/pair_coul_diel.cpp
+++ b/src/USER-MISC/pair_coul_diel.cpp
@@ -326,7 +326,7 @@ void PairCoulDiel::read_restart_settings(FILE *fp)
 /* ---------------------------------------------------------------------- */
 
 double PairCoulDiel::single(int i, int j, int itype, int jtype,
-                           double rsq, double factor_coul, double factor_lj,
+                           double rsq, double factor_coul, double /*factor_lj*/,
                            double &fforce)
 {
   double r, rarg,forcedielec,phidielec;
diff --git a/src/USER-MISC/pair_coul_shield.cpp b/src/USER-MISC/pair_coul_shield.cpp
index deec7da81f..11df975c19 100644
--- a/src/USER-MISC/pair_coul_shield.cpp
+++ b/src/USER-MISC/pair_coul_shield.cpp
@@ -341,7 +341,7 @@ void PairCoulShield::read_restart_settings(FILE *fp)
 /* ---------------------------------------------------------------------- */
 
 double PairCoulShield::single(int i, int j, int itype, int jtype,
-                           double rsq, double factor_coul, double factor_lj,
+                           double rsq, double factor_coul, double /*factor_lj*/,
                            double &fforce)
 {
   double r, rarg,Vc,fvc,forcecoul,phishieldec;
diff --git a/src/USER-MISC/pair_edip.cpp b/src/USER-MISC/pair_edip.cpp
index 2976d7ad73..4716e271d7 100644
--- a/src/USER-MISC/pair_edip.cpp
+++ b/src/USER-MISC/pair_edip.cpp
@@ -621,7 +621,7 @@ void PairEDIP::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairEDIP::settings(int narg, char **arg)
+void PairEDIP::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/USER-MISC/pair_edip_multi.cpp b/src/USER-MISC/pair_edip_multi.cpp
index 6be57eee74..fc76aadb0b 100644
--- a/src/USER-MISC/pair_edip_multi.cpp
+++ b/src/USER-MISC/pair_edip_multi.cpp
@@ -516,7 +516,7 @@ void PairEDIPMulti::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairEDIPMulti::settings(int narg, char **arg)
+void PairEDIPMulti::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/USER-MISC/pair_extep.cpp b/src/USER-MISC/pair_extep.cpp
index 5a8cdf2884..49c562471f 100644
--- a/src/USER-MISC/pair_extep.cpp
+++ b/src/USER-MISC/pair_extep.cpp
@@ -442,7 +442,7 @@ void PairExTeP::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairExTeP::settings(int narg, char **arg)
+void PairExTeP::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/USER-MISC/pair_gauss_cut.cpp b/src/USER-MISC/pair_gauss_cut.cpp
index 85f7c02887..a000eff028 100644
--- a/src/USER-MISC/pair_gauss_cut.cpp
+++ b/src/USER-MISC/pair_gauss_cut.cpp
@@ -374,8 +374,8 @@ void PairGaussCut::write_data_all(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairGaussCut::single(int i, int j, int itype, int jtype, double rsq,
-                         double factor_coul, double factor_lj,
+double PairGaussCut::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                         double /*factor_coul*/, double factor_lj,
                          double &fforce)
 {
   double r, rexp,ugauss,phigauss;
diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.cpp b/src/USER-MISC/pair_ilp_graphene_hbn.cpp
index 30ee2e7a5a..2aecbe5d19 100644
--- a/src/USER-MISC/pair_ilp_graphene_hbn.cpp
+++ b/src/USER-MISC/pair_ilp_graphene_hbn.cpp
@@ -1010,8 +1010,8 @@ void PairILPGrapheneHBN::read_file(char *filename)
 
 /* ---------------------------------------------------------------------- */
 
-double PairILPGrapheneHBN::single(int i, int j, int itype, int jtype, double rsq,
-                         double factor_coul, double factor_lj,
+double PairILPGrapheneHBN::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                         double /*factor_coul*/, double factor_lj,
                          double &fforce)
 {
   double r,r2inv,r6inv,r8inv,forcelj,philj,fpair;
@@ -1047,7 +1047,7 @@ double PairILPGrapheneHBN::single(int i, int j, int itype, int jtype, double rsq
 /* ---------------------------------------------------------------------- */
 
 int PairILPGrapheneHBN::pack_forward_comm(int n, int *list, double *buf,
-                               int pbc_flag, int *pbc)
+                               int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m,id,ip,l;
 
diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp
index be0e81d48d..4c1f36c640 100644
--- a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp
+++ b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp
@@ -1015,8 +1015,8 @@ void PairKolmogorovCrespiFull::read_file(char *filename)
 
 /* ---------------------------------------------------------------------- */
 
-double PairKolmogorovCrespiFull::single(int i, int j, int itype, int jtype, double rsq,
-                         double factor_coul, double factor_lj,
+double PairKolmogorovCrespiFull::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                         double /*factor_coul*/, double factor_lj,
                          double &fforce)
 {
   double r,r2inv,r6inv,r8inv,forcelj,philj;
@@ -1050,7 +1050,7 @@ double PairKolmogorovCrespiFull::single(int i, int j, int itype, int jtype, doub
 /* ---------------------------------------------------------------------- */
 
 int PairKolmogorovCrespiFull::pack_forward_comm(int n, int *list, double *buf,
-                               int pbc_flag, int *pbc)
+                               int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m,l,ip,id;
 
diff --git a/src/USER-MISC/pair_lennard_mdf.cpp b/src/USER-MISC/pair_lennard_mdf.cpp
index f6e7f7f56b..45d0da4d83 100644
--- a/src/USER-MISC/pair_lennard_mdf.cpp
+++ b/src/USER-MISC/pair_lennard_mdf.cpp
@@ -352,9 +352,9 @@ void PairLJ_AB_MDF::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairLJ_AB_MDF::single(int i, int j, int itype, int jtype,
+double PairLJ_AB_MDF::single(int /*i*/, int /*j*/, int itype, int jtype,
                              double rsq,
-                             double factor_coul, double factor_lj,
+                             double /*factor_coul*/, double factor_lj,
                              double &fforce)
 {
   double r2inv,r6inv,forcelj,philj;
diff --git a/src/USER-MISC/pair_lj_mdf.cpp b/src/USER-MISC/pair_lj_mdf.cpp
index d43a6c3086..891239016b 100644
--- a/src/USER-MISC/pair_lj_mdf.cpp
+++ b/src/USER-MISC/pair_lj_mdf.cpp
@@ -352,9 +352,9 @@ void PairLJMDF::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairLJMDF::single(int i, int j, int itype, int jtype,
+double PairLJMDF::single(int /*i*/, int /*j*/, int itype, int jtype,
                              double rsq,
-                             double factor_coul, double factor_lj,
+                             double /*factor_coul*/, double factor_lj,
                              double &fforce)
 {
   double r2inv,r6inv,forcelj,philj;
diff --git a/src/USER-MISC/pair_meam_spline.cpp b/src/USER-MISC/pair_meam_spline.cpp
index 750f6ac5bb..1305891b33 100644
--- a/src/USER-MISC/pair_meam_spline.cpp
+++ b/src/USER-MISC/pair_meam_spline.cpp
@@ -360,7 +360,7 @@ void PairMEAMSpline::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairMEAMSpline::settings(int narg, char **arg)
+void PairMEAMSpline::settings(int narg, char **/*arg*/)
 {
   if(narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -592,7 +592,7 @@ void PairMEAMSpline::init_list(int id, NeighList *ptr)
 /* ----------------------------------------------------------------------
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
-double PairMEAMSpline::init_one(int i, int j)
+double PairMEAMSpline::init_one(int /*i*/, int /*j*/)
 {
   return cutoff;
 }
@@ -600,7 +600,7 @@ double PairMEAMSpline::init_one(int i, int j)
 /* ---------------------------------------------------------------------- */
 
 int PairMEAMSpline::pack_forward_comm(int n, int *list, double *buf,
-                                      int pbc_flag, int *pbc)
+                                      int /*pbc_flag*/, int */*pbc*/)
 {
   int* list_iter = list;
   int* list_iter_end = list + n;
@@ -618,14 +618,14 @@ void PairMEAMSpline::unpack_forward_comm(int n, int first, double *buf)
 
 /* ---------------------------------------------------------------------- */
 
-int PairMEAMSpline::pack_reverse_comm(int n, int first, double *buf)
+int PairMEAMSpline::pack_reverse_comm(int /*n*/, int /*first*/, double */*buf*/)
 {
   return 0;
 }
 
 /* ---------------------------------------------------------------------- */
 
-void PairMEAMSpline::unpack_reverse_comm(int n, int *list, double *buf)
+void PairMEAMSpline::unpack_reverse_comm(int /*n*/, int */*list*/, double */*buf*/)
 {
 }
 
diff --git a/src/USER-MISC/pair_meam_sw_spline.cpp b/src/USER-MISC/pair_meam_sw_spline.cpp
index f6b7212f9c..be0ac1c35b 100644
--- a/src/USER-MISC/pair_meam_sw_spline.cpp
+++ b/src/USER-MISC/pair_meam_sw_spline.cpp
@@ -372,7 +372,7 @@ void PairMEAMSWSpline::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairMEAMSWSpline::settings(int narg, char **arg)
+void PairMEAMSWSpline::settings(int narg, char **/*arg*/)
 {
   if(narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -552,7 +552,7 @@ void PairMEAMSWSpline::init_list(int id, NeighList *ptr)
 /* ----------------------------------------------------------------------
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
-double PairMEAMSWSpline::init_one(int i, int j)
+double PairMEAMSWSpline::init_one(int /*i*/, int /*j*/)
 {
         return cutoff;
 }
@@ -560,7 +560,7 @@ double PairMEAMSWSpline::init_one(int i, int j)
 /* ---------------------------------------------------------------------- */
 
 int PairMEAMSWSpline::pack_forward_comm(int n, int *list, double *buf,
-                                        int pbc_flag, int *pbc)
+                                        int /*pbc_flag*/, int */*pbc*/)
 {
         int* list_iter = list;
         int* list_iter_end = list + n;
@@ -578,14 +578,14 @@ void PairMEAMSWSpline::unpack_forward_comm(int n, int first, double *buf)
 
 /* ---------------------------------------------------------------------- */
 
-int PairMEAMSWSpline::pack_reverse_comm(int n, int first, double *buf)
+int PairMEAMSWSpline::pack_reverse_comm(int /*n*/, int /*first*/, double */*buf*/)
 {
         return 0;
 }
 
 /* ---------------------------------------------------------------------- */
 
-void PairMEAMSWSpline::unpack_reverse_comm(int n, int *list, double *buf)
+void PairMEAMSWSpline::unpack_reverse_comm(int /*n*/, int */*list*/, double */*buf*/)
 {
 }
 
diff --git a/src/USER-MISC/pair_momb.cpp b/src/USER-MISC/pair_momb.cpp
index 12a40bb08b..927181ebf6 100644
--- a/src/USER-MISC/pair_momb.cpp
+++ b/src/USER-MISC/pair_momb.cpp
@@ -365,8 +365,8 @@ void PairMomb::read_restart_settings(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairMomb::single(int i, int j, int itype, int jtype, double rsq,
-                         double factor_coul, double factor_lj,
+double PairMomb::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                         double /*factor_coul*/, double factor_lj,
                          double &fforce)
 {
   double r,dr,dexp,phi,r2inv,r6inv,ddexp,invexp;
diff --git a/src/USER-MISC/pair_morse_smooth_linear.cpp b/src/USER-MISC/pair_morse_smooth_linear.cpp
index 8a9c89cf69..328c1bd27b 100644
--- a/src/USER-MISC/pair_morse_smooth_linear.cpp
+++ b/src/USER-MISC/pair_morse_smooth_linear.cpp
@@ -337,8 +337,8 @@ void PairMorseSmoothLinear::write_data_all(FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-double PairMorseSmoothLinear::single(int i, int j, int itype, int jtype, double rsq,
-                                     double factor_coul, double factor_lj,
+double PairMorseSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq,
+                                     double /*factor_coul*/, double factor_lj,
                                      double &fforce)
 {
   double r,dr,dexp,phi;
diff --git a/src/USER-MISC/pair_tersoff_table.cpp b/src/USER-MISC/pair_tersoff_table.cpp
index c2362b8de9..d7e28a1e40 100644
--- a/src/USER-MISC/pair_tersoff_table.cpp
+++ b/src/USER-MISC/pair_tersoff_table.cpp
@@ -719,7 +719,7 @@ void PairTersoffTable::allocate()
    global settings
 ------------------------------------------------------------------------- */
 
-void PairTersoffTable::settings(int narg, char **arg)
+void PairTersoffTable::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
 }
diff --git a/src/USER-MOFFF/angle_cosine_buck6d.cpp b/src/USER-MOFFF/angle_cosine_buck6d.cpp
index b5800db2be..352c28be4d 100644
--- a/src/USER-MOFFF/angle_cosine_buck6d.cpp
+++ b/src/USER-MOFFF/angle_cosine_buck6d.cpp
@@ -309,7 +309,7 @@ void AngleCosineBuck6d::init_style()
 
 /* ---------------------------------------------------------------------- */
 
-double AngleCosineBuck6d::equilibrium_angle(int i)
+double AngleCosineBuck6d::equilibrium_angle(int /*i*/)
 {
   return MY_PI;
 }
diff --git a/src/USER-PHONON/fix_phonon.cpp b/src/USER-PHONON/fix_phonon.cpp
index 3a37c67a38..cdbe4068bc 100644
--- a/src/USER-PHONON/fix_phonon.cpp
+++ b/src/USER-PHONON/fix_phonon.cpp
@@ -299,7 +299,7 @@ void FixPhonon::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixPhonon::setup(int flag)
+void FixPhonon::setup(int /*flag*/)
 {
   // initialize accumulating variables
   for (int i = 0; i < sysdim; ++i) TempSum[i] = 0.;
diff --git a/src/USER-QTB/fix_qbmsst.cpp b/src/USER-QTB/fix_qbmsst.cpp
index fa5ee75bcb..e8a4f85eaa 100644
--- a/src/USER-QTB/fix_qbmsst.cpp
+++ b/src/USER-QTB/fix_qbmsst.cpp
@@ -424,7 +424,7 @@ void FixQBMSST::init()
 /* ----------------------------------------------------------------------
    compute T,P before integrator starts
 ------------------------------------------------------------------------- */
-void FixQBMSST::setup(int vflag)
+void FixQBMSST::setup(int /*vflag*/)
 {
   lagrangian_position = 0.0;
 
@@ -507,7 +507,7 @@ void FixQBMSST::setup(int vflag)
 /* ----------------------------------------------------------------------
    1st half of Verlet update
 ------------------------------------------------------------------------- */
-void FixQBMSST::initial_integrate(int vflag)
+void FixQBMSST::initial_integrate(int /*vflag*/)
 {
   int sd;
   sd = direction;
@@ -1157,7 +1157,7 @@ void FixQBMSST::grow_arrays(int nmax)
 /* ----------------------------------------------------------------------
    copy values within local atom-based array
 ------------------------------------------------------------------------- */
-void FixQBMSST::copy_arrays(int i, int j, int delflag)
+void FixQBMSST::copy_arrays(int i, int j, int /*delflag*/)
 {
   for (int m = 0; m < 2*N_f; m++) {
     random_array_0[j][m] = random_array_0[i][m];
diff --git a/src/USER-QTB/fix_qtb.cpp b/src/USER-QTB/fix_qtb.cpp
index 7f9a6510be..015f953b8e 100644
--- a/src/USER-QTB/fix_qtb.cpp
+++ b/src/USER-QTB/fix_qtb.cpp
@@ -239,7 +239,7 @@ void FixQTB::setup(int vflag)
 /* ----------------------------------------------------------------------
    post_force
 ------------------------------------------------------------------------- */
-void FixQTB::post_force(int vflag)
+void FixQTB::post_force(int /*vflag*/)
 {
   double gamma1,gamma3;
 
@@ -334,7 +334,7 @@ void FixQTB::post_force(int vflag)
 /* ----------------------------------------------------------------------
    post_force_respa
 ------------------------------------------------------------------------- */
-void FixQTB::post_force_respa(int vflag, int ilevel, int iloop)
+void FixQTB::post_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) post_force(vflag);
 }
@@ -392,7 +392,7 @@ void FixQTB::grow_arrays(int nmax)
 /* ----------------------------------------------------------------------
    copy values within local atom-based array
 ------------------------------------------------------------------------- */
-void FixQTB::copy_arrays(int i, int j, int delflag)
+void FixQTB::copy_arrays(int i, int j, int /*delflag*/)
 {
   for (int m = 0; m < 2*N_f; m++) {
     random_array_0[j][m] = random_array_0[i][m];
diff --git a/src/USER-QUIP/pair_quip.cpp b/src/USER-QUIP/pair_quip.cpp
index 0c00a5ef59..6f5040d037 100644
--- a/src/USER-QUIP/pair_quip.cpp
+++ b/src/USER-QUIP/pair_quip.cpp
@@ -212,7 +212,7 @@ void PairQUIP::compute(int eflag, int vflag)
    global settings
 ------------------------------------------------------------------------- */
 
-void PairQUIP::settings(int narg, char **arg)
+void PairQUIP::settings(int narg, char **/*arg*/)
 {
   if (narg != 0) error->all(FLERR,"Illegal pair_style command");
   if (strcmp(force->pair_style,"hybrid") == 0)
@@ -315,7 +315,7 @@ void PairQUIP::init_style()
    init for one type pair i,j and corresponding j,i
 ------------------------------------------------------------------------- */
 
-double PairQUIP::init_one(int i, int j)
+double PairQUIP::init_one(int /*i*/, int /*j*/)
 {
   return cutoff;
 }
diff --git a/src/USER-REAXC/fix_qeq_reax.cpp b/src/USER-REAXC/fix_qeq_reax.cpp
index a2f4d3d0e9..a6e59f7620 100644
--- a/src/USER-REAXC/fix_qeq_reax.cpp
+++ b/src/USER-REAXC/fix_qeq_reax.cpp
@@ -381,7 +381,7 @@ void FixQEqReax::init()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqReax::init_list(int id, NeighList *ptr)
+void FixQEqReax::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
@@ -485,7 +485,7 @@ void FixQEqReax::init_storage()
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqReax::pre_force(int vflag)
+void FixQEqReax::pre_force(int /*vflag*/)
 {
   double t_start, t_end;
 
@@ -518,7 +518,7 @@ void FixQEqReax::pre_force(int vflag)
 
 /* ---------------------------------------------------------------------- */
 
-void FixQEqReax::pre_force_respa(int vflag, int ilevel, int iloop)
+void FixQEqReax::pre_force_respa(int vflag, int ilevel, int /*iloop*/)
 {
   if (ilevel == nlevels_respa-1) pre_force(vflag);
 }
@@ -833,7 +833,7 @@ void FixQEqReax::calculate_Q()
 /* ---------------------------------------------------------------------- */
 
 int FixQEqReax::pack_forward_comm(int n, int *list, double *buf,
-                                  int pbc_flag, int *pbc)
+                                  int /*pbc_flag*/, int */*pbc*/)
 {
   int m;
 
@@ -952,7 +952,7 @@ void FixQEqReax::grow_arrays(int nmax)
    copy values within fictitious charge arrays
 ------------------------------------------------------------------------- */
 
-void FixQEqReax::copy_arrays(int i, int j, int delflag)
+void FixQEqReax::copy_arrays(int i, int j, int /*delflag*/)
 {
   for (int m = 0; m < nprev; m++) {
     s_hist[j][m] = s_hist[i][m];
diff --git a/src/USER-REAXC/fix_reaxc.cpp b/src/USER-REAXC/fix_reaxc.cpp
index df06217993..df1d7db085 100644
--- a/src/USER-REAXC/fix_reaxc.cpp
+++ b/src/USER-REAXC/fix_reaxc.cpp
@@ -105,7 +105,7 @@ void FixReaxC::grow_arrays(int nmax)
    copy values within local atom-based arrays
 ------------------------------------------------------------------------- */
 
-void FixReaxC::copy_arrays(int i, int j, int delflag)
+void FixReaxC::copy_arrays(int i, int j, int /*delflag*/)
 {
   num_bonds[j] = num_bonds[i];
   num_hbonds[j] = num_hbonds[i];
@@ -136,7 +136,7 @@ int FixReaxC::unpack_exchange(int nlocal, double *buf)
 /* ---------------------------------------------------------------------- */
 
 int FixReaxC::pack_forward_comm(int n, int *list, double *buf,
-                                int pbc_flag, int *pbc)
+                                int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/USER-REAXC/fix_reaxc_bonds.cpp b/src/USER-REAXC/fix_reaxc_bonds.cpp
index b38d137412..f3e592a682 100644
--- a/src/USER-REAXC/fix_reaxc_bonds.cpp
+++ b/src/USER-REAXC/fix_reaxc_bonds.cpp
@@ -112,7 +112,7 @@ int FixReaxCBonds::setmask()
 
 /* ---------------------------------------------------------------------- */
 
-void FixReaxCBonds::setup(int vflag)
+void FixReaxCBonds::setup(int /*vflag*/)
 {
   end_of_step();
 }
@@ -137,7 +137,7 @@ void FixReaxCBonds::end_of_step()
 
 /* ---------------------------------------------------------------------- */
 
-void FixReaxCBonds::Output_ReaxC_Bonds(bigint ntimestep, FILE *fp)
+void FixReaxCBonds::Output_ReaxC_Bonds(bigint /*ntimestep*/, FILE */*fp*/)
 
 {
   int i, j;
@@ -185,7 +185,7 @@ void FixReaxCBonds::Output_ReaxC_Bonds(bigint ntimestep, FILE *fp)
 
 /* ---------------------------------------------------------------------- */
 
-void FixReaxCBonds::FindBond(struct _reax_list *lists, int &numbonds)
+void FixReaxCBonds::FindBond(struct _reax_list */*lists*/, int &numbonds)
 {
   int *ilist, i, ii, inum;
   int j, pj, nj;
diff --git a/src/USER-REAXC/fix_reaxc_species.cpp b/src/USER-REAXC/fix_reaxc_species.cpp
index 61b4cebf96..abb8708d8d 100644
--- a/src/USER-REAXC/fix_reaxc_species.cpp
+++ b/src/USER-REAXC/fix_reaxc_species.cpp
@@ -281,7 +281,7 @@ int FixReaxCSpecies::setmask()
 
 /* ---------------------------------------------------------------------- */
 
-void FixReaxCSpecies::setup(int vflag)
+void FixReaxCSpecies::setup(int /*vflag*/)
 {
   ntotal = static_cast<int> (atom->natoms);
   if (Name == NULL)
@@ -427,7 +427,7 @@ void FixReaxCSpecies::create_fix()
 
 /* ---------------------------------------------------------------------- */
 
-void FixReaxCSpecies::init_list(int id, NeighList *ptr)
+void FixReaxCSpecies::init_list(int /*id*/, NeighList *ptr)
 {
   list = ptr;
 }
@@ -442,7 +442,7 @@ void FixReaxCSpecies::post_integrate()
 
 /* ---------------------------------------------------------------------- */
 
-void FixReaxCSpecies::Output_ReaxC_Bonds(bigint ntimestep, FILE *fp)
+void FixReaxCSpecies::Output_ReaxC_Bonds(bigint ntimestep, FILE */*fp*/)
 
 {
   int Nmole, Nspec;
@@ -946,7 +946,7 @@ int FixReaxCSpecies::nint(const double &r)
 /* ---------------------------------------------------------------------- */
 
 int FixReaxCSpecies::pack_forward_comm(int n, int *list, double *buf,
-                                       int pbc_flag, int *pbc)
+                                       int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/USER-REAXC/pair_reaxc.cpp b/src/USER-REAXC/pair_reaxc.cpp
index 7f77d875bc..378d20952c 100644
--- a/src/USER-REAXC/pair_reaxc.cpp
+++ b/src/USER-REAXC/pair_reaxc.cpp
@@ -751,7 +751,7 @@ int PairReaxC::write_reax_lists()
 
 /* ---------------------------------------------------------------------- */
 
-void PairReaxC::read_reax_forces(int vflag)
+void PairReaxC::read_reax_forces(int /*vflag*/)
 {
   for( int i = 0; i < system->N; ++i ) {
     system->my_atoms[i].f[0] = workspace->f[i][0];
diff --git a/src/USER-REAXC/reaxc_allocate.cpp b/src/USER-REAXC/reaxc_allocate.cpp
index a07f090f92..14906a2a9c 100644
--- a/src/USER-REAXC/reaxc_allocate.cpp
+++ b/src/USER-REAXC/reaxc_allocate.cpp
@@ -39,8 +39,8 @@
    important: we cannot know the exact number of atoms that will fall into a
    process's box throughout the whole simulation. therefore
    we need to make upper bound estimates for various data structures */
-int PreAllocate_Space( reax_system *system, control_params *control,
-                       storage *workspace, MPI_Comm comm )
+int PreAllocate_Space( reax_system *system, control_params */*control*/,
+                       storage */*workspace*/, MPI_Comm comm )
 {
   int mincap = system->mincap;
   double safezone = system->safezone;
@@ -68,8 +68,8 @@ int PreAllocate_Space( reax_system *system, control_params *control,
 
 /*************       system        *************/
 
-int Allocate_System( reax_system *system, int local_cap, int total_cap,
-                     char *msg )
+int Allocate_System( reax_system *system, int /*local_cap*/, int total_cap,
+                     char */*msg*/ )
 {
   system->my_atoms = (reax_atom*)
     realloc( system->my_atoms, total_cap*sizeof(reax_atom) );
@@ -116,7 +116,7 @@ void DeAllocate_System( reax_system *system )
 
 
 /*************       workspace        *************/
-void DeAllocate_Workspace( control_params *control, storage *workspace )
+void DeAllocate_Workspace( control_params */*control*/, storage *workspace )
 {
   int i;
 
@@ -204,9 +204,9 @@ void DeAllocate_Workspace( control_params *control, storage *workspace )
 }
 
 
-int Allocate_Workspace( reax_system *system, control_params *control,
+int Allocate_Workspace( reax_system */*system*/, control_params */*control*/,
                         storage *workspace, int local_cap, int total_cap,
-                        MPI_Comm comm, char *msg )
+                        MPI_Comm comm, char */*msg*/ )
 {
   int i, total_real, total_rvec, local_rvec;
 
diff --git a/src/USER-REAXC/reaxc_bond_orders.cpp b/src/USER-REAXC/reaxc_bond_orders.cpp
index 468164a2c0..02df9ec518 100644
--- a/src/USER-REAXC/reaxc_bond_orders.cpp
+++ b/src/USER-REAXC/reaxc_bond_orders.cpp
@@ -359,8 +359,8 @@ int BOp( storage *workspace, reax_list *bonds, double bo_cut,
 }
 
 
-void BO( reax_system *system, control_params *control, simulation_data *data,
-         storage *workspace, reax_list **lists, output_controls *out_control )
+void BO( reax_system *system, control_params */*control*/, simulation_data */*data*/,
+         storage *workspace, reax_list **lists, output_controls */*out_control*/ )
 {
   int i, j, pj, type_i, type_j;
   int start_i, end_i, sym_index;
diff --git a/src/USER-REAXC/reaxc_bonds.cpp b/src/USER-REAXC/reaxc_bonds.cpp
index 9678addd6b..a26f70c543 100644
--- a/src/USER-REAXC/reaxc_bonds.cpp
+++ b/src/USER-REAXC/reaxc_bonds.cpp
@@ -31,9 +31,9 @@
 #include "reaxc_tool_box.h"
 #include "reaxc_vector.h"
 
-void Bonds( reax_system *system, control_params *control,
+void Bonds( reax_system *system, control_params */*control*/,
             simulation_data *data, storage *workspace, reax_list **lists,
-            output_controls *out_control )
+            output_controls */*out_control*/ )
 {
   int i, j, pj, natoms;
   int start_i, end_i;
diff --git a/src/USER-REAXC/reaxc_forces.cpp b/src/USER-REAXC/reaxc_forces.cpp
index 00b29824ea..56501eeda0 100644
--- a/src/USER-REAXC/reaxc_forces.cpp
+++ b/src/USER-REAXC/reaxc_forces.cpp
@@ -41,9 +41,9 @@
 
 interaction_function Interaction_Functions[NUM_INTRS];
 
-void Dummy_Interaction( reax_system *system, control_params *control,
-                        simulation_data *data, storage *workspace,
-                        reax_list **lists, output_controls *out_control )
+void Dummy_Interaction( reax_system */*system*/, control_params */*control*/,
+                        simulation_data */*data*/, storage */*workspace*/,
+                        reax_list **/*lists*/, output_controls */*out_control*/ )
 {
 }
 
@@ -68,7 +68,7 @@ void Init_Force_Functions( control_params *control )
 void Compute_Bonded_Forces( reax_system *system, control_params *control,
                             simulation_data *data, storage *workspace,
                             reax_list **lists, output_controls *out_control,
-                            MPI_Comm comm )
+                            MPI_Comm /*comm*/ )
 {
   int i;
 
@@ -83,7 +83,7 @@ void Compute_Bonded_Forces( reax_system *system, control_params *control,
 void Compute_NonBonded_Forces( reax_system *system, control_params *control,
                                simulation_data *data, storage *workspace,
                                reax_list **lists, output_controls *out_control,
-                               MPI_Comm comm )
+                               MPI_Comm /*comm*/ )
 {
 
   /* van der Waals and Coulomb interactions */
@@ -98,7 +98,7 @@ void Compute_NonBonded_Forces( reax_system *system, control_params *control,
 
 void Compute_Total_Force( reax_system *system, control_params *control,
                           simulation_data *data, storage *workspace,
-                          reax_list **lists, mpi_datatypes *mpi_data )
+                          reax_list **lists, mpi_datatypes */*mpi_data*/ )
 {
   int i, pj;
   reax_list *bonds = (*lists) + BONDS;
@@ -114,8 +114,8 @@ void Compute_Total_Force( reax_system *system, control_params *control,
 
 }
 
-void Validate_Lists( reax_system *system, storage *workspace, reax_list **lists,
-                     int step, int n, int N, int numH, MPI_Comm comm )
+void Validate_Lists( reax_system *system, storage */*workspace*/, reax_list **lists,
+                     int step, int /*n*/, int N, int numH, MPI_Comm comm )
 {
   int i, comp, Hindex;
   reax_list *bonds, *hbonds;
@@ -173,7 +173,7 @@ void Validate_Lists( reax_system *system, storage *workspace, reax_list **lists,
 
 void Init_Forces_noQEq( reax_system *system, control_params *control,
                         simulation_data *data, storage *workspace,
-                        reax_list **lists, output_controls *out_control,
+                        reax_list **lists, output_controls */*out_control*/,
                         MPI_Comm comm ) {
   int i, j, pj;
   int start_i, end_i;
@@ -317,7 +317,7 @@ void Init_Forces_noQEq( reax_system *system, control_params *control,
 
 void Estimate_Storages( reax_system *system, control_params *control,
                         reax_list **lists, int *Htop, int *hb_top,
-                        int *bond_top, int *num_3body, MPI_Comm comm )
+                        int *bond_top, int *num_3body, MPI_Comm /*comm*/ )
 {
   int i, j, pj;
   int start_i, end_i;
diff --git a/src/USER-REAXC/reaxc_hydrogen_bonds.cpp b/src/USER-REAXC/reaxc_hydrogen_bonds.cpp
index cb516b24f7..c0b3121a40 100644
--- a/src/USER-REAXC/reaxc_hydrogen_bonds.cpp
+++ b/src/USER-REAXC/reaxc_hydrogen_bonds.cpp
@@ -33,7 +33,7 @@
 
 void Hydrogen_Bonds( reax_system *system, control_params *control,
                      simulation_data *data, storage *workspace,
-                     reax_list **lists, output_controls *out_control )
+                     reax_list **lists, output_controls */*out_control*/ )
 {
   int  i, j, k, pi, pk;
   int  type_i, type_j, type_k;
diff --git a/src/USER-REAXC/reaxc_init_md.cpp b/src/USER-REAXC/reaxc_init_md.cpp
index 4af21284f2..33614c7c68 100644
--- a/src/USER-REAXC/reaxc_init_md.cpp
+++ b/src/USER-REAXC/reaxc_init_md.cpp
@@ -36,7 +36,7 @@
 #include "reaxc_tool_box.h"
 #include "reaxc_vector.h"
 
-int Init_System( reax_system *system, control_params *control, char *msg )
+int Init_System( reax_system *system, control_params *control, char */*msg*/ )
 {
   int i;
   reax_atom *atom;
@@ -66,7 +66,7 @@ int Init_System( reax_system *system, control_params *control, char *msg )
 
 
 int Init_Simulation_Data( reax_system *system, control_params *control,
-                          simulation_data *data, char *msg )
+                          simulation_data *data, char */*msg*/ )
 {
   Reset_Simulation_Data( data, control->virial );
 
@@ -139,8 +139,8 @@ int Init_Workspace( reax_system *system, control_params *control,
 
 
 /************** setup communication data structures  **************/
-int Init_MPI_Datatypes( reax_system *system, storage *workspace,
-                        mpi_datatypes *mpi_data, MPI_Comm comm, char *msg )
+int Init_MPI_Datatypes( reax_system *system, storage */*workspace*/,
+                        mpi_datatypes *mpi_data, MPI_Comm comm, char */*msg*/ )
 {
 
   /* setup the world */
@@ -151,8 +151,8 @@ int Init_MPI_Datatypes( reax_system *system, storage *workspace,
 }
 
 int  Init_Lists( reax_system *system, control_params *control,
-                 simulation_data *data, storage *workspace, reax_list **lists,
-                 mpi_datatypes *mpi_data, char *msg )
+                 simulation_data */*data*/, storage */*workspace*/, reax_list **lists,
+                 mpi_datatypes *mpi_data, char */*msg*/ )
 {
   int i, total_hbonds, total_bonds, bond_cap, num_3body, cap_3body, Htop;
   int *hb_top, *bond_top;
diff --git a/src/USER-REAXC/reaxc_io_tools.cpp b/src/USER-REAXC/reaxc_io_tools.cpp
index 4d58f7514d..030912d4b7 100644
--- a/src/USER-REAXC/reaxc_io_tools.cpp
+++ b/src/USER-REAXC/reaxc_io_tools.cpp
@@ -88,7 +88,7 @@ int Init_Output_Files( reax_system *system, control_params *control,
 
 /************************ close output files ************************/
 int Close_Output_Files( reax_system *system, control_params *control,
-                        output_controls *out_control, mpi_datatypes *mpi_data )
+                        output_controls *out_control, mpi_datatypes */*mpi_data*/ )
 {
   if( out_control->write_steps > 0 )
     End_Traj( system->my_rank, out_control );
diff --git a/src/USER-REAXC/reaxc_lookup.cpp b/src/USER-REAXC/reaxc_lookup.cpp
index 9db8b7b9f6..8cc1555c59 100644
--- a/src/USER-REAXC/reaxc_lookup.cpp
+++ b/src/USER-REAXC/reaxc_lookup.cpp
@@ -151,7 +151,7 @@ void Complete_Cubic_Spline( const double *h, const double *f, double v0, double
 
 
 int Init_Lookup_Tables( reax_system *system, control_params *control,
-                        storage *workspace, mpi_datatypes *mpi_data, char *msg )
+                        storage *workspace, mpi_datatypes *mpi_data, char */*msg*/ )
 {
   int i, j, r;
   int num_atom_types;
diff --git a/src/USER-REAXC/reaxc_multi_body.cpp b/src/USER-REAXC/reaxc_multi_body.cpp
index ce5b966529..e599a3d86e 100644
--- a/src/USER-REAXC/reaxc_multi_body.cpp
+++ b/src/USER-REAXC/reaxc_multi_body.cpp
@@ -32,7 +32,7 @@
 
 void Atom_Energy( reax_system *system, control_params *control,
                   simulation_data *data, storage *workspace, reax_list **lists,
-                  output_controls *out_control )
+                  output_controls */*out_control*/ )
 {
   int i, j, pj, type_i, type_j;
   double Delta_lpcorr, dfvl;
diff --git a/src/USER-REAXC/reaxc_nonbonded.cpp b/src/USER-REAXC/reaxc_nonbonded.cpp
index 9c223428a6..731b1602e9 100644
--- a/src/USER-REAXC/reaxc_nonbonded.cpp
+++ b/src/USER-REAXC/reaxc_nonbonded.cpp
@@ -33,7 +33,7 @@
 
 void vdW_Coulomb_Energy( reax_system *system, control_params *control,
                          simulation_data *data, storage *workspace,
-                         reax_list **lists, output_controls *out_control )
+                         reax_list **lists, output_controls */*out_control*/ )
 {
   int i, j, pj, natoms;
   int start_i, end_i, flag;
@@ -206,7 +206,7 @@ void vdW_Coulomb_Energy( reax_system *system, control_params *control,
 void Tabulated_vdW_Coulomb_Energy( reax_system *system,control_params *control,
                                    simulation_data *data, storage *workspace,
                                    reax_list **lists,
-                                   output_controls *out_control )
+                                   output_controls */*out_control*/ )
 {
   int i, j, pj, r, natoms;
   int type_i, type_j, tmin, tmax;
diff --git a/src/USER-REAXC/reaxc_reset_tools.cpp b/src/USER-REAXC/reaxc_reset_tools.cpp
index 4ec744e7b1..1b16f10aee 100644
--- a/src/USER-REAXC/reaxc_reset_tools.cpp
+++ b/src/USER-REAXC/reaxc_reset_tools.cpp
@@ -87,7 +87,7 @@ void Reset_Pressures( simulation_data *data )
 }
 
 
-void Reset_Simulation_Data( simulation_data* data, int virial )
+void Reset_Simulation_Data( simulation_data* data, int /*virial*/ )
 {
   Reset_Energies( &data->my_en );
   Reset_Energies( &data->sys_en );
diff --git a/src/USER-REAXC/reaxc_torsion_angles.cpp b/src/USER-REAXC/reaxc_torsion_angles.cpp
index c5a7f23b30..d6f38d3765 100644
--- a/src/USER-REAXC/reaxc_torsion_angles.cpp
+++ b/src/USER-REAXC/reaxc_torsion_angles.cpp
@@ -41,7 +41,7 @@ double Calculate_Omega( rvec dvec_ij, double r_ij,
                       three_body_interaction_data *p_jkl,
                       rvec dcos_omega_di, rvec dcos_omega_dj,
                       rvec dcos_omega_dk, rvec dcos_omega_dl,
-                      output_controls *out_control )
+                      output_controls */*out_control*/ )
 {
   double unnorm_cos_omega, unnorm_sin_omega, omega;
   double sin_ijk, cos_ijk, sin_jkl, cos_jkl;
diff --git a/src/USER-REAXC/reaxc_traj.cpp b/src/USER-REAXC/reaxc_traj.cpp
index ae2bba2150..f980120a59 100644
--- a/src/USER-REAXC/reaxc_traj.cpp
+++ b/src/USER-REAXC/reaxc_traj.cpp
@@ -48,7 +48,7 @@ int Reallocate_Output_Buffer( output_controls *out_control, int req_space,
 }
 
 
-void Write_Skip_Line( output_controls *out_control, mpi_datatypes *mpi_data,
+void Write_Skip_Line( output_controls *out_control, mpi_datatypes */*mpi_data*/,
                       int my_rank, int skip, int num_section )
 {
   if( my_rank == MASTER_NODE )
@@ -259,7 +259,7 @@ int Write_Header( reax_system *system, control_params *control,
 }
 
 
-int Write_Init_Desc( reax_system *system, control_params *control,
+int Write_Init_Desc( reax_system *system, control_params */*control*/,
                      output_controls *out_control, mpi_datatypes *mpi_data )
 {
   int i, me, np, cnt, buffer_len, buffer_req;
@@ -482,7 +482,7 @@ int Write_Frame_Header( reax_system *system, control_params *control,
 
 
 
-int Write_Atoms( reax_system *system, control_params *control,
+int Write_Atoms( reax_system *system, control_params */*control*/,
                  output_controls *out_control, mpi_datatypes *mpi_data )
 {
   int i, me, np, line_len, buffer_len, buffer_req, cnt;
diff --git a/src/USER-REAXC/reaxc_valence_angles.cpp b/src/USER-REAXC/reaxc_valence_angles.cpp
index c92996e56b..35342c9173 100644
--- a/src/USER-REAXC/reaxc_valence_angles.cpp
+++ b/src/USER-REAXC/reaxc_valence_angles.cpp
@@ -76,7 +76,7 @@ void Calculate_dCos_Theta( rvec dvec_ji, double d_ji, rvec dvec_jk, double d_jk,
 
 void Valence_Angles( reax_system *system, control_params *control,
                      simulation_data *data, storage *workspace,
-                     reax_list **lists, output_controls *out_control )
+                     reax_list **lists, output_controls */*out_control*/ )
 {
   int i, j, pi, k, pk, t;
   int type_i, type_j, type_k;
diff --git a/src/USER-SMD/atom_vec_smd.cpp b/src/USER-SMD/atom_vec_smd.cpp
index e99f3c5169..97a2fb0349 100644
--- a/src/USER-SMD/atom_vec_smd.cpp
+++ b/src/USER-SMD/atom_vec_smd.cpp
@@ -208,7 +208,7 @@ void AtomVecSMD::copy(int i, int j, int delflag) {
 
 /* ---------------------------------------------------------------------- */
 
-int AtomVecSMD::pack_comm(int n, int *list, double *buf, int pbc_flag, int *pbc) {
+int AtomVecSMD::pack_comm(int /*n*/, int */*list*/, double */*buf*/, int /*pbc_flag*/, int */*pbc*/) {
         error->one(FLERR, "atom vec tlsph can only be used with ghost velocities turned on");
         return -1;
 }
@@ -333,7 +333,7 @@ int AtomVecSMD::pack_comm_hybrid(int n, int *list, double *buf) {
 
 /* ---------------------------------------------------------------------- */
 
-void AtomVecSMD::unpack_comm(int n, int first, double *buf) {
+void AtomVecSMD::unpack_comm(int /*n*/, int /*first*/, double */*buf*/) {
         error->one(FLERR, "atom vec tlsph can only be used with ghost velocities turned on");
 }
 
@@ -441,7 +441,7 @@ int AtomVecSMD::unpack_reverse_hybrid(int n, int *list, double *buf) {
 
 /* ---------------------------------------------------------------------- */
 
-int AtomVecSMD::pack_border(int n, int *list, double *buf, int pbc_flag, int *pbc) {
+int AtomVecSMD::pack_border(int /*n*/, int */*list*/, double */*buf*/, int /*pbc_flag*/, int */*pbc*/) {
         error->one(FLERR, "atom vec tlsph can only be used with ghost velocities turned on");
         return -1;
 }
@@ -633,7 +633,7 @@ int AtomVecSMD::pack_border_hybrid(int n, int *list, double *buf) {
 
 /* ---------------------------------------------------------------------- */
 
-void AtomVecSMD::unpack_border(int n, int first, double *buf) {
+void AtomVecSMD::unpack_border(int /*n*/, int /*first*/, double */*buf*/) {
         error->one(FLERR, "atom vec tlsph can only be used with ghost velocities turned on");
 }
 
@@ -1098,7 +1098,7 @@ void AtomVecSMD::data_atom(double *coord, imageint imagetmp, char **values) {
  initialize other atom quantities for this sub-style
  ------------------------------------------------------------------------- */
 
-int AtomVecSMD::data_atom_hybrid(int nlocal, char **values) {
+int AtomVecSMD::data_atom_hybrid(int /*nlocal*/, char **/*values*/) {
         error->one(FLERR, "hybrid atom style functionality not yet implemented for atom style smd");
         return -1;
 }
@@ -1120,7 +1120,7 @@ void AtomVecSMD::data_vel(int m, char **values) {
  unpack hybrid quantities from one line in Velocities section of data file
  ------------------------------------------------------------------------- */
 
-int AtomVecSMD::data_vel_hybrid(int m, char **values) {
+int AtomVecSMD::data_vel_hybrid(int /*m*/, char **/*values*/) {
         error->one(FLERR, "hybrid atom style functionality not yet implemented for atom style smd");
         return 0;
 }
@@ -1158,7 +1158,7 @@ void AtomVecSMD::pack_data(double **buf) {
  pack hybrid atom info for data file
  ------------------------------------------------------------------------- */
 
-int AtomVecSMD::pack_data_hybrid(int i, double *buf) {
+int AtomVecSMD::pack_data_hybrid(int /*i*/, double */*buf*/) {
         error->one(FLERR, "hybrid atom style functionality not yet implemented for atom style smd");
         return -1;
 }
@@ -1180,7 +1180,7 @@ void AtomVecSMD::write_data(FILE *fp, int n, double **buf) {
  write hybrid atom info to data file
  ------------------------------------------------------------------------- */
 
-int AtomVecSMD::write_data_hybrid(FILE *fp, double *buf) {
+int AtomVecSMD::write_data_hybrid(FILE */*fp*/, double */*buf*/) {
         error->one(FLERR, "hybrid atom style functionality not yet implemented for atom style smd");
         return -1;
 }
@@ -1203,7 +1203,7 @@ void AtomVecSMD::pack_vel(double **buf) {
  pack hybrid velocity info for data file
  ------------------------------------------------------------------------- */
 
-int AtomVecSMD::pack_vel_hybrid(int i, double *buf) {
+int AtomVecSMD::pack_vel_hybrid(int /*i*/, double */*buf*/) {
         error->one(FLERR, "hybrid atom style functionality not yet implemented for atom style smd");
         return 0;
 }
@@ -1222,7 +1222,7 @@ void AtomVecSMD::write_vel(FILE *fp, int n, double **buf) {
  write hybrid velocity info to data file
  ------------------------------------------------------------------------- */
 
-int AtomVecSMD::write_vel_hybrid(FILE *fp, double *buf) {
+int AtomVecSMD::write_vel_hybrid(FILE */*fp*/, double */*buf*/) {
         error->one(FLERR, "hybrid atom style functionality not yet implemented for atom style smd");
         return 3;
 }
diff --git a/src/USER-SMD/fix_smd_adjust_dt.cpp b/src/USER-SMD/fix_smd_adjust_dt.cpp
index 3685248d5e..f015c6c4df 100644
--- a/src/USER-SMD/fix_smd_adjust_dt.cpp
+++ b/src/USER-SMD/fix_smd_adjust_dt.cpp
@@ -86,13 +86,13 @@ void FixSMDTlsphDtReset::init() {
 
 /* ---------------------------------------------------------------------- */
 
-void FixSMDTlsphDtReset::setup(int vflag) {
+void FixSMDTlsphDtReset::setup(int /*vflag*/) {
         end_of_step();
 }
 
 /* ---------------------------------------------------------------------- */
 
-void FixSMDTlsphDtReset::initial_integrate(int vflag) {
+void FixSMDTlsphDtReset::initial_integrate(int /*vflag*/) {
 
         //printf("in adjust_dt: dt = %20.10f\n", update->dt);
 
diff --git a/src/USER-SMD/fix_smd_integrate_tlsph.cpp b/src/USER-SMD/fix_smd_integrate_tlsph.cpp
index 4668e673fc..1eae45161f 100644
--- a/src/USER-SMD/fix_smd_integrate_tlsph.cpp
+++ b/src/USER-SMD/fix_smd_integrate_tlsph.cpp
@@ -125,7 +125,7 @@ void FixSMDIntegrateTlsph::init() {
 /* ----------------------------------------------------------------------
  ------------------------------------------------------------------------- */
 
-void FixSMDIntegrateTlsph::initial_integrate(int vflag) {
+void FixSMDIntegrateTlsph::initial_integrate(int /*vflag*/) {
         double dtfm, vsq, scale;
 
         // update v and x of atoms in group
diff --git a/src/USER-SMD/fix_smd_integrate_ulsph.cpp b/src/USER-SMD/fix_smd_integrate_ulsph.cpp
index a145deeb61..685d6af5a8 100644
--- a/src/USER-SMD/fix_smd_integrate_ulsph.cpp
+++ b/src/USER-SMD/fix_smd_integrate_ulsph.cpp
@@ -158,7 +158,7 @@ void FixSMDIntegrateUlsph::init() {
  allow for both per-type and per-atom mass
  ------------------------------------------------------------------------- */
 
-void FixSMDIntegrateUlsph::initial_integrate(int vflag) {
+void FixSMDIntegrateUlsph::initial_integrate(int /*vflag*/) {
         double **x = atom->x;
         double **v = atom->v;
         double **f = atom->f;
diff --git a/src/USER-SMD/fix_smd_move_triangulated_surface.cpp b/src/USER-SMD/fix_smd_move_triangulated_surface.cpp
index d4afbe0535..1515849c53 100644
--- a/src/USER-SMD/fix_smd_move_triangulated_surface.cpp
+++ b/src/USER-SMD/fix_smd_move_triangulated_surface.cpp
@@ -248,7 +248,7 @@ void FixSMDMoveTriSurf::init() {
 /* ----------------------------------------------------------------------
  ------------------------------------------------------------------------- */
 
-void FixSMDMoveTriSurf::initial_integrate(int vflag) {
+void FixSMDMoveTriSurf::initial_integrate(int /*vflag*/) {
         double **x = atom->x;
         double **x0 = atom->x0;
         double **v = atom->v;
@@ -461,7 +461,7 @@ void FixSMDMoveTriSurf::reset_dt() {
 
 /* ---------------------------------------------------------------------- */
 
-int FixSMDMoveTriSurf::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc) {
+int FixSMDMoveTriSurf::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/) {
         int i, j, m;
         double **x0 = atom->x0;
         double **smd_data_9 = atom->smd_data_9;
diff --git a/src/USER-SMD/fix_smd_setvel.cpp b/src/USER-SMD/fix_smd_setvel.cpp
index 5e7cdbad38..4bc8b5127b 100644
--- a/src/USER-SMD/fix_smd_setvel.cpp
+++ b/src/USER-SMD/fix_smd_setvel.cpp
@@ -231,7 +231,7 @@ void FixSMDSetVel::min_setup(int vflag) {
 /* ---------------------------------------------------------------------- */
 
 //void FixSMDSetVel::initial_integrate(int vflag) {
-void FixSMDSetVel::post_force(int vflag) {
+void FixSMDSetVel::post_force(int /*vflag*/) {
         double **x = atom->x;
         double **f = atom->f;
         double **v = atom->v;
diff --git a/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp b/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp
index 3e2812aa12..eba094da53 100644
--- a/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp
+++ b/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp
@@ -199,7 +199,7 @@ void FixSMD_TLSPH_ReferenceConfiguration::pre_exchange() {
  so can be migrated or stored with atoms
  ------------------------------------------------------------------------- */
 
-void FixSMD_TLSPH_ReferenceConfiguration::setup(int vflag) {
+void FixSMD_TLSPH_ReferenceConfiguration::setup(int /*vflag*/) {
         int i, j, ii, jj, n, inum, jnum;
         int *ilist, *jlist, *numneigh, **firstneigh;
         double r, h, wf, wfd;
@@ -386,7 +386,7 @@ void FixSMD_TLSPH_ReferenceConfiguration::grow_arrays(int nmax) {
  copy values within local atom-based arrays
  ------------------------------------------------------------------------- */
 
-void FixSMD_TLSPH_ReferenceConfiguration::copy_arrays(int i, int j, int delflag) {
+void FixSMD_TLSPH_ReferenceConfiguration::copy_arrays(int i, int j, int /*delflag*/) {
         npartner[j] = npartner[i];
         for (int m = 0; m < npartner[j]; m++) {
                 partner[j][m] = partner[i][m];
@@ -470,7 +470,7 @@ int FixSMD_TLSPH_ReferenceConfiguration::pack_restart(int i, double *buf) {
  unpack values from atom->extra array to restart the fix
  ------------------------------------------------------------------------- */
 
-void FixSMD_TLSPH_ReferenceConfiguration::unpack_restart(int nlocal, int nth) {
+void FixSMD_TLSPH_ReferenceConfiguration::unpack_restart(int /*nlocal*/, int /*nth*/) {
 // ipage = NULL if being called from granular pair style init()
 
 // skip to Nth set of extra values
@@ -512,7 +512,7 @@ int FixSMD_TLSPH_ReferenceConfiguration::size_restart(int nlocal) {
 
 /* ---------------------------------------------------------------------- */
 
-int FixSMD_TLSPH_ReferenceConfiguration::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc) {
+int FixSMD_TLSPH_ReferenceConfiguration::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/) {
         int i, j, m;
         double *radius = atom->radius;
         double *vfrac = atom->vfrac;
diff --git a/src/USER-SMD/fix_smd_wall_surface.cpp b/src/USER-SMD/fix_smd_wall_surface.cpp
index 97c2ead5fc..4dd415f53e 100644
--- a/src/USER-SMD/fix_smd_wall_surface.cpp
+++ b/src/USER-SMD/fix_smd_wall_surface.cpp
@@ -110,7 +110,7 @@ void FixSMDWallSurface::min_setup(int vflag) {
  must be done in setup (not init) since fix init comes before neigh init
  ------------------------------------------------------------------------- */
 
-void FixSMDWallSurface::setup(int vflag) {
+void FixSMDWallSurface::setup(int /*vflag*/) {
 
         if (!first)
                 return;
diff --git a/src/USER-SMD/pair_smd_hertz.cpp b/src/USER-SMD/pair_smd_hertz.cpp
index 815db4a450..13f48e995e 100644
--- a/src/USER-SMD/pair_smd_hertz.cpp
+++ b/src/USER-SMD/pair_smd_hertz.cpp
@@ -373,7 +373,7 @@ double PairHertz::memory_usage() {
         return 0.0;
 }
 
-void *PairHertz::extract(const char *str, int &i) {
+void *PairHertz::extract(const char *str, int &/*i*/) {
         //printf("in PairTriSurf::extract\n");
         if (strcmp(str, "smd/hertz/stable_time_increment_ptr") == 0) {
                 return (void *) &stable_time_increment;
diff --git a/src/USER-SMD/pair_smd_tlsph.cpp b/src/USER-SMD/pair_smd_tlsph.cpp
index 4dd16c4d83..f9922ef222 100644
--- a/src/USER-SMD/pair_smd_tlsph.cpp
+++ b/src/USER-SMD/pair_smd_tlsph.cpp
@@ -1802,7 +1802,7 @@ double PairTlsph::memory_usage() {
  extract method to provide access to this class' data structures
  ------------------------------------------------------------------------- */
 
-void *PairTlsph::extract(const char *str, int &i) {
+void *PairTlsph::extract(const char *str, int &/*i*/) {
 //printf("in PairTlsph::extract\n");
         if (strcmp(str, "smd/tlsph/Fincr_ptr") == 0) {
                 return (void *) Fincr;
@@ -1839,7 +1839,7 @@ void *PairTlsph::extract(const char *str, int &i) {
 
 /* ---------------------------------------------------------------------- */
 
-int PairTlsph::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc) {
+int PairTlsph::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/) {
         int i, j, m;
         tagint *mol = atom->molecule;
         double *damage = atom->damage;
@@ -1928,7 +1928,7 @@ void PairTlsph::unpack_forward_comm(int n, int first, double *buf) {
  ------------------------------------------------------------------------- */
 
 void PairTlsph::effective_longitudinal_modulus(const int itype, const double dt, const double d_iso, const double p_rate,
-                const Matrix3d d_dev, const Matrix3d sigma_dev_rate, const double damage, double &K_eff, double &mu_eff, double &M_eff) {
+                const Matrix3d d_dev, const Matrix3d sigma_dev_rate, const double /*damage*/, double &K_eff, double &mu_eff, double &M_eff) {
         double M0; // initial longitudinal modulus
         double shear_rate_sq;
 
@@ -2094,7 +2094,7 @@ void PairTlsph::ComputeStressDeviator(const int i, const Matrix3d sigmaInitial_d
 /* ----------------------------------------------------------------------
  Compute damage. Called from AssembleStress().
  ------------------------------------------------------------------------- */
-void PairTlsph::ComputeDamage(const int i, const Matrix3d strain, const Matrix3d stress, Matrix3d &stress_damaged) {
+void PairTlsph::ComputeDamage(const int i, const Matrix3d strain, const Matrix3d stress, Matrix3d &/*stress_damaged*/) {
         double *eff_plastic_strain = atom->eff_plastic_strain;
         double *eff_plastic_strain_rate = atom->eff_plastic_strain_rate;
         double *radius = atom->radius;
diff --git a/src/USER-SMD/pair_smd_triangulated_surface.cpp b/src/USER-SMD/pair_smd_triangulated_surface.cpp
index b8bff7e799..e40c876ec3 100644
--- a/src/USER-SMD/pair_smd_triangulated_surface.cpp
+++ b/src/USER-SMD/pair_smd_triangulated_surface.cpp
@@ -834,7 +834,7 @@ double PairTriSurf::clamp(const double a, const double min, const double max) {
         }
 }
 
-void *PairTriSurf::extract(const char *str, int &i) {
+void *PairTriSurf::extract(const char *str, int &/*i*/) {
         //printf("in PairTriSurf::extract\n");
         if (strcmp(str, "smd/tri_surface/stable_time_increment_ptr") == 0) {
                 return (void *) &stable_time_increment;
diff --git a/src/USER-SMD/pair_smd_ulsph.cpp b/src/USER-SMD/pair_smd_ulsph.cpp
index 96eb912fae..aa88e125d6 100644
--- a/src/USER-SMD/pair_smd_ulsph.cpp
+++ b/src/USER-SMD/pair_smd_ulsph.cpp
@@ -1487,7 +1487,7 @@ double PairULSPH::memory_usage() {
 
 /* ---------------------------------------------------------------------- */
 
-int PairULSPH::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc) {
+int PairULSPH::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/) {
         double *vfrac = atom->vfrac;
         double *eff_plastic_strain = atom->eff_plastic_strain;
         int i, j, m;
@@ -1562,7 +1562,7 @@ void PairULSPH::unpack_forward_comm(int n, int first, double *buf) {
  * EXTRACT
  */
 
-void *PairULSPH::extract(const char *str, int &i) {
+void *PairULSPH::extract(const char *str, int &/*i*/) {
 //printf("in extract\n");
         if (strcmp(str, "smd/ulsph/smoothVel_ptr") == 0) {
                 return (void *) smoothVel;
diff --git a/src/USER-SMD/smd_material_models.cpp b/src/USER-SMD/smd_material_models.cpp
index e3deb199b6..4213428872 100644
--- a/src/USER-SMD/smd_material_models.cpp
+++ b/src/USER-SMD/smd_material_models.cpp
@@ -97,7 +97,7 @@ void ShockEOS(double rho, double rho0, double e, double e0, double c0, double S,
  final pressure pFinal
 
  ------------------------------------------------------------------------- */
-void polynomialEOS(double rho, double rho0, double e, double C0, double C1, double C2, double C3, double C4, double C5, double C6,
+void polynomialEOS(double rho, double rho0, double /*e*/, double C0, double C1, double C2, double C3, double /*C4*/, double /*C5*/, double /*C6*/,
                 double pInitial, double dt, double &pFinal, double &p_rate) {
 
         double mu = rho / rho0 - 1.0;
@@ -307,7 +307,7 @@ void LinearPlasticStrength(const double G, const double yieldStress, const Matri
  output:  sigmaFinal_dev, sigmaFinal_dev_rate__: final stress deviator and its rate.
  ------------------------------------------------------------------------- */
 void JohnsonCookStrength(const double G, const double cp, const double espec, const double A, const double B, const double a,
-                const double C, const double epdot0, const double T0, const double Tmelt, const double M, const double dt, const double ep,
+                const double C, const double epdot0, const double T0, const double Tmelt, const double /*M*/, const double dt, const double ep,
                 const double epdot, const Matrix3d sigmaInitial_dev, const Matrix3d d_dev, Matrix3d &sigmaFinal_dev__,
                 Matrix3d &sigma_dev_rate__, double &plastic_strain_increment) {
 
diff --git a/src/USER-SMTBQ/pair_smtbq.cpp b/src/USER-SMTBQ/pair_smtbq.cpp
index 1028d8a897..9eee7d0728 100644
--- a/src/USER-SMTBQ/pair_smtbq.cpp
+++ b/src/USER-SMTBQ/pair_smtbq.cpp
@@ -242,7 +242,7 @@ void PairSMTBQ::allocate()
    global settings
    ------------------------------------------------------------------------- */
 
-void PairSMTBQ::settings(int narg, char **arg)
+void PairSMTBQ::settings(int narg, char **/*arg*/)
 {
   if (narg > 0) error->all(FLERR,"Illegal pair_style command");
 }
@@ -1592,7 +1592,7 @@ void PairSMTBQ::tabqeq()
 /* ---------------------------------------------------------------------*/
 
 void PairSMTBQ::potqeq(int i, int j, double qi, double qj, double rsq,
-                       double &fforce, int eflag, double &eng)
+                       double &fforce, int /*eflag*/, double &eng)
 {
 
   /* ===================================================================
@@ -1840,7 +1840,7 @@ void PairSMTBQ::pot_ES2 (int i, int j, double rsq, double &pot)
    -------------------------------------------------------------------- */
 
 void PairSMTBQ::rep_OO(Intparam *intparam, double rsq, double &fforce,
-                       int eflag, double &eng)
+                       int /*eflag*/, double &eng)
 {
   double r,tmp_exp,tmp;
   double A = intparam->abuck ;
@@ -1858,7 +1858,7 @@ void PairSMTBQ::rep_OO(Intparam *intparam, double rsq, double &fforce,
 
 
 void PairSMTBQ::Attr_OO(Intparam *intparam, double rsq, double &fforce,
-                        int eflag, double &eng)
+                        int /*eflag*/, double &eng)
 {
   double r,tmp_exp;
   double aOO = intparam->aOO ;
@@ -1980,8 +1980,8 @@ void PairSMTBQ::tabsm()
 
 /* -------------------------------------------------------------- */
 
-void PairSMTBQ::repulsive(Intparam *intparam, double rsq, int i, int j,
-                          double &fforce, int eflag, double &eng)
+void PairSMTBQ::repulsive(Intparam *intparam, double rsq, int /*i*/, int /*j*/,
+                          double &fforce, int /*eflag*/, double &eng)
 {
 
   /* ================================================
@@ -2031,7 +2031,7 @@ void PairSMTBQ::repulsive(Intparam *intparam, double rsq, int i, int j,
 
 
 void PairSMTBQ::attractive(Intparam *intparam, double rsq,
-                           int eflag, int i, double iq, int j, double jq)
+                           int /*eflag*/, int i, double /*iq*/, int /*j*/, double /*jq*/)
 {
   int itype,l;
   double r,t1,t2,xi,sds;
@@ -3334,7 +3334,7 @@ void PairSMTBQ::groupQEqAllParallel_QEq()
 
 /* ---------------------------------------------------------------------- */
 
-void PairSMTBQ::Init_charge(int *nQEq, int *nQEqa, int *nQEqc)
+void PairSMTBQ::Init_charge(int */*nQEq*/, int */*nQEqa*/, int */*nQEqc*/)
 {
   int ii,i,gp,itype;
   int *ilist,test[nteam],init[nteam];
@@ -3391,7 +3391,7 @@ void PairSMTBQ::Init_charge(int *nQEq, int *nQEqa, int *nQEqc)
  *                        COMMUNICATION
  * ---------------------------------------------------------------------- */
 
-int PairSMTBQ::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc)
+int PairSMTBQ::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/, int */*pbc*/)
 {
   int i,j,m;
 
diff --git a/src/USER-SPH/fix_meso.cpp b/src/USER-SPH/fix_meso.cpp
index d7a5d81517..b688eccfea 100644
--- a/src/USER-SPH/fix_meso.cpp
+++ b/src/USER-SPH/fix_meso.cpp
@@ -64,7 +64,7 @@ void FixMeso::init() {
   dtf = 0.5 * update->dt * force->ftm2v;
 }
 
-void FixMeso::setup_pre_force(int vflag)
+void FixMeso::setup_pre_force(int /*vflag*/)
 {
   // set vest equal to v
   double **v = atom->v;
@@ -87,7 +87,7 @@ void FixMeso::setup_pre_force(int vflag)
  allow for both per-type and per-atom mass
  ------------------------------------------------------------------------- */
 
-void FixMeso::initial_integrate(int vflag) {
+void FixMeso::initial_integrate(int /*vflag*/) {
   // update v and x and rho and e of atoms in group
 
   double **x = atom->x;
diff --git a/src/USER-SPH/fix_meso_stationary.cpp b/src/USER-SPH/fix_meso_stationary.cpp
index f5fc306320..29e8a1554c 100644
--- a/src/USER-SPH/fix_meso_stationary.cpp
+++ b/src/USER-SPH/fix_meso_stationary.cpp
@@ -67,7 +67,7 @@ void FixMesoStationary::init() {
  allow for both per-type and per-atom mass
  ------------------------------------------------------------------------- */
 
-void FixMesoStationary::initial_integrate(int vflag) {
+void FixMesoStationary::initial_integrate(int /*vflag*/) {
 
   double *rho = atom->rho;
   double *drho = atom->drho;
diff --git a/src/USER-SPH/pair_sph_heatconduction.cpp b/src/USER-SPH/pair_sph_heatconduction.cpp
index 6f0cf7eca2..4a8990d6fd 100644
--- a/src/USER-SPH/pair_sph_heatconduction.cpp
+++ b/src/USER-SPH/pair_sph_heatconduction.cpp
@@ -155,7 +155,7 @@ void PairSPHHeatConduction::allocate() {
  global settings
  ------------------------------------------------------------------------- */
 
-void PairSPHHeatConduction::settings(int narg, char **arg) {
+void PairSPHHeatConduction::settings(int narg, char **/*arg*/) {
   if (narg != 0)
     error->all(FLERR,
         "Illegal number of setting arguments for pair_style sph/heatconduction");
@@ -211,8 +211,8 @@ double PairSPHHeatConduction::init_one(int i, int j) {
 
 /* ---------------------------------------------------------------------- */
 
-double PairSPHHeatConduction::single(int i, int j, int itype, int jtype,
-    double rsq, double factor_coul, double factor_lj, double &fforce) {
+double PairSPHHeatConduction::single(int /*i*/, int /*j*/, int /*itype*/, int /*jtype*/,
+    double /*rsq*/, double /*factor_coul*/, double /*factor_lj*/, double &fforce) {
   fforce = 0.0;
 
   return 0.0;
diff --git a/src/USER-SPH/pair_sph_idealgas.cpp b/src/USER-SPH/pair_sph_idealgas.cpp
index 99fba05917..32b3e61233 100644
--- a/src/USER-SPH/pair_sph_idealgas.cpp
+++ b/src/USER-SPH/pair_sph_idealgas.cpp
@@ -197,7 +197,7 @@ void PairSPHIdealGas::allocate() {
  global settings
  ------------------------------------------------------------------------- */
 
-void PairSPHIdealGas::settings(int narg, char **arg) {
+void PairSPHIdealGas::settings(int narg, char **/*arg*/) {
   if (narg != 0)
     error->all(FLERR,
         "Illegal number of setting arguments for pair_style sph/idealgas");
@@ -252,8 +252,8 @@ double PairSPHIdealGas::init_one(int i, int j) {
 
 /* ---------------------------------------------------------------------- */
 
-double PairSPHIdealGas::single(int i, int j, int itype, int jtype,
-    double rsq, double factor_coul, double factor_lj, double &fforce) {
+double PairSPHIdealGas::single(int /*i*/, int /*j*/, int /*itype*/, int /*jtype*/,
+    double /*rsq*/, double /*factor_coul*/, double /*factor_lj*/, double &fforce) {
   fforce = 0.0;
 
   return 0.0;
diff --git a/src/USER-SPH/pair_sph_lj.cpp b/src/USER-SPH/pair_sph_lj.cpp
index 5cefdf87c4..c382833baf 100644
--- a/src/USER-SPH/pair_sph_lj.cpp
+++ b/src/USER-SPH/pair_sph_lj.cpp
@@ -204,7 +204,7 @@ void PairSPHLJ::allocate() {
  global settings
  ------------------------------------------------------------------------- */
 
-void PairSPHLJ::settings(int narg, char **arg) {
+void PairSPHLJ::settings(int narg, char **/*arg*/) {
   if (narg != 0)
     error->all(FLERR,
         "Illegal number of setting arguments for pair_style sph/lj");
@@ -261,8 +261,8 @@ double PairSPHLJ::init_one(int i, int j) {
 
 /* ---------------------------------------------------------------------- */
 
-double PairSPHLJ::single(int i, int j, int itype, int jtype,
-    double rsq, double factor_coul, double factor_lj, double &fforce) {
+double PairSPHLJ::single(int /*i*/, int /*j*/, int /*itype*/, int /*jtype*/,
+    double /*rsq*/, double /*factor_coul*/, double /*factor_lj*/, double &fforce) {
   fforce = 0.0;
 
   return 0.0;
diff --git a/src/USER-SPH/pair_sph_rhosum.cpp b/src/USER-SPH/pair_sph_rhosum.cpp
index 605187d3a7..9b5a535288 100644
--- a/src/USER-SPH/pair_sph_rhosum.cpp
+++ b/src/USER-SPH/pair_sph_rhosum.cpp
@@ -278,8 +278,8 @@ double PairSPHRhoSum::init_one(int i, int j) {
 
 /* ---------------------------------------------------------------------- */
 
-double PairSPHRhoSum::single(int i, int j, int itype, int jtype, double rsq,
-    double factor_coul, double factor_lj, double &fforce) {
+double PairSPHRhoSum::single(int /*i*/, int /*j*/, int /*itype*/, int /*jtype*/, double /*rsq*/,
+    double /*factor_coul*/, double /*factor_lj*/, double &fforce) {
   fforce = 0.0;
 
   return 0.0;
@@ -288,7 +288,7 @@ double PairSPHRhoSum::single(int i, int j, int itype, int jtype, double rsq,
 /* ---------------------------------------------------------------------- */
 
 int PairSPHRhoSum::pack_forward_comm(int n, int *list, double *buf,
-                                     int pbc_flag, int *pbc) {
+                                     int /*pbc_flag*/, int */*pbc*/) {
   int i, j, m;
   double *rho = atom->rho;
 
diff --git a/src/USER-SPH/pair_sph_taitwater.cpp b/src/USER-SPH/pair_sph_taitwater.cpp
index 00500b940d..42b318f2c9 100644
--- a/src/USER-SPH/pair_sph_taitwater.cpp
+++ b/src/USER-SPH/pair_sph_taitwater.cpp
@@ -225,7 +225,7 @@ void PairSPHTaitwater::allocate() {
  global settings
  ------------------------------------------------------------------------- */
 
-void PairSPHTaitwater::settings(int narg, char **arg) {
+void PairSPHTaitwater::settings(int narg, char **/*arg*/) {
   if (narg != 0)
     error->all(FLERR,
         "Illegal number of setting arguments for pair_style sph/taitwater");
@@ -293,8 +293,8 @@ double PairSPHTaitwater::init_one(int i, int j) {
 
 /* ---------------------------------------------------------------------- */
 
-double PairSPHTaitwater::single(int i, int j, int itype, int jtype,
-    double rsq, double factor_coul, double factor_lj, double &fforce) {
+double PairSPHTaitwater::single(int /*i*/, int /*j*/, int /*itype*/, int /*jtype*/,
+    double /*rsq*/, double /*factor_coul*/, double /*factor_lj*/, double &fforce) {
   fforce = 0.0;
 
   return 0.0;
diff --git a/src/USER-SPH/pair_sph_taitwater_morris.cpp b/src/USER-SPH/pair_sph_taitwater_morris.cpp
index 80607cb333..8012895af8 100644
--- a/src/USER-SPH/pair_sph_taitwater_morris.cpp
+++ b/src/USER-SPH/pair_sph_taitwater_morris.cpp
@@ -225,7 +225,7 @@ void PairSPHTaitwaterMorris::allocate() {
  global settings
  ------------------------------------------------------------------------- */
 
-void PairSPHTaitwaterMorris::settings(int narg, char **arg) {
+void PairSPHTaitwaterMorris::settings(int narg, char **/*arg*/) {
   if (narg != 0)
     error->all(FLERR,
         "Illegal number of setting arguments for pair_style sph/taitwater/morris");
@@ -289,8 +289,8 @@ double PairSPHTaitwaterMorris::init_one(int i, int j) {
 
 /* ---------------------------------------------------------------------- */
 
-double PairSPHTaitwaterMorris::single(int i, int j, int itype, int jtype,
-    double rsq, double factor_coul, double factor_lj, double &fforce) {
+double PairSPHTaitwaterMorris::single(int /*i*/, int /*j*/, int /*itype*/, int /*jtype*/,
+    double /*rsq*/, double /*factor_coul*/, double /*factor_lj*/, double &fforce) {
   fforce = 0.0;
 
   return 0.0;
diff --git a/src/USER-UEF/fix_nh_uef.cpp b/src/USER-UEF/fix_nh_uef.cpp
index bfa4549286..bffcd7849f 100644
--- a/src/USER-UEF/fix_nh_uef.cpp
+++ b/src/USER-UEF/fix_nh_uef.cpp
@@ -348,7 +348,7 @@ void FixNHUef::final_integrate()
  * at outer level: call this->final_integrate()
  * at other levels: rotate -> 2nd verlet step -> rotate back
  * ---------------------------------------------------------------------- */
-void FixNHUef::final_integrate_respa(int ilevel, int iloop)
+void FixNHUef::final_integrate_respa(int ilevel, int /*iloop*/)
 {
   // set timesteps by level
   dtf = 0.5 * step_respa[ilevel] * force->ftm2v;
-- 
GitLab