[cig-commits] [commit] rajesh-petsc-schur: further cleanup, with all occurences of CPPR having been removed (ec09457)

cig_noreply at geodynamics.org cig_noreply at geodynamics.org
Wed Nov 5 19:14:50 PST 2014


Repository : https://github.com/geodynamics/citcoms

On branch  : rajesh-petsc-schur
Link       : https://github.com/geodynamics/citcoms/compare/464e1b32299b15819f93efd98d969cddb84dfe51...f97ae655a50bdbd6dac1923a3471ee4dae178fbd

>---------------------------------------------------------------

commit ec0945705eef4b24081ed7ef0f52224d56e1b34c
Author: Rajesh Kommu <rajesh.kommu at gmail.com>
Date:   Thu Sep 25 15:08:23 2014 -0700

    further cleanup, with all occurences of CPPR having been removed


>---------------------------------------------------------------

ec0945705eef4b24081ed7ef0f52224d56e1b34c
 lib/Initial_temperature.c          |  2 +-
 lib/Output.c                       | 28 ++++++++++++++--------------
 lib/Output_gzdir.c                 | 26 +++++++++++++-------------
 lib/Output_vtk.c                   | 20 ++++++++++----------
 lib/Phase_change.c                 |  2 +-
 lib/Regional_boundary_conditions.c |  2 +-
 lib/Regional_parallel_related.c    | 10 +++++-----
 lib/Regional_tracer_advection.c    |  2 +-
 lib/Regional_version_dependent.c   |  6 +++---
 lib/Size_does_matter.c             |  4 ++--
 lib/global_defs.h                  |  3 ---
 11 files changed, 51 insertions(+), 54 deletions(-)

diff --git a/lib/Initial_temperature.c b/lib/Initial_temperature.c
index 0eda049..1e8e21c 100644
--- a/lib/Initial_temperature.c
+++ b/lib/Initial_temperature.c
@@ -243,7 +243,7 @@ static void debug_tic(struct All_variables *E)
   int m, j;
 
   fprintf(E->fp_out,"output_temperature\n");
-    fprintf(E->fp_out,"for cap %d\n",E->sphere.capid[CPPR]);
+    fprintf(E->fp_out,"for cap %d\n",E->sphere.capid[1]);
     for (j=1;j<=E->lmesh.nno;j++)
       fprintf(E->fp_out,"X = %.6e Z = %.6e Y = %.6e T[%06d] = %.6e \n",E->sx[1][j],E->sx[2][j],E->sx[3][j],j,E->T[j]);
   fflush(E->fp_out);
diff --git a/lib/Output.c b/lib/Output.c
index c8661b7..2a23326 100644
--- a/lib/Output.c
+++ b/lib/Output.c
@@ -194,7 +194,7 @@ void output_coord(struct All_variables *E)
   sprintf(output_file,"%s.coord.%d",E->control.data_file,E->parallel.me);
   fp1 = output_open(output_file, "w");
 
-  fprintf(fp1,"%3d %7d\n",CPPR,E->lmesh.nno);
+  fprintf(fp1,"%7d\n",E->lmesh.nno);
   for(i=1;i<=E->lmesh.nno;i++)
     fprintf(fp1,"%.6e %.6e %.6e\n",E->sx[1][i],E->sx[2][i],E->sx[3][i]);
   fclose(fp1);
@@ -209,7 +209,7 @@ void output_domain(struct All_variables *E)
 
     /* Note: rank-0 writes the domain bounds of all processors */
 
-    const int j = CPPR;
+    const int j = 1;
     const int tag = 0;
     const int receiver = 0;
     const int nox = E->lmesh.nox;
@@ -310,7 +310,7 @@ void output_visc(struct All_variables *E, int cycles)
   fp1 = output_open(output_file, "w");
 
 
