silence more compiler warnings
This commit is contained in:
@ -195,7 +195,7 @@ void PairBornCoulMSM::compute(int eflag, int vflag)
|
|||||||
|
|
||||||
if (force->kspace->scalar_pressure_flag && vflag) {
|
if (force->kspace->scalar_pressure_flag && vflag) {
|
||||||
for (i = 0; i < 3; i++) virial[i] += force->pair->eng_coul/3.0;
|
for (i = 0; i < 3; i++) virial[i] += force->pair->eng_coul/3.0;
|
||||||
for (int i = 0; i < nmax; i++) {
|
for (i = 0; i < nmax; i++) {
|
||||||
f[i][0] += ftmp[i][0];
|
f[i][0] += ftmp[i][0];
|
||||||
f[i][1] += ftmp[i][1];
|
f[i][1] += ftmp[i][1];
|
||||||
f[i][2] += ftmp[i][2];
|
f[i][2] += ftmp[i][2];
|
||||||
|
|||||||
@ -305,7 +305,7 @@ void ComputeCoordAtom::compute_peratom()
|
|||||||
rsq = delx*delx + dely*dely + delz*delz;
|
rsq = delx*delx + dely*dely + delz*delz;
|
||||||
if (rsq < cutsq) {
|
if (rsq < cutsq) {
|
||||||
double dot_product = 0.0;
|
double dot_product = 0.0;
|
||||||
for (int m=0; m < 2*(2*l+1); m++) {
|
for (m=0; m < 2*(2*l+1); m++) {
|
||||||
dot_product += normv[i][nqlist+m]*normv[j][nqlist+m];
|
dot_product += normv[i][nqlist+m]*normv[j][nqlist+m];
|
||||||
}
|
}
|
||||||
if (dot_product > threshold) n++;
|
if (dot_product > threshold) n++;
|
||||||
|
|||||||
@ -139,7 +139,7 @@ void ComputeGyrationChunk::compute_vector()
|
|||||||
|
|
||||||
MPI_Allreduce(rg,rgall,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
MPI_Allreduce(rg,rgall,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++)
|
for (i = 0; i < nchunk; i++)
|
||||||
if (masstotal[i] > 0.0)
|
if (masstotal[i] > 0.0)
|
||||||
rgall[i] = sqrt(rgall[i]/masstotal[i]);
|
rgall[i] = sqrt(rgall[i]/masstotal[i]);
|
||||||
}
|
}
|
||||||
|
|||||||
@ -101,7 +101,7 @@ void ComputeInertiaChunk::compute_array()
|
|||||||
|
|
||||||
// zero local per-chunk values
|
// zero local per-chunk values
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
massproc[i] = 0.0;
|
massproc[i] = 0.0;
|
||||||
com[i][0] = com[i][1] = com[i][2] = 0.0;
|
com[i][0] = com[i][1] = com[i][2] = 0.0;
|
||||||
for (j = 0; j < 6; j++) inertia[i][j] = 0.0;
|
for (j = 0; j < 6; j++) inertia[i][j] = 0.0;
|
||||||
@ -117,7 +117,7 @@ void ComputeInertiaChunk::compute_array()
|
|||||||
double *rmass = atom->rmass;
|
double *rmass = atom->rmass;
|
||||||
int nlocal = atom->nlocal;
|
int nlocal = atom->nlocal;
|
||||||
|
|
||||||
for (int i = 0; i < nlocal; i++)
|
for (i = 0; i < nlocal; i++)
|
||||||
if (mask[i] & groupbit) {
|
if (mask[i] & groupbit) {
|
||||||
index = ichunk[i]-1;
|
index = ichunk[i]-1;
|
||||||
if (index < 0) continue;
|
if (index < 0) continue;
|
||||||
@ -133,7 +133,7 @@ void ComputeInertiaChunk::compute_array()
|
|||||||
MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
||||||
MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world);
|
MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world);
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
if (masstotal[i] > 0.0) {
|
if (masstotal[i] > 0.0) {
|
||||||
comall[i][0] /= masstotal[i];
|
comall[i][0] /= masstotal[i];
|
||||||
comall[i][1] /= masstotal[i];
|
comall[i][1] /= masstotal[i];
|
||||||
|
|||||||
@ -108,7 +108,7 @@ void ComputeOmegaChunk::compute_array()
|
|||||||
|
|
||||||
// zero local per-chunk values
|
// zero local per-chunk values
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
massproc[i] = 0.0;
|
massproc[i] = 0.0;
|
||||||
com[i][0] = com[i][1] = com[i][2] = 0.0;
|
com[i][0] = com[i][1] = com[i][2] = 0.0;
|
||||||
for (j = 0; j < 6; j++) inertia[i][j] = 0.0;
|
for (j = 0; j < 6; j++) inertia[i][j] = 0.0;
|
||||||
@ -126,7 +126,7 @@ void ComputeOmegaChunk::compute_array()
|
|||||||
double *rmass = atom->rmass;
|
double *rmass = atom->rmass;
|
||||||
int nlocal = atom->nlocal;
|
int nlocal = atom->nlocal;
|
||||||
|
|
||||||
for (int i = 0; i < nlocal; i++)
|
for (i = 0; i < nlocal; i++)
|
||||||
if (mask[i] & groupbit) {
|
if (mask[i] & groupbit) {
|
||||||
index = ichunk[i]-1;
|
index = ichunk[i]-1;
|
||||||
if (index < 0) continue;
|
if (index < 0) continue;
|
||||||
@ -142,7 +142,7 @@ void ComputeOmegaChunk::compute_array()
|
|||||||
MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
||||||
MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world);
|
MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world);
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
if (masstotal[i] > 0.0) {
|
if (masstotal[i] > 0.0) {
|
||||||
comall[i][0] /= masstotal[i];
|
comall[i][0] /= masstotal[i];
|
||||||
comall[i][1] /= masstotal[i];
|
comall[i][1] /= masstotal[i];
|
||||||
|
|||||||
@ -308,7 +308,7 @@ void ComputeOrientOrderAtom::compute_peratom()
|
|||||||
// if not nnn neighbors, order parameter = 0;
|
// if not nnn neighbors, order parameter = 0;
|
||||||
|
|
||||||
if ((ncount == 0) || (ncount < nnn)) {
|
if ((ncount == 0) || (ncount < nnn)) {
|
||||||
for (int jj = 0; jj < ncol; jj++)
|
for (jj = 0; jj < ncol; jj++)
|
||||||
qn[jj] = 0.0;
|
qn[jj] = 0.0;
|
||||||
continue;
|
continue;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -438,7 +438,7 @@ void ComputeTempChunk::vcm_compute()
|
|||||||
|
|
||||||
int *ichunk = cchunk->ichunk;
|
int *ichunk = cchunk->ichunk;
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
vcm[i][0] = vcm[i][1] = vcm[i][2] = 0.0;
|
vcm[i][0] = vcm[i][1] = vcm[i][2] = 0.0;
|
||||||
massproc[i] = 0.0;
|
massproc[i] = 0.0;
|
||||||
}
|
}
|
||||||
@ -487,7 +487,7 @@ void ComputeTempChunk::temperature(int icol)
|
|||||||
|
|
||||||
// zero local per-chunk values
|
// zero local per-chunk values
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
count[i] = 0;
|
count[i] = 0;
|
||||||
sum[i] = 0.0;
|
sum[i] = 0.0;
|
||||||
}
|
}
|
||||||
@ -560,7 +560,7 @@ void ComputeTempChunk::temperature(int icol)
|
|||||||
double mvv2e = force->mvv2e;
|
double mvv2e = force->mvv2e;
|
||||||
double boltz = force->boltz;
|
double boltz = force->boltz;
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
dof = cdof + adof*countall[i];
|
dof = cdof + adof*countall[i];
|
||||||
if (dof > 0.0) tfactor = mvv2e / (dof * boltz);
|
if (dof > 0.0) tfactor = mvv2e / (dof * boltz);
|
||||||
else tfactor = 0.0;
|
else tfactor = 0.0;
|
||||||
|
|||||||
@ -313,7 +313,7 @@ void ComputeTempProfile::compute_array()
|
|||||||
|
|
||||||
for (i = 0; i < nbins; i++) tbin[i] = 0.0;
|
for (i = 0; i < nbins; i++) tbin[i] = 0.0;
|
||||||
|
|
||||||
for (int i = 0; i < nlocal; i++)
|
for (i = 0; i < nlocal; i++)
|
||||||
if (mask[i] & groupbit) {
|
if (mask[i] & groupbit) {
|
||||||
ibin = bin[i];
|
ibin = bin[i];
|
||||||
if (xflag) vthermal[0] = v[i][0] - binave[ibin][ivx];
|
if (xflag) vthermal[0] = v[i][0] - binave[ibin][ivx];
|
||||||
|
|||||||
@ -100,7 +100,7 @@ void ComputeTorqueChunk::compute_array()
|
|||||||
|
|
||||||
// zero local per-chunk values
|
// zero local per-chunk values
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
massproc[i] = 0.0;
|
massproc[i] = 0.0;
|
||||||
com[i][0] = com[i][1] = com[i][2] = 0.0;
|
com[i][0] = com[i][1] = com[i][2] = 0.0;
|
||||||
torque[i][0] = torque[i][1] = torque[i][2] = 0.0;
|
torque[i][0] = torque[i][1] = torque[i][2] = 0.0;
|
||||||
@ -116,7 +116,7 @@ void ComputeTorqueChunk::compute_array()
|
|||||||
double *rmass = atom->rmass;
|
double *rmass = atom->rmass;
|
||||||
int nlocal = atom->nlocal;
|
int nlocal = atom->nlocal;
|
||||||
|
|
||||||
for (int i = 0; i < nlocal; i++)
|
for (i = 0; i < nlocal; i++)
|
||||||
if (mask[i] & groupbit) {
|
if (mask[i] & groupbit) {
|
||||||
index = ichunk[i]-1;
|
index = ichunk[i]-1;
|
||||||
if (index < 0) continue;
|
if (index < 0) continue;
|
||||||
@ -132,7 +132,7 @@ void ComputeTorqueChunk::compute_array()
|
|||||||
MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world);
|
||||||
MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world);
|
MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world);
|
||||||
|
|
||||||
for (int i = 0; i < nchunk; i++) {
|
for (i = 0; i < nchunk; i++) {
|
||||||
if (masstotal[i] > 0.0) {
|
if (masstotal[i] > 0.0) {
|
||||||
comall[i][0] /= masstotal[i];
|
comall[i][0] /= masstotal[i];
|
||||||
comall[i][1] /= masstotal[i];
|
comall[i][1] /= masstotal[i];
|
||||||
|
|||||||
@ -891,7 +891,6 @@ int Irregular::create_data_grouped(int n, int *procs, int sortflag)
|
|||||||
utils::merge_sort(order,nrecv_proc,(void *)proc_recv,compare_standalone);
|
utils::merge_sort(order,nrecv_proc,(void *)proc_recv,compare_standalone);
|
||||||
#endif
|
#endif
|
||||||
|
|
||||||
int j;
|
|
||||||
for (i = 0; i < nrecv_proc; i++) {
|
for (i = 0; i < nrecv_proc; i++) {
|
||||||
j = order[i];
|
j = order[i];
|
||||||
proc_recv_ordered[i] = proc_recv[j];
|
proc_recv_ordered[i] = proc_recv[j];
|
||||||
|
|||||||
Reference in New Issue
Block a user