Rename ffopen and ffclose to gmx_ff*.
[alexxy/gromacs.git] / src / gromacs / gmxana / gmx_do_dssp.c
index 3b34c71bafc177f969cffca3aa74158ff97569db..77e143348029ee62715f134b4e2ddcf4ab57d8cf 100644 (file)
@@ -74,7 +74,7 @@ static int strip_dssp(char *dsspfile, int nres,
     real            iaccf, iaccb;
     t_xpmelmt       c;
 
-    tapeout = ffopen(dsspfile, "r");
+    tapeout = gmx_ffopen(dsspfile, "r");
 
     /* Skip header */
     do
@@ -179,7 +179,7 @@ static int strip_dssp(char *dsspfile, int nres,
     {
         fprintf(fTArea, "%10g  %10g  %10g\n", t, 0.01*iaccb, 0.01*iaccf);
     }
-    ffclose(tapeout);
+    gmx_ffclose(tapeout);
 
     /* Return the number of lines found in the dssp file (i.e. number
      * of redidues plus chain separator lines).
@@ -328,12 +328,12 @@ void write_sas_mat(const char *fn, real **accr, int nframe, int nres, t_matrix *
                 hi = max(hi, accr[i][j]);
             }
         }
-        fp   = ffopen(fn, "w");
+        fp   = gmx_ffopen(fn, "w");
         nlev = hi-lo+1;
         write_xpm(fp, 0, "Solvent Accessible Surface", "Surface (A^2)",
                   "Time", "Residue Index", nframe, nres,
                   mat->axis_x, mat->axis_y, accr, lo, hi, rlo, rhi, &nlev);
-        ffclose(fp);
+        gmx_ffclose(fp);
     }
 }
 
@@ -427,7 +427,7 @@ void analyse_ss(const char *outfile, t_matrix *mat, const char *ss_string,
     }
     fprintf(fp, "\n");
 
-    ffclose(fp);
+    gmx_ffclose(fp);
     sfree(leg);
     sfree(count);
 }
@@ -656,9 +656,9 @@ int gmx_do_dssp(int argc, char *argv[])
             }
         }
         gmx_rmpbc(gpbc, natoms, box, x);
-        tapein = ffopen(pdbfile, "w");
+        tapein = gmx_ffopen(pdbfile, "w");
         write_pdbfile_indexed(tapein, NULL, atoms, x, ePBC, box, ' ', -1, gnx, index, NULL, TRUE);
-        ffclose(tapein);
+        gmx_ffclose(tapein);
 
 #ifdef GMX_NO_SYSTEM
         printf("Warning-- No calls to system(3) supported on this platform.");
@@ -691,7 +691,7 @@ int gmx_do_dssp(int argc, char *argv[])
     close_trj(status);
     if (fTArea)
     {
-        ffclose(fTArea);
+        gmx_ffclose(fTArea);
     }
     gmx_rmpbc_done(gpbc);
 
@@ -700,7 +700,7 @@ int gmx_do_dssp(int argc, char *argv[])
     ss        = opt2FILE("-o", NFILE, fnm, "w");
     mat.flags = 0;
     write_xpm_m(ss, mat);
-    ffclose(ss);
+    gmx_ffclose(ss);
 
     if (opt2bSet("-ssdump", NFILE, fnm))
     {
@@ -716,7 +716,7 @@ int gmx_do_dssp(int argc, char *argv[])
             ss_str[i] = '\0';
             fprintf(ss, "%s\n", ss_str);
         }
-        ffclose(ss);
+        gmx_ffclose(ss);
         sfree(ss_str);
     }
     analyse_ss(fnSCount, &mat, ss_string, oenv);
@@ -740,7 +740,7 @@ int gmx_do_dssp(int argc, char *argv[])
             {
                 fprintf(acc, "%5d  %10g %10g\n", i+1, av_area[i], norm_av_area[i]);
             }
-            ffclose(acc);
+            gmx_ffclose(acc);
         }
     }