-  fprintf(fp1,"%3d %7d\n",CPPR,E->lmesh.nno);
+  fprintf(fp1,"%7d\n",E->lmesh.nno);
   for(i=1;i<=E->lmesh.nno;i++)
     fprintf(fp1,"%.4e\n",E->VI[lev][i]);
   fclose(fp1);
@@ -327,7 +327,7 @@ void output_avisc(struct All_variables *E, int cycles)
     sprintf(output_file,"%s.avisc.%d.%d", E->control.data_file,
 	    E->parallel.me, cycles);
     fp1 = output_open(output_file, "w");
-    fprintf(fp1,"%3d %7d\n",CPPR,E->lmesh.nno);
+    fprintf(fp1,"%7d\n",E->lmesh.nno);
     for(i=1;i<=E->lmesh.nno;i++)
       fprintf(fp1,"%.4e %.4e %.4e %.4e\n",
           E->VI2[lev][i],E->VIn1[lev][i],E->VIn2[lev][i],E->VIn3[lev][i]);
@@ -349,7 +349,7 @@ void output_velo(struct All_variables *E, int cycles)
 
   fprintf(fp1,"%d %d %.5e\n",cycles,E->lmesh.nno,E->monitor.elapsed_time);
 
-  fprintf(fp1,"%3d %7d\n",CPPR,E->lmesh.nno);
+  fprintf(fp1,"%7d\n",E->lmesh.nno);
   for(i=1;i<=E->lmesh.nno;i++) {
       fprintf(fp1,"%.6e %.6e %.6e %.6e\n",E->sphere.cap[1].V[1][i],E->sphere.cap[1].V[2][i],E->sphere.cap[1].V[3][i],E->T[i]);
   }
@@ -388,7 +388,7 @@ void output_surf_botm(struct All_variables *E, int cycles)
         else
             topo = E->slice.tpg;
 
