From d1980031efbb2a8b73ca5ca75596b5b4c314e445 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 25 Jun 2023 06:02:17 -0400 Subject: [PATCH] remove more duplicate semicolons --- src/BODY/pair_body_rounded_polyhedron.cpp | 2 +- src/CG-DNA/bond_oxdna_fene.cpp | 2 +- src/CG-DNA/pair_oxdna2_coaxstk.cpp | 2 +- src/CG-DNA/pair_oxdna2_dh.cpp | 2 +- src/CG-DNA/pair_oxdna_coaxstk.cpp | 2 +- src/CG-DNA/pair_oxdna_xstk.cpp | 2 +- src/CG-DNA/pair_oxrna2_xstk.cpp | 2 +- src/EXTRA-COMPUTE/compute_adf.cpp | 2 +- src/EXTRA-DUMP/dump_xtc.cpp | 2 +- src/EXTRA-FIX/fix_wall_ees.cpp | 2 +- src/INTEL/npair_full_bin_intel.cpp | 2 +- src/INTEL/pppm_disp_intel.cpp | 2 +- src/KOKKOS/atom_vec_dpd_kokkos.cpp | 12 ++++++------ src/KOKKOS/dihedral_harmonic_kokkos.cpp | 6 +++--- src/KOKKOS/fix_wall_gran_old.cpp | 2 +- src/KSPACE/ewald.cpp | 2 +- src/KSPACE/pair_lj_charmmfsw_coul_long.cpp | 6 +++--- src/KSPACE/pppm.cpp | 2 +- src/KSPACE/pppm_disp.cpp | 2 +- src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp | 4 ++-- src/RIGID/fix_shake.cpp | 2 +- src/SMTBQ/pair_smtbq.cpp | 2 +- src/SPIN/min_spin_lbfgs.cpp | 2 +- src/fix_ave_grid.cpp | 2 +- src/input.cpp | 2 +- src/special.cpp | 2 +- 26 files changed, 36 insertions(+), 36 deletions(-) diff --git a/src/BODY/pair_body_rounded_polyhedron.cpp b/src/BODY/pair_body_rounded_polyhedron.cpp index d9a79abad0..9425707ef1 100644 --- a/src/BODY/pair_body_rounded_polyhedron.cpp +++ b/src/BODY/pair_body_rounded_polyhedron.cpp @@ -1910,7 +1910,7 @@ void PairBodyRoundedPolyhedron::inside_polygon(int ibody, int face_index, iffirst = facfirst[ibody]; rradi = rounded_radius[ibody]; double rradsq = rradi*rradi; - anglesum1 = anglesum2 = 0;; + anglesum1 = anglesum2 = 0; for (i = 0; i < MAX_FACE_SIZE; i++) { npi1 = static_cast(face[iffirst+face_index][i]); if (npi1 < 0) break; diff --git a/src/CG-DNA/bond_oxdna_fene.cpp b/src/CG-DNA/bond_oxdna_fene.cpp index 2d471cbbe6..780b71e44c 100644 --- a/src/CG-DNA/bond_oxdna_fene.cpp +++ b/src/CG-DNA/bond_oxdna_fene.cpp @@ -146,7 +146,7 @@ void BondOxdnaFene::ev_tally_xyz(int i, int j, int nlocal, int newton_bond, doub void BondOxdnaFene::compute(int eflag, int vflag) { int a, b, in, type; - double delf[3], delta[3], deltb[3]; // force, torque increment;; + double delf[3], delta[3], deltb[3]; // force, torque increment double delr[3], ebond, fbond; double rsq, Deltasq, rlogarg; double r, rr0, rr0sq; diff --git a/src/CG-DNA/pair_oxdna2_coaxstk.cpp b/src/CG-DNA/pair_oxdna2_coaxstk.cpp index 844ba56577..527020076c 100644 --- a/src/CG-DNA/pair_oxdna2_coaxstk.cpp +++ b/src/CG-DNA/pair_oxdna2_coaxstk.cpp @@ -612,7 +612,7 @@ void PairOxdna2Coaxstk::coeff(int narg, char **arg) (0.5 * (cut_cxst_lo_one - cut_cxst_0_one) * (cut_cxst_lo_one - cut_cxst_0_one) - k_cxst_one * 0.5 * (cut_cxst_0_one -cut_cxst_c_one) * (cut_cxst_0_one - cut_cxst_c_one)/k_cxst_one); - cut_cxst_lc_one = cut_cxst_lo_one - 0.5 * (cut_cxst_lo_one - cut_cxst_0_one)/b_cxst_lo_one;; + cut_cxst_lc_one = cut_cxst_lo_one - 0.5 * (cut_cxst_lo_one - cut_cxst_0_one)/b_cxst_lo_one; b_cxst_hi_one = 0.25 * (cut_cxst_hi_one - cut_cxst_0_one) * (cut_cxst_hi_one - cut_cxst_0_one)/ (0.5 * (cut_cxst_hi_one - cut_cxst_0_one) * (cut_cxst_hi_one - cut_cxst_0_one) - diff --git a/src/CG-DNA/pair_oxdna2_dh.cpp b/src/CG-DNA/pair_oxdna2_dh.cpp index dcfe3f9ea1..a8114c84d7 100644 --- a/src/CG-DNA/pair_oxdna2_dh.cpp +++ b/src/CG-DNA/pair_oxdna2_dh.cpp @@ -79,7 +79,7 @@ void PairOxdna2Dh::compute_interaction_sites(double e1[3], void PairOxdna2Dh::compute(int eflag, int vflag) { - double delf[3],delta[3],deltb[3]; // force, torque increment;; + double delf[3],delta[3],deltb[3]; // force, torque increment double rtmp_s[3],delr[3]; double evdwl,fpair,factor_lj; double r,rsq,rinv; diff --git a/src/CG-DNA/pair_oxdna_coaxstk.cpp b/src/CG-DNA/pair_oxdna_coaxstk.cpp index b9b34338fe..679bfbf18d 100644 --- a/src/CG-DNA/pair_oxdna_coaxstk.cpp +++ b/src/CG-DNA/pair_oxdna_coaxstk.cpp @@ -749,7 +749,7 @@ void PairOxdnaCoaxstk::coeff(int narg, char **arg) (0.5 * (cut_cxst_lo_one - cut_cxst_0_one) * (cut_cxst_lo_one - cut_cxst_0_one) - k_cxst_one * 0.5 * (cut_cxst_0_one -cut_cxst_c_one) * (cut_cxst_0_one - cut_cxst_c_one)/k_cxst_one); - cut_cxst_lc_one = cut_cxst_lo_one - 0.5 * (cut_cxst_lo_one - cut_cxst_0_one)/b_cxst_lo_one;; + cut_cxst_lc_one = cut_cxst_lo_one - 0.5 * (cut_cxst_lo_one - cut_cxst_0_one)/b_cxst_lo_one; b_cxst_hi_one = 0.25 * (cut_cxst_hi_one - cut_cxst_0_one) * (cut_cxst_hi_one - cut_cxst_0_one)/ (0.5 * (cut_cxst_hi_one - cut_cxst_0_one) * (cut_cxst_hi_one - cut_cxst_0_one) - diff --git a/src/CG-DNA/pair_oxdna_xstk.cpp b/src/CG-DNA/pair_oxdna_xstk.cpp index d95004f537..6ef6091889 100644 --- a/src/CG-DNA/pair_oxdna_xstk.cpp +++ b/src/CG-DNA/pair_oxdna_xstk.cpp @@ -696,7 +696,7 @@ void PairOxdnaXstk::coeff(int narg, char **arg) (0.5 * (cut_xst_lo_one - cut_xst_0_one) * (cut_xst_lo_one - cut_xst_0_one) - k_xst_one * 0.5 * (cut_xst_0_one -cut_xst_c_one) * (cut_xst_0_one - cut_xst_c_one)/k_xst_one); - cut_xst_lc_one = cut_xst_lo_one - 0.5 * (cut_xst_lo_one - cut_xst_0_one)/b_xst_lo_one;; + cut_xst_lc_one = cut_xst_lo_one - 0.5 * (cut_xst_lo_one - cut_xst_0_one)/b_xst_lo_one; b_xst_hi_one = 0.25 * (cut_xst_hi_one - cut_xst_0_one) * (cut_xst_hi_one - cut_xst_0_one)/ (0.5 * (cut_xst_hi_one - cut_xst_0_one) * (cut_xst_hi_one - cut_xst_0_one) - diff --git a/src/CG-DNA/pair_oxrna2_xstk.cpp b/src/CG-DNA/pair_oxrna2_xstk.cpp index cdba56e33a..e28b6573bf 100644 --- a/src/CG-DNA/pair_oxrna2_xstk.cpp +++ b/src/CG-DNA/pair_oxrna2_xstk.cpp @@ -639,7 +639,7 @@ void PairOxrna2Xstk::coeff(int narg, char **arg) (0.5 * (cut_xst_lo_one - cut_xst_0_one) * (cut_xst_lo_one - cut_xst_0_one) - k_xst_one * 0.5 * (cut_xst_0_one -cut_xst_c_one) * (cut_xst_0_one - cut_xst_c_one)/k_xst_one); - cut_xst_lc_one = cut_xst_lo_one - 0.5 * (cut_xst_lo_one - cut_xst_0_one)/b_xst_lo_one;; + cut_xst_lc_one = cut_xst_lo_one - 0.5 * (cut_xst_lo_one - cut_xst_0_one)/b_xst_lo_one; b_xst_hi_one = 0.25 * (cut_xst_hi_one - cut_xst_0_one) * (cut_xst_hi_one - cut_xst_0_one)/ (0.5 * (cut_xst_hi_one - cut_xst_0_one) * (cut_xst_hi_one - cut_xst_0_one) - diff --git a/src/EXTRA-COMPUTE/compute_adf.cpp b/src/EXTRA-COMPUTE/compute_adf.cpp index fc74cb8037..35ff8bfd33 100644 --- a/src/EXTRA-COMPUTE/compute_adf.cpp +++ b/src/EXTRA-COMPUTE/compute_adf.cpp @@ -288,7 +288,7 @@ void ComputeADF::init() rcutinnerk[0] = 0.0; rcutouterj[0] = force->pair->cutforce; rcutouterk[0] = force->pair->cutforce; - maxouter = force->pair->cutforce;; + maxouter = force->pair->cutforce; } else { for (int m = 0; m < ntriples; m++) { maxouter = MAX(rcutouterj[m],maxouter); diff --git a/src/EXTRA-DUMP/dump_xtc.cpp b/src/EXTRA-DUMP/dump_xtc.cpp index 6b0b97181b..ba3f740cf7 100644 --- a/src/EXTRA-DUMP/dump_xtc.cpp +++ b/src/EXTRA-DUMP/dump_xtc.cpp @@ -1046,7 +1046,7 @@ int xdr3dfcoord(XDR *xdrs, float *fp, int *size, float *precision) sizesmall[0] = sizesmall[1] = sizesmall[2] = magicints[smallidx]; } } - if (buf[1] != 0) buf[0]++;; + if (buf[1] != 0) buf[0]++; xdr_int(xdrs, &(buf[0])); /* buf[0] holds the length in bytes */ return errval * (xdr_opaque(xdrs, (caddr_t)&(buf[3]), (u_int)buf[0])); } else { diff --git a/src/EXTRA-FIX/fix_wall_ees.cpp b/src/EXTRA-FIX/fix_wall_ees.cpp index 230b8f6ac0..0e4d5aa1eb 100644 --- a/src/EXTRA-FIX/fix_wall_ees.cpp +++ b/src/EXTRA-FIX/fix_wall_ees.cpp @@ -116,7 +116,7 @@ void FixWallEES::wall_particle(int m, int which, double coord) nhat[(dim+2)%3] = 0 ; - double* shape = bonus[ellipsoid[i]].shape;; + double* shape = bonus[ellipsoid[i]].shape; MathExtra::quat_to_mat(bonus[ellipsoid[i]].quat,A); MathExtra::transpose_matvec(A,nhat,tempvec); for (int k = 0; k<3; k++) { diff --git a/src/INTEL/npair_full_bin_intel.cpp b/src/INTEL/npair_full_bin_intel.cpp index 2f8af4c8af..285ed35ec9 100644 --- a/src/INTEL/npair_full_bin_intel.cpp +++ b/src/INTEL/npair_full_bin_intel.cpp @@ -62,7 +62,7 @@ fbi(NeighList *list, IntelBuffers *buffers) { list->inum = nlocal; list->gnum = 0; - int host_start = _fix->host_start_neighbor();; + int host_start = _fix->host_start_neighbor(); const int off_end = _fix->offload_end_neighbor(); #ifdef _LMP_INTEL_OFFLOAD diff --git a/src/INTEL/pppm_disp_intel.cpp b/src/INTEL/pppm_disp_intel.cpp index cc4aa6ab93..6dac9fad99 100644 --- a/src/INTEL/pppm_disp_intel.cpp +++ b/src/INTEL/pppm_disp_intel.cpp @@ -1478,7 +1478,7 @@ void PPPMDispIntel::fieldforce_c_ik(IntelBuffers * /*buffers*/) int nxsum = nx + nlower; int nysum = ny + nlower; - int nzsum = nz + nlower;; + int nzsum = nz + nlower; FFT_SCALAR dx = nx+fshiftone - (x[i][0]-lo0)*xi; FFT_SCALAR dy = ny+fshiftone - (x[i][1]-lo1)*yi; diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index eda26a92dc..a8ce29f666 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -116,22 +116,22 @@ void AtomVecDPDKokkos::grow_pointers() d_dpdTheta = atomKK->k_dpdTheta.d_view; h_dpdTheta = atomKK->k_dpdTheta.h_view; uCond = atomKK->uCond; - d_uCond = atomKK->k_uCond.d_view;; + d_uCond = atomKK->k_uCond.d_view; h_uCond = atomKK->k_uCond.h_view; uMech = atomKK->uMech; - d_uMech = atomKK->k_uMech.d_view;; + d_uMech = atomKK->k_uMech.d_view; h_uMech = atomKK->k_uMech.h_view; uChem = atomKK->uChem; - d_uChem = atomKK->k_uChem.d_view;; + d_uChem = atomKK->k_uChem.d_view; h_uChem = atomKK->k_uChem.h_view; uCG = atomKK->uCG; - d_uCG = atomKK->k_uCG.d_view;; + d_uCG = atomKK->k_uCG.d_view; h_uCG = atomKK->k_uCG.h_view; uCGnew = atomKK->uCGnew; - d_uCGnew = atomKK->k_uCGnew.d_view;; + d_uCGnew = atomKK->k_uCGnew.d_view; h_uCGnew = atomKK->k_uCGnew.h_view; duChem = atomKK->duChem; - d_duChem = atomKK->k_duChem.d_view;; + d_duChem = atomKK->k_duChem.d_view; h_duChem = atomKK->k_duChem.h_view; } diff --git a/src/KOKKOS/dihedral_harmonic_kokkos.cpp b/src/KOKKOS/dihedral_harmonic_kokkos.cpp index 96287946ea..8ca0b368df 100644 --- a/src/KOKKOS/dihedral_harmonic_kokkos.cpp +++ b/src/KOKKOS/dihedral_harmonic_kokkos.cpp @@ -265,9 +265,9 @@ void DihedralHarmonicKokkos::operator()(TagDihedralHarmonicComputenspecial[iatom][0]; for (j = 0; j < npartner[i]; j++) - partner_tag[i][j] = atommols[imol]->special[iatom][j] + tagprev;; + partner_tag[i][j] = atommols[imol]->special[iatom][j] + tagprev; } } diff --git a/src/SMTBQ/pair_smtbq.cpp b/src/SMTBQ/pair_smtbq.cpp index 15e5c2da5e..fdef0b6043 100644 --- a/src/SMTBQ/pair_smtbq.cpp +++ b/src/SMTBQ/pair_smtbq.cpp @@ -204,7 +204,7 @@ PairSMTBQ::~PairSMTBQ() memory->destroy(potcov); memory->destroy(nvsm); - memory->destroy(vsm);; + memory->destroy(vsm); memory->destroy(flag_QEq); memory->destroy(nQEqall); diff --git a/src/SPIN/min_spin_lbfgs.cpp b/src/SPIN/min_spin_lbfgs.cpp index c9c84239b6..ae9d33a705 100644 --- a/src/SPIN/min_spin_lbfgs.cpp +++ b/src/SPIN/min_spin_lbfgs.cpp @@ -378,7 +378,7 @@ void MinSpinLBFGS::calc_search_direction() scaling = maximum_rotation(g_cur); for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i] * factor * scaling;; + p_s[i] = -g_cur[i] * factor * scaling; g_old[i] = g_cur[i] * factor; for (int k = 0; k < num_mem; k++) { ds[k][i] = 0.0; diff --git a/src/fix_ave_grid.cpp b/src/fix_ave_grid.cpp index 524def73a4..039c656fab 100644 --- a/src/fix_ave_grid.cpp +++ b/src/fix_ave_grid.cpp @@ -931,7 +931,7 @@ void FixAveGrid::atom2grid() vsq = v[i][0]*v[i][0] + v[i][1]*v[i][1] + v[i][2]*v[i][2]; if (rmass) one = rmass[i]; else one = mass[type[i]]; - array2d[bin[i][0]][bin[i][1]][m] += one*vsq;; + array2d[bin[i][0]][bin[i][1]][m] += one*vsq; } } } else { diff --git a/src/input.cpp b/src/input.cpp index 1dc2b00ebc..dbbc62df59 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -567,7 +567,7 @@ void Input::substitute(char *&str, char *&str2, int &max, int &max2, int flag) // else $x becomes x followed by null char // beyond = points to text following variable - int i,n,paren_count,nchars;; + int i,n,paren_count,nchars; char immediate[256]; char *var,*value,*beyond; int quoteflag = 0; diff --git a/src/special.cpp b/src/special.cpp index a210b6a82a..7e15ec9e80 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -958,7 +958,7 @@ void Special::combine() void Special::angle_trim() { - int i,j,k,m;; + int i,j,k,m; int *num_angle = atom->num_angle; int *num_dihedral = atom->num_dihedral;