-        fprintf(fp2,"%3d %7d\n",CPPR,E->lmesh.nsf);
+        fprintf(fp2,"%7d\n",E->lmesh.nsf);
         for(i=1;i<=E->lmesh.nsf;i++)   {
             s = i*E->lmesh.noz;
             fprintf(fp2,"%.4e %.4e %.4e %.4e\n",
@@ -403,7 +403,7 @@ void output_surf_botm(struct All_variables *E, int cycles)
             E->parallel.me, cycles);
     fp2 = output_open(output_file, "w");
 
-      fprintf(fp2,"%3d %7d\n",CPPR,E->lmesh.nsf);
+      fprintf(fp2,"%7d\n",E->lmesh.nsf);
       for(i=1;i<=E->lmesh.nsf;i++)  {
         s = (i-1)*E->lmesh.noz + 1;
         fprintf(fp2,"%.4e %.4e %.4e %.4e\n",
@@ -477,7 +477,7 @@ void output_stress(struct All_variables *E, int cycles)
 
   fprintf(fp1,"%d %d %.5e\n",cycles,E->lmesh.nno,E->monitor.elapsed_time);
 
-    fprintf(fp1,"%3d %7d\n",CPPR,E->lmesh.nno);
+    fprintf(fp1,"%7d\n",E->lmesh.nno);
     /* those are sorted like stt spp srr stp str srp  */
     for (node=1;node<=E->lmesh.nno;node++)
       fprintf(fp1, "%.4e %.4e %.4e %.4e %.4e %.4e\n",
@@ -614,7 +614,7 @@ void output_pressure(struct All_variables *E, int cycles)
 
   fprintf(fp1,"%d %d %.5e\n",cycles,E->lmesh.nno,E->monitor.elapsed_time);
 
-  fprintf(fp1,"%3d %7d\n",CPPR,E->lmesh.nno);
+  fprintf(fp1,"%7d\n",E->lmesh.nno);
   for(i=1;i<=E->lmesh.nno;i++)
     fprintf(fp1,"%.6e\n",E->NP[i]);
 
@@ -666,8 +666,8 @@ void output_comp_nd(struct All_variables *E, int cycles)
             E->parallel.me, cycles);
     fp1 = output_open(output_file, "w");
 
-        fprintf(fp1,"%3d %7d %.5e %d\n",
-                CPPR, E->lmesh.nel,
+        fprintf(fp1,"%7d %.5e %d\n",
+                E->lmesh.nel,
                 E->monitor.elapsed_time, E->composition.ncomp);
         for(i=0;i<E->composition.ncomp;i++) {
             fprintf(fp1,"%.5e %.5e ",
@@ -698,8 +698,8 @@ void output_comp_el(struct All_variables *E, int cycles)
             E->parallel.me, cycles);
     fp1 = output_open(output_file, "w");
 
-        fprintf(fp1,"%3d %7d %.5e %d\n",
-                CPPR, E->lmesh.nel,
+        fprintf(fp1,"%7d %.5e %d\n",
+                E->lmesh.nel,
                 E->monitor.elapsed_time, E->composition.ncomp);
         for(i=0;i<E->composition.ncomp;i++) {
             fprintf(fp1,"%.5e %.5e ",
@@ -732,7 +732,7 @@ void output_heating(struct All_variables *E, int cycles)
 
     fprintf(fp1,"%.5e\n",E->monitor.elapsed_time);
 
-    fprintf(fp1,"%3d %7d\n", CPPR, E->lmesh.nel);
+    fprintf(fp1,"%7d\n", E->lmesh.nel);
     for(e=1; e<=E->lmesh.nel; e++)
         fprintf(fp1, "%.4e %.4e %.4e\n", E->heating_adi[e],
                 E->heating_visc[e], E->heating_latent[e]);
diff --git a/lib/Output_gzdir.c b/lib/Output_gzdir.c
index daec336..2b8d92f 100644
--- a/lib/Output_gzdir.c
+++ b/lib/Output_gzdir.c
@@ -380,7 +380,7 @@ void gzdir_output_coord(struct All_variables *E)
     gz1 = gzdir_output_open(output_file,"w");
 
     /* nodal coordinates */
-      gzprintf(gz1,"%3d %7d\n",CPPR,E->lmesh.nno);
+      gzprintf(gz1,"%7d\n",E->lmesh.nno);
       for(i=1;i<=E->lmesh.nno;i++)
 	gzprintf(gz1,"%.6e %.6e %.6e\n",
 		 E->sx[1][i],E->sx[2][i],E->sx[3][i]);
@@ -612,7 +612,7 @@ void gzdir_output_velo_temp(struct All_variables *E, int cycles)
     gzout = gzdir_output_open(output_file,"w");
     gzprintf(gzout,"%d %d %.5e\n",
 	     cycles,E->lmesh.nno,E->monitor.elapsed_time);
-      gzprintf(gzout,"%3d %7d\n",CPPR,E->lmesh.nno);
+      gzprintf(gzout,"%7d\n",E->lmesh.nno);
       if(E->output.gzdir.vtk_io){
 	/* VTK */
 	for(i=1;i<=E->lmesh.nno;i++)
@@ -702,7 +702,7 @@ void gzdir_output_visc(struct All_variables *E, int cycles)
 	     "%s/%d/visc.%d.%d.gz", E->control.data_dir,
 	     cycles,E->parallel.me, cycles);
     gz1 = gzdir_output_open(output_file,"w");
-      gzprintf(gz1,"%3d %7d\n",CPPR,E->lmesh.nno);
+      gzprintf(gz1,"%7d\n",E->lmesh.nno);
       for(i=1;i<=E->lmesh.nno;i++)
 	gzprintf(gz1,"%.4e\n",E->VI[lev][i]);
 
@@ -759,7 +759,7 @@ void gzdir_output_avisc(struct All_variables *E, int cycles)
 	       "%s/%d/avisc.%d.%d.gz", E->control.data_dir,
 	       cycles,E->parallel.me, cycles);
       gz1 = gzdir_output_open(output_file,"w");
-	gzprintf(gz1,"%3d %7d\n",CPPR,E->lmesh.nno);
+	gzprintf(gz1,"%7d\n",E->lmesh.nno);
 	for(i=1;i<=E->lmesh.nno;i++)
 	  gzprintf(gz1,"%.4e %.4e %.4e %.4e\n",E->VI2[lev][i],E->VIn1[lev][i],E->VIn2[lev][i],E->VIn3[lev][i]);
       
@@ -825,7 +825,7 @@ void gzdir_output_surf_botm(struct All_variables *E, int cycles)
         else
             topo = E->slice.tpg;
 
-        gzprintf(fp2,"%3d %7d\n",CPPR,E->lmesh.nsf);
+        gzprintf(fp2,"%7d\n",E->lmesh.nsf);
         for(i=1;i<=E->lmesh.nsf;i++)   {
             s = i*E->lmesh.noz;
             gzprintf(fp2,"%.4e %.4e %.4e %.4e\n",
@@ -840,7 +840,7 @@ void gzdir_output_surf_botm(struct All_variables *E, int cycles)
 	    cycles,E->parallel.me, cycles);
     fp2 = gzdir_output_open(output_file,"w");
 
-      gzprintf(fp2,"%3d %7d\n",CPPR,E->lmesh.nsf);
+      gzprintf(fp2,"%7d\n",E->lmesh.nsf);
       for(i=1;i<=E->lmesh.nsf;i++)  {
         s = (i-1)*E->lmesh.noz + 1;
         gzprintf(fp2,"%.4e %.4e %.4e %.4e\n",
@@ -916,7 +916,7 @@ void gzdir_output_stress(struct All_variables *E, int cycles)
 
   gzprintf(fp1,"%d %d %.5e\n",cycles,E->lmesh.nno,E->monitor.elapsed_time);
 
-    gzprintf(fp1,"%3d %7d\n",CPPR,E->lmesh.nno);
+    gzprintf(fp1,"%7d\n",E->lmesh.nno);
     for (node=1;node<=E->lmesh.nno;node++)
       gzprintf(fp1, "%.4e %.4e %.4e %.4e %.4e %.4e\n",
               E->gstress[(node-1)*6+1], /*  stt */
@@ -999,7 +999,7 @@ void gzdir_output_pressure(struct All_variables *E, int cycles)
 	     E->parallel.me, cycles);
     gz1 = gzdir_output_open(output_file,"w");
     gzprintf(gz1,"%d %d %.5e\n",cycles,E->lmesh.nno,E->monitor.elapsed_time);
-      gzprintf(gz1,"%3d %7d\n",CPPR,E->lmesh.nno);
+      gzprintf(gz1,"%7d\n",E->lmesh.nno);
       for(i=1;i<=E->lmesh.nno;i++)
 	gzprintf(gz1,"%.6e\n",E->NP[i]);
     gzclose(gz1);
@@ -1079,8 +1079,8 @@ void gzdir_output_comp_nd(struct All_variables *E, int cycles)
 	     E->control.data_dir,cycles,
 	     E->parallel.me, cycles);
     gz1 = gzdir_output_open(output_file,"w");
-      gzprintf(gz1,"%3d %7d %.5e %.5e %.5e\n",
-	       CPPR, E->lmesh.nel,
+      gzprintf(gz1,"%7d %.5e %.5e %.5e\n",
+	       E->lmesh.nel,
 	       E->monitor.elapsed_time,
 	       E->composition.initial_bulk_composition,
 	       E->composition.bulk_composition);
@@ -1130,8 +1130,8 @@ void gzdir_output_comp_el(struct All_variables *E, int cycles)
 	    cycles,E->parallel.me, cycles);
     fp1 = gzdir_output_open(output_file,"w");
 
-        gzprintf(fp1,"%3d %7d %.5e %.5e %.5e\n",
-                CPPR, E->lmesh.nel,
+        gzprintf(fp1,"%7d %.5e %.5e %.5e\n",
+                E->lmesh.nel,
                 E->monitor.elapsed_time,
                 E->composition.initial_bulk_composition,
                 E->composition.bulk_composition);
@@ -1158,7 +1158,7 @@ void gzdir_output_heating(struct All_variables *E, int cycles)
 
     gzprintf(fp1,"%.5e\n",E->monitor.elapsed_time);
 
-    gzprintf(fp1,"%3d %7d\n", CPPR, E->lmesh.nel);
+    gzprintf(fp1,"%7d\n", E->lmesh.nel);
     for(e=1; e<=E->lmesh.nel; e++)
         gzprintf(fp1, "%.4e %.4e %.4e\n", E->heating_adi[e],
                   E->heating_visc[e], E->heating_latent[e]);
diff --git a/lib/Output_vtk.c b/lib/Output_vtk.c
index 314d668..88d8f85 100644
--- a/lib/Output_vtk.c
+++ b/lib/Output_vtk.c
@@ -145,9 +145,9 @@ static void vtk_output_velo(struct All_variables *E, FILE *fp)
             cost = E->SinCos[lev][2][i];
             cosf = E->SinCos[lev][3][i];
 
-            floatvel[(((CPPR-1)*E->sphere.caps_per_proc)+i-1)*3+0] = (float)(V[1][i]*cost*cosf - V[2][i]*sinf + V[3][i]*sint*cosf);
-            floatvel[(((CPPR-1)*E->sphere.caps_per_proc)+i-1)*3+1] = (float)(V[1][i]*cost*sinf + V[2][i]*cosf + V[3][i]*sint*sinf);
-            floatvel[(((CPPR-1)*E->sphere.caps_per_proc)+i-1)*3+2] = (float)(-V[1][i]*sint + V[3][i]*cost);
+            floatvel[(i-1)*3+0] = (float)(V[1][i]*cost*cosf - V[2][i]*sinf + V[3][i]*sint*cosf);
+            floatvel[(i-1)*3+1] = (float)(V[1][i]*cost*sinf + V[2][i]*cosf + V[3][i]*sint*sinf);
+            floatvel[(i-1)*3+2] = (float)(-V[1][i]*sint + V[3][i]*cost);
         }
 
     if (strcmp(E->output.vtk_format, "binary") == 0)
@@ -188,9 +188,9 @@ static void vtk_output_coord(struct All_variables *E, FILE *fp)
     fprintf(fp, "        <DataArray type=\"Float32\" Name=\"coordinate\" NumberOfComponents=\"3\" format=\"%s\">\n", E->output.vtk_format);
 
         for(i=1; i<=E->lmesh.nno; i++){
-          floatpos[((CPPR-1)*E->lmesh.nno+i-1)*3] = (float)(E->x[1][i]);
-	        floatpos[((CPPR-1)*E->lmesh.nno+i-1)*3+1]=(float)(E->x[2][i]);
-	        floatpos[((CPPR-1)*E->lmesh.nno+i-1)*3+2]=(float)(E->x[3][i]);
+          floatpos[(i-1)*3+0]=(float)(E->x[1][i]);
+	       floatpos[(i-1)*3+1]=(float)(E->x[2][i]);
+	       floatpos[(i-1)*3+2]=(float)(E->x[3][i]);
         }
 
     if (strcmp(E->output.vtk_format, "binary") == 0)
@@ -239,7 +239,7 @@ static void vtk_output_comp_nd(struct All_variables *E, FILE *fp)
         fprintf(fp, "        <DataArray type=\"Float32\" Name=\"composition%d\" format=\"%s\">\n", k+1, E->output.vtk_format);
 
             for(i=1; i<=E->lmesh.nno; i++) {
-                floatcompo[(CPPR-1)*E->lmesh.nno+i-1] = (float) (E->composition.comp_node[k][i]);
+                floatcompo[i-1] = (float) (E->composition.comp_node[k][i]);
 	    }
 
         if (strcmp(E->output.vtk_format, "binary") == 0)
@@ -275,16 +275,16 @@ static void vtk_output_surf(struct All_variables *E,  FILE *fp, int cycles)
 
         for(i=1;i<=E->lmesh.nsf;i++){
             for(k=1;k<=E->lmesh.noz;k++){
-                floattopo[(CPPR-1)*E->lmesh.nno + (i-1)*E->lmesh.noz + k-1] = 0.0;
+                floattopo[(i-1)*E->lmesh.noz + k-1] = 0.0;
             }
 
             if (E->parallel.me_loc[3]==E->parallel.nprocz-1) {
 
                 /* choose either STD topo or pseudo-free-surf topo */
                 if(E->control.pseudo_free_surf)
-                floattopo[(CPPR-1)*E->lmesh.nno + i*E->lmesh.noz-1] = E->slice.freesurf[i];
+                floattopo[i*E->lmesh.noz-1] = E->slice.freesurf[i];
                 else
-                floattopo[(CPPR-1)*E->lmesh.nno + i*E->lmesh.noz-1] = E->slice.tpg[i];
+                floattopo[i*E->lmesh.noz-1] = E->slice.tpg[i];
 
             }
         }
diff --git a/lib/Phase_change.c b/lib/Phase_change.c
index 9a0535f..83a4e5d 100644
--- a/lib/Phase_change.c
+++ b/lib/Phase_change.c
@@ -191,7 +191,7 @@ static void debug_phase_change(struct All_variables *E, float *B)
   int m, j;
 
   fprintf(E->fp_out,"output_phase_change_buoyancy\n");
-    fprintf(E->fp_out,"for cap %d\n",E->sphere.capid[CPPR]);
+    fprintf(E->fp_out,"for cap %d\n",E->sphere.capid[1]);
     for (j=1;j<=E->lmesh.nno;j++)
       fprintf(E->fp_out,"Z = %.6e T = %.6e B[%06d] = %.6e \n",E->sx[3][j],E->T[j],j,B[j]);
   fflush(E->fp_out);
diff --git a/lib/Regional_boundary_conditions.c b/lib/Regional_boundary_conditions.c
index 210f282..e418883 100644
--- a/lib/Regional_boundary_conditions.c
+++ b/lib/Regional_boundary_conditions.c
@@ -140,7 +140,7 @@ void regional_velocity_boundary_conditions(E)
 
       if(E->control.verbose) {
 	  for (node=1;node<=E->lmesh.nno;node++)
-	    fprintf(E->fp_out,"m=%d VB== %d %g %g %g flag %u %u %u\n",CPPR,node,E->sphere.cap[1].VB[1][node],E->sphere.cap[1].VB[2][node],E->sphere.cap[1].VB[3][node],E->node[node]&VBX,E->node[node]&VBY,E->node[node]&VBZ);
+	    fprintf(E->fp_out,"VB== %d %g %g %g flag %u %u %u\n",node,E->sphere.cap[1].VB[1][node],E->sphere.cap[1].VB[2][node],E->sphere.cap[1].VB[3][node],E->node[node]&VBX,E->node[node]&VBY,E->node[node]&VBZ);
 	fflush(E->fp_out);
       }
       /* If any imposed internal velocity structure it goes here */
diff --git a/lib/Regional_parallel_related.c b/lib/Regional_parallel_related.c
index d929bd5..a7baa84 100644
--- a/lib/Regional_parallel_related.c
+++ b/lib/Regional_parallel_related.c
@@ -82,7 +82,7 @@ void regional_parallel_processor_setup(struct All_variables *E)
   pid_surf = me/E->parallel.nprocz;
   i = cases[E->sphere.caps_per_proc];
 
-  E->sphere.capid[CPPR] = 1;
+  E->sphere.capid[1] = 1;
 
   /* steup location-to-processor map */
   E->parallel.loc2proc_map = (int ****) malloc(E->sphere.caps*sizeof(int ***));
@@ -106,7 +106,7 @@ void regional_parallel_processor_setup(struct All_variables *E)
 
   if (E->control.verbose) {
     fprintf(E->fp_out,"me=%d loc1=%d loc2=%d loc3=%d\n",me,E->parallel.me_loc[1],E->parallel.me_loc[2],E->parallel.me_loc[3]);
-    fprintf(E->fp_out,"capid[%d]=%d \n",CPPR,E->sphere.capid[CPPR]);
+    fprintf(E->fp_out,"capid[1]=%d \n",E->sphere.capid[1]);
     for (m=0;m<E->sphere.caps;m++)
       for (j=0;j<E->parallel.nprocy;j++)
 	for (i=0;i<E->parallel.nprocx;i++)
@@ -406,7 +406,7 @@ void regional_parallel_domain_boundary_nodes(E)
 if (E->control.verbose) {
  fprintf(E->fp_out,"output_shared_nodes %d \n",E->parallel.me);
  for(lev=E->mesh.gridmax;lev>=E->mesh.gridmin;lev--)
-    fprintf(E->fp_out,"lev=%d  me=%d capid=%d m=%d \n",lev,E->parallel.me,E->sphere.capid[CPPR],CPPR);
+    fprintf(E->fp_out,"lev=%d  me=%d capid=%d\n",lev,E->parallel.me,E->sphere.capid[1]);
     for (ii=1;ii<=6;ii++)
       for (i=1;i<=E->parallel.NUM_NNO[lev].bound[ii];i++)
         fprintf(E->fp_out,"ii=%d   %d %d \n",ii,i,E->parallel.NODE[lev][i].bound[ii]);
@@ -459,7 +459,7 @@ void regional_parallel_communication_routs_v(E)
     kkk=0;
 
 
-      cap = E->sphere.capid[CPPR] - 1;  /* which cap I am in (0~11) */
+      cap = E->sphere.capid[1] - 1;  /* which cap I am in (0~11) */
 
           for(i=1;i<=2;i++)       {       /* do YOZ boundaries & OY lines */
 
@@ -576,7 +576,7 @@ void regional_parallel_communication_routs_v(E)
   if(E->control.verbose) {
     for(lev=E->mesh.gridmax;lev>=E->mesh.gridmin;lev--) {
       fprintf(E->fp_out,"output_communication route surface for lev=%d \n",lev);
-    fprintf(E->fp_out,"  me= %d cap=%d pass  %d \n",E->parallel.me,E->sphere.capid[CPPR],E->parallel.TNUM_PASS[lev]);
+    fprintf(E->fp_out,"  me= %d cap=%d pass  %d \n",E->parallel.me,E->sphere.capid[1],E->parallel.TNUM_PASS[lev]);
     for (k=1;k<=E->parallel.TNUM_PASS[lev];k++)   {
       fprintf(E->fp_out,"proc %d and pass  %d to proc %d with %d eqn and %d node\n",E->parallel.me,k,E->parallel.PROCESSOR[lev].pass[k],E->parallel.NUM_NEQ[lev].pass[k],E->parallel.NUM_NODE[lev].pass[k]);
 /*    fprintf(E->fp_out,"Eqn:\n");  */
diff --git a/lib/Regional_tracer_advection.c b/lib/Regional_tracer_advection.c
index 4e026e2..ec71dff 100644
--- a/lib/Regional_tracer_advection.c
+++ b/lib/Regional_tracer_advection.c
@@ -527,7 +527,7 @@ void regional_keep_within_bounds(struct All_variables *E,
 void regional_lost_souls(struct All_variables *E)
 {
     /* This part only works if E->sphere.caps_per_proc==1 */
-    const int j = CPPR;
+    const int j = 1;
     int lev = E->mesh.levmax;
 
     int i, d, kk;
diff --git a/lib/Regional_version_dependent.c b/lib/Regional_version_dependent.c
index 1a0e74c..8d3e8a9 100644
--- a/lib/Regional_version_dependent.c
+++ b/lib/Regional_version_dependent.c
@@ -148,10 +148,10 @@ void regional_node_locations(E)
   if (E->control.verbose) {
   for (lev=E->mesh.levmin;lev<=E->mesh.levmax;lev++) {
     fprintf(E->fp_out,"output_coordinates before rotation %d \n",lev);
-    fprintf(E->fp_out,"output_coordinates for cap %d %d\n",CPPR,E->lmesh.NNO[lev]);
+    fprintf(E->fp_out,"output_coordinates for cap %d\n",E->lmesh.NNO[lev]);
     for (i=1;i<=E->lmesh.NNO[lev];i++)
       if(i%E->lmesh.NOZ[lev]==1)
-        fprintf(E->fp_out,"%d %d %g %g %g\n",CPPR,i,E->SX[lev][1][i],E->SX[lev][2][i],E->SX[lev][3][i]);
+        fprintf(E->fp_out,"%d %g %g %g\n",i,E->SX[lev][1][i],E->SX[lev][2][i],E->SX[lev][3][i]);
     }
     fflush(E->fp_out);
   }
@@ -174,7 +174,7 @@ void regional_node_locations(E)
     fprintf(E->fp_out,"output_coordinates after rotation %d \n",lev);
       for (i=1;i<=E->lmesh.NNO[lev];i++)
         if(i%E->lmesh.NOZ[lev]==1)
-             fprintf(E->fp_out,"%d %d %g %g %g\n",CPPR,i,E->SX[lev][1][i],E->SX[lev][2][i],E->SX[lev][3][i]);
+             fprintf(E->fp_out,"%d %g %g %g\n",i,E->SX[lev][1][i],E->SX[lev][2][i],E->SX[lev][3][i]);
       }
     fflush(E->fp_out);
   }
diff --git a/lib/Size_does_matter.c b/lib/Size_does_matter.c
index 5708e02..0dce8fc 100644
--- a/lib/Size_does_matter.c
+++ b/lib/Size_does_matter.c
@@ -1101,14 +1101,14 @@ void mass_matrix(struct All_variables *E)
 
         for(lev=E->mesh.levmin;lev<=E->mesh.levmax;lev++)  {
             fprintf(E->fp_out,"output_mass lev=%d\n",lev);
-                fprintf(E->fp_out,"m=%d %d \n",E->sphere.capid[CPPR],m);
+                fprintf(E->fp_out,"%d\n",E->sphere.capid[1]);
                 for(e=1;e<=E->lmesh.NEL[lev];e++)
                     fprintf(E->fp_out,"%d %g \n",e,E->ECO[lev][e].area);
                 for (node=1;node<=E->lmesh.NNO[lev];node++)
                     fprintf(E->fp_out,"Mass[%d]= %g \n",node,E->MASS[lev][node]);
         }
 
-            fprintf(E->fp_out,"m=%d %d \n",E->sphere.capid[CPPR],m);
+            fprintf(E->fp_out,"%d\n",E->sphere.capid[1]);
             for (node=1;node<=E->lmesh.nno;node++)
                 fprintf(E->fp_out,"TMass[%d]= %g \n",node,E->TMass[node]);
         fflush(E->fp_out);
diff --git a/lib/global_defs.h b/lib/global_defs.h
index feedcb1..9fa59d6 100644
--- a/lib/global_defs.h
+++ b/lib/global_defs.h
@@ -61,9 +61,6 @@ extern "C" {
 
 #else
 
-extern const int CPPR;
-
-
 /* Macros */
 #define max(A,B) (((A) > (B)) ? (A) : (B))
 #define min(A,B) (((A) < (B)) ? (A) : (B))



More information about the CIG-COMMITS mailing list