[GRASS-SVN] r65545 - grass-addons/grass7/vector/v.kriging

svn_grass at osgeo.org svn_grass at osgeo.org
Wed Jul 8 04:43:17 PDT 2015


Author: evas
Date: 2015-07-08 04:43:17 -0700 (Wed, 08 Jul 2015)
New Revision: 65545

Modified:
   grass-addons/grass7/vector/v.kriging/Makefile
   grass-addons/grass7/vector/v.kriging/geostat.c
   grass-addons/grass7/vector/v.kriging/getval.c
   grass-addons/grass7/vector/v.kriging/local_proto.h
   grass-addons/grass7/vector/v.kriging/main.c
   grass-addons/grass7/vector/v.kriging/quantile.c
   grass-addons/grass7/vector/v.kriging/utils.c
   grass-addons/grass7/vector/v.kriging/utils_kriging.c
   grass-addons/grass7/vector/v.kriging/utils_write.c
Log:
v.kriging: fixed warnings

Modified: grass-addons/grass7/vector/v.kriging/Makefile
===================================================================
--- grass-addons/grass7/vector/v.kriging/Makefile	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/Makefile	2015-07-08 11:43:17 UTC (rev 65545)
@@ -1,4 +1,4 @@
-MODULE_TOPDIR = ../..
+MODULE_TOPDIR = /home/evergreen/grass7
 
 PGM = v.kriging
 

Modified: grass-addons/grass7/vector/v.kriging/geostat.c
===================================================================
--- grass-addons/grass7/vector/v.kriging/geostat.c	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/geostat.c	2015-07-08 11:43:17 UTC (rev 65545)
@@ -2,10 +2,10 @@
 
 /* experimental variogram 
  * based on  2D variogram (alghalandis.com/?page_id=463)) */
-  void E_variogram(int type, struct int_par *xD, struct points *pnts, struct reg_par *reg, struct var_par *pars)
+  void E_variogram(int type, struct int_par *xD, struct points *pnts, struct var_par *pars)
 {
   // Variogram properties
-  struct parameters *var_pars, *var_par_hz, *var_par_vert;
+  struct parameters *var_pars;
   double max_dist, max_dist_vert; // max distance of interpolated points
   double radius, radius_vert;     // radius of interpolation in the horizontal plane
 
@@ -41,9 +41,7 @@
   double *r;                        // pointer to xyz coordinates
   double *search;                   // pointer to search point coordinates
   double *vals = pnts->invals;      // values to be used for interpolation
-  int i3 = xD->i3;
   int phase = xD->phase;            // phase: initial / middle / final
-  int function = var_pars->function; // type of theoretical variogram
 
   int nLag;                         // # of horizontal bins
   int nLag_vert;                    // # of vertical bins
@@ -71,7 +69,6 @@
   }
 
   // depend on variogram type: 
-  int k; // index of variogram to be computed
   int nrows = nLag;
   int ncols = type == 2 ? nLag_vert : 1;
 
@@ -88,7 +85,6 @@
   double tv;    // bearing of the line between the couple of the input points
   double ddir1, ddir2;  // the azimuth of computing variogram
   double rv;    // radius of the couple of points
-  double drv;   // distance between the points
   double rvh;   // difference between point distance and the horizontal segment boundary
   double dv;    // difference of the values to be interpolated that are located on the couple of points
 
@@ -97,12 +93,10 @@
 
   double *i_vals, *j_vals; // values located on the point couples
 
-  int n1 = n+1;     // number of points + 1
   int *ii;     // difference of indices between rellevant input points
   
   double gamma_lag;    // sum of dissimilarities in one bin
   double cpls;         // # of dissimilarities in one bin
-  double gamma_E;      // average of dissimilarities in one bin (element of gamma matrix)
   mat_struct *gamma_M; // gamma matrix (hz, vert or bivar)
   mat_struct *c_M;     // matrix of # of dissimilarities
   double *gamma;       // pointer to gamma matrix
@@ -112,7 +106,6 @@
 
   double gamma_sum;  // sum of gamma elements (non-nan)
   int gamma_n;       // # of gamma elements (non-nan)
-  double gamma_sill; // sill
  
   /* Allocated vertices and matrices:
    * --------------------------------
@@ -207,7 +200,7 @@
 	
 	n_vals = list->n_values;            // # of input values located on NN
 	if (n_vals > 0) {
-	  correct_indices(i3, list, r, pnts, var_pars);
+	  correct_indices(list, r, pnts, var_pars);
 	  ii = &list->value[0];             // indices of these input values (note: increased by 1)
 	  j_vals = &vals[*ii];                // pointer to input values
 	  
@@ -331,7 +324,7 @@
   char *variogram;
 
   // report
-  if (report->write2file = TRUE) { // report file available:
+  if (report->write2file == TRUE) { // report file available:
     time(&report->now); // write down time of start
     if (type != 1) {
       fprintf(report->fp, "\nComputation of theoretical variogram started on %s\n", ctime(&report->now));    
@@ -475,8 +468,6 @@
 {
   // Local variables
   int i3 = xD->i3;
-  int n = pnts->n;                      // number of input points
-  double *r = pnts->r;                  // xyz coordinates of input points
   double *vals = pnts->invals;          // values to be used for interpolation
   struct write *report = &xD->report;
   struct write *crossvalid = &xD->crossvalid;
@@ -487,21 +478,14 @@
   //max_dist = sqrt(0.5 * SQUARE(max_dist));
 
   double max_dist_vert = type == 2 ? var_par->vertical.max_dist : var_par->max_dist;
-  double ratio = var_par->type == 3 ? xD->aniso_ratio : 1.;
-       
-  unsigned int passed=0;      // number of successfully interpolated valuesy
+         
   unsigned int percents=50;   // counter
-  unsigned int nrcd;          // number of cells/voxels
   unsigned int row, col, dep; // indices of cells/voxels
   double rslt_OK;     // interpolated value located on r0
 
-  int i, j;
-  unsigned int n1;
-
   pnts->max_dist = var_par->lag;
   struct ilist *list;
-  int n_vals;
-
+  
   double *r0;         // xyz coordinates of cell/voxel centre
   mat_struct *GM;
   mat_struct *GM_sub; // submatrix of selected points
@@ -512,8 +496,6 @@
   // Cell/voxel center coords (location of interpolated value)
   r0 = (double *) G_malloc(3 * sizeof(double));   
   
-  FILE *fp;
-
   if (report->name) {  // report file available:
     report->write2file = TRUE;
     report->fp = fopen(report->name, "a");
@@ -573,7 +555,7 @@
 	}
 
 	if (list->n_values > 1) { // positive # of selected points: 
-	  correct_indices(i3, list, r0, pnts, var_par);
+	  correct_indices(list, r0, pnts, var_par);
 
 	  GM_sub = submatrix(list, GM, report); // make submatrix for selected points
 	  GM_Inv = G_matrix_inverse(GM_sub);    // invert submatrix

Modified: grass-addons/grass7/vector/v.kriging/getval.c
===================================================================
--- grass-addons/grass7/vector/v.kriging/getval.c	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/getval.c	2015-07-08 11:43:17 UTC (rev 65545)
@@ -10,7 +10,7 @@
 {
   struct select *in_reg = &pnts->in_reg;
 
-  int i, n, nrec, type, ctype;
+  int i, n, nrec, ctype;
   struct field_info *Fi;
 
   dbCatValArray cvarr;
@@ -186,10 +186,9 @@
     point->Rtree_vert = RTreeCreateTree(-1, 0, 1); // create 1D spatial index
   }
 
-  int i;
   int sid=0;        // id of the rectangle (will be increased by 1)
   
-  double *rx, *ry, *rz, *r; // pointers to coordinates
+  double *rx, *ry, *rz; // pointers to coordinates
   int ind = 0;      // index of the point     
   int *indices;     // indices of the points within the region
   int *index;       // pointer to the vector of indices
@@ -399,7 +398,7 @@
 
   int j, nLag_vert;
   double lag_vert, max_dist_vert;
-  double *v_elm, *g_elm, *c_elm;
+  double *v_elm, *g_elm;
   double sill_hz, sill_vert;
 
  
@@ -412,8 +411,7 @@
     int i, type;
     int nLag;
     double lag, max_dist, td_hz, sill;
-    double *h, *h_elm, *c, *gamma;
-    int function;
+    double *h_elm, *gamma;
     int file, file_length;
 
     for (i=0; i<2; i++) {

Modified: grass-addons/grass7/vector/v.kriging/local_proto.h
===================================================================
--- grass-addons/grass7/vector/v.kriging/local_proto.h	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/local_proto.h	2015-07-08 11:43:17 UTC (rev 65545)
@@ -196,14 +196,14 @@
 struct ilist *find_n_NNs(int, int, struct points *, int);
 double sum_NN(int, int, struct ilist *, struct points *);
 
-void correct_indices(int, struct ilist *, double *, struct points *, struct parameters *);
+void correct_indices(struct ilist *, double *, struct points *, struct parameters *);
 int cmpVals(const void *, const void *);
 void coord_diff(int, int, double *, double *);
 double distance_diff(double *);
 double radius_hz_diff(double *);
 double zenith_angle(double *);
 void triple(double, double, double, double *);
-double lag_size(int, struct int_par *, struct points *, struct parameters *, struct write *);
+double lag_size(int, struct points *, struct parameters *, struct write *);
 int lag_number(double, double *);
 void optimize(double *, int *, double);
 void variogram_restricts(struct int_par *, struct points *, struct parameters *);
@@ -213,14 +213,14 @@
 mat_struct *LSM(mat_struct *, mat_struct *);
 mat_struct *nonlin_LMS(int , double *, double *);
 
-void E_variogram(int, struct int_par *, struct points *, struct reg_par *, struct var_par *);
+void E_variogram(int, struct int_par *, struct points *, struct var_par *);
 void T_variogram(int, int, struct opts, struct parameters *, struct write *);
 void ordinary_kriging(struct int_par *, struct reg_par *, struct points *, struct var_par *, struct output *);
 
 void LMS_variogram(struct parameters *, struct write *);
 double bivar_sill(int, mat_struct *);
 void sill(struct parameters *);
-int sill_compare(struct int_par *, struct flgs *, struct var_par *, struct points *);
+void sill_compare(struct int_par *, struct flgs *, struct var_par *, struct points *);
 int set_function(char *, struct write *);
 double RBF(double *);
 double linear(double, double, double);
@@ -254,12 +254,12 @@
 void open_layer(struct int_par *, struct reg_par *, struct output *);
 int write2layer(struct int_par *, struct reg_par *, struct output *, unsigned int, unsigned int, unsigned int, double);
 
-static inline double get_quantile(int);
-static void get_slot_counts(int, double *);
-static void initialize_bins(void);
-static void fill_bins(int, double *);
-static int compare(const void *, const void *);
-static void sort_bins(void);
-static void compute_quantiles(int, double *, struct write *);
+double get_quantile(int);
+void get_slot_counts(int, double *);
+void initialize_bins(void);
+void fill_bins(int, double *);
+int compare(const void *, const void *);
+void sort_bins(void);
+void compute_quantiles(int, double *, struct write *);
 double quantile(double, int, double *, struct write *);
 #endif

Modified: grass-addons/grass7/vector/v.kriging/main.c
===================================================================
--- grass-addons/grass7/vector/v.kriging/main.c	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/main.c	2015-07-08 11:43:17 UTC (rev 65545)
@@ -37,7 +37,6 @@
 
   // Outputs
   struct output out;      // Output layer properties
-  FILE *fp;
     
   // Settings
   int field;
@@ -434,9 +433,9 @@
 	var_pars.vert.lag = var_pars.vert.max_dist / var_pars.vert.nLag; // modify lag size
       }
     }
-    E_variogram(0, &xD, &pnts, &reg, &var_pars); // horizontal variogram (for both 2D and 3D interpolation)
+    E_variogram(0, &xD, &pnts, &var_pars); // horizontal variogram (for both 2D and 3D interpolation)
     if (xD.i3 == TRUE) { // 3D interpolation:
-      E_variogram(1, &xD, &pnts, &reg, &var_pars);     // vertical variogram
+      E_variogram(1, &xD, &pnts, &var_pars);     // vertical variogram
       G_message(_("You may continue to computing theoretical variograms (middle phase)..."));
     }
     else {
@@ -466,7 +465,7 @@
    sill_compare(&xD, &flg, &var_pars, &pnts);
    variogram_restricts(&xD, &pnts, &var_pars.fin);
 
-   E_variogram(var_pars.fin.type, &xD, &pnts, &reg, &var_pars);            
+   E_variogram(var_pars.fin.type, &xD, &pnts, &var_pars);            
    G_message(_("You may continue to interpolate values (final phase)..."));
    goto end;
 

Modified: grass-addons/grass7/vector/v.kriging/quantile.c
===================================================================
--- grass-addons/grass7/vector/v.kriging/quantile.c	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/quantile.c	2015-07-08 11:43:17 UTC (rev 65545)
@@ -33,12 +33,12 @@
     return i;
 }
 
-static inline double get_quantile(int n)
+double get_quantile(int n)
 {
   return (double)total * quants[n]; // # of lower values
 }
 
-static void get_slot_counts(int n, double *data)
+void get_slot_counts(int n, double *data)
 {
   int i;
   
@@ -55,7 +55,7 @@
   //G_percent(i, n, 2);
 }
 
-static void initialize_bins(void)
+void initialize_bins(void)
 {
   int slot;    // index of slot
   double next; // percentile
@@ -92,7 +92,7 @@
   num_bins = bin; 
 }
 
-static void fill_bins(int n, double *data)
+void fill_bins(int n, double *data)
 {
   int i;
   
@@ -116,7 +116,7 @@
   //G_percent(i, n, 2);
 }
 
-static int compare(const void *aa, const void *bb)
+int compare(const void *aa, const void *bb)
 {
     double a = *(const double *)aa;
     double b = *(const double *)bb;
@@ -128,7 +128,7 @@
     return 0;
 }
 
-static void sort_bins(void)
+void sort_bins(void)
 {
     int bin;
 
@@ -141,7 +141,7 @@
     //G_percent(bin, num_bins, 2);
 }
 
-static void compute_quantiles(int recode, double *quantile, struct write *report)
+void compute_quantiles(int recode, double *quantile, struct write *report)
 {
     int bin = 0;
     double prev_v = minimum;

Modified: grass-addons/grass7/vector/v.kriging/utils.c
===================================================================
--- grass-addons/grass7/vector/v.kriging/utils.c	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/utils.c	2015-07-08 11:43:17 UTC (rev 65545)
@@ -16,15 +16,14 @@
       return 0;
   }
 
-void correct_indices(int i3, struct ilist *list, double *r0, struct points *pnts, struct parameters *var_pars)
+void correct_indices(struct ilist *list, double *r0, struct points *pnts, struct parameters *var_pars)
 {
   int i;
   int n = list->n_values;
   int *vals = list->value;
   double dx, dy, dz;
   int type = var_pars->type;
-  double sqDist = type == 2 ? SQUARE(var_pars->horizontal.max_dist) : SQUARE(var_pars->max_dist);
-  
+    
   int n_new = 0;  // # of effective indices (not identical points, nor too far)
   int *newvals, *save;   // effective indices
   newvals = (int *) G_malloc(n * sizeof(int));
@@ -77,7 +76,7 @@
 void coord_diff(int i, int j, double *r, double *dr)
 {
   int k = 3*i, l = 3*j;
-  double *rk, *rl, zi, zj, *drt;
+  double *rk, *rl, *drt;
   rk = &r[k];
   rl = &r[l];
   drt = &dr[0];
@@ -112,18 +111,17 @@
 }
 
 // compute size of the lag
-double lag_size(int direction, struct int_par *xD, struct points *pnts, struct parameters *var_pars, struct write *report)
+double lag_size(int direction, struct points *pnts, struct parameters *var_pars, struct write *report)
 {
   // local variables
   int n = pnts->n;                             // # of input points
   double *r = pnts->r;                         // xyz of input points
-  int fction = var_pars->function;
   int type = var_pars->type;
   double max_dist = type == 2 ? var_pars->horizontal.max_dist : var_pars->max_dist; // maximum horizontal distance (or vertical for vertical variogram)
   double max_dist_vert = type == 2 ? var_pars->vertical.max_dist : var_pars->max_dist; // maximum vertical distance (just for bivariate variogram)
 
 
-  int i, j, k;                     // loop indices
+  int i, j;                     // loop indices
   int n_vals;                      // number of the nearest neighbors (NN)
   int *j_vals;                     // indices of NN (NOT sorted by distance)
   struct ilist *list;              // list of NN
@@ -283,14 +281,10 @@
 // maximal horizontal and vertical distance to restrict variogram computing
 void variogram_restricts(struct int_par *xD, struct points *pnts, struct parameters *var_pars)
 {
-  int n = pnts->n;       // # of points
-  double *r = pnts->r;   // xyz of points
   struct write *report = &xD->report;
   
-  int i;
   double *min, *max;     // extend
   double dr[3];          // coordinate differences
-  double h_maxG;         // modify maximum distance (to not have empty lags)
 
   int dimension;         // dimension: hz / vert / aniso
   char type[12];
@@ -335,20 +329,20 @@
 
   if (var_pars->type == 2) { // bivariate variogram
     // horizontal direction: 
-    var_pars->lag = lag_size(12, xD, pnts, var_pars, report);  // lag distance
+    var_pars->lag = lag_size(12, pnts, var_pars, report);  // lag distance
     var_pars->nLag = lag_number(var_pars->lag, &var_pars->max_dist); // number of lags
     optimize(&var_pars->lag, &var_pars->nLag, var_pars->max_dist);
     var_pars->max_dist = var_pars->nLag * var_pars->lag;             // maximum distance
 
     // vertical direction
-    var_pars->lag_vert = lag_size(3, xD, pnts, var_pars, report);             // lag distance
+    var_pars->lag_vert = lag_size(3, pnts, var_pars, report);             // lag distance
     var_pars->nLag_vert = lag_number(var_pars->lag_vert, &var_pars->max_dist_vert); // # of lags
     optimize(&var_pars->lag_vert, &var_pars->nLag_vert, var_pars->max_dist_vert);
     var_pars->max_dist_vert = var_pars->nLag_vert * var_pars->lag_vert;             // max distance
   }
 
   else { // univariate variograms (hz / vert / aniso)
-    var_pars->lag = lag_size(dimension, xD, pnts, var_pars, report); // lag size
+    var_pars->lag = lag_size(dimension, pnts, var_pars, report); // lag size
     var_pars->nLag = lag_number(var_pars->lag, &var_pars->max_dist);   // # of lags
     optimize(&var_pars->lag, &var_pars->nLag, var_pars->max_dist);
     var_pars->max_dist = var_pars->nLag * var_pars->lag;               // maximum distance
@@ -396,13 +390,8 @@
 // Least Squares Method
 mat_struct *LSM(mat_struct *A, mat_struct *x)
 {
-  int i, nr, nc;
   mat_struct *AT, *ATA, *ATA_Inv, *ATx, *T;
 
-  /* A[nr x nc] */
-  nr = A->rows;
-  nc = A->cols;
-
   /* LMS */
   AT = G_matrix_transpose(A);	/* Transposed design matrix */
   ATA = G_matrix_product(AT, A);	/* AT*A */
@@ -573,7 +562,7 @@
   }
 
   else { // univariate variogram
-    char dim[6], dist[2];
+    char dim[6];
     if (xD->i3 == TRUE) { // 3D
       if (var_par->type == 0) {
 	strcpy(dim,"hz");
@@ -602,45 +591,26 @@
 // plot experimental and theoretical variogram
 void plot_var(int i3, int bivar, struct parameters *var_pars)
 {
-  int function, func_h, func_v;
+  int function;
   double nugget, nugget_h, nugget_v;
-  double sill, sill_h, sill_v;
-  double h_range, h_range_h, h_range_v;
+  double sill;
+  double h_range;
   double *T;
 
   // setup theoretical variogram parameters
-  switch (bivar) {
-  case FALSE: // univariate variogram
+  if (bivar == FALSE) { // univariate variogram
     function = var_pars->function;
     if (function > 1) { // nonlinear and not parabolic variogram
       nugget = var_pars->nugget;
       sill = var_pars->sill - nugget;
       h_range = var_pars->h_range;
-    }   
-    else {
-      T = &var_pars->T->vals[0];
-    } 
-    break;
-
-  case TRUE:  // bivariate variogram
-    if (var_pars->function != 5) {
-      func_h = var_pars->horizontal.function;
-      func_v = var_pars->vertical.function;
-
-      nugget_h = var_pars->horizontal.nugget;
-      sill_h = var_pars->horizontal.sill - nugget_h;
-      h_range_h = var_pars->horizontal.h_range;
-
-      nugget_v = var_pars->vertical.nugget;
-      sill_v = var_pars->vertical.sill - nugget_v;
-      h_range_v = var_pars->vertical.h_range;
     }
-    else {
-      T = &var_pars->T->vals[0];
-    } 
-    break;
   }
 
+  if (var_pars->function < 2) { // linear or parabolic variogram
+    T = &var_pars->T->vals[0];
+  }     
+
   int i, j;     // indices
   int nr, nc;   // # of rows, cols
   int type = var_pars->type;

Modified: grass-addons/grass7/vector/v.kriging/utils_kriging.c
===================================================================
--- grass-addons/grass7/vector/v.kriging/utils_kriging.c	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/utils_kriging.c	2015-07-08 11:43:17 UTC (rev 65545)
@@ -1,10 +1,5 @@
 #include "local_proto.h"
 
- __inline double square(double x)
-  {
-    return x*x;
-  }
-
 void LMS_variogram(struct parameters *var_par, struct write *report)
 {
   int nZ, nL;                // # of gamma matrix rows and columns
@@ -71,7 +66,6 @@
       vert++;
     }
   } // end i
- end_loop:
 
   // Estimate theoretical variogram coefficients 
   var_par->T = LSM(var_par->A, gR); // Least Square Method
@@ -147,8 +141,6 @@
   // Local variables
   int type = var_par->type;
   mat_struct *gamma = var_par->gamma;
-  int nrows = gamma->rows;
-  int ncols = gamma->cols;
 
   char var_type[12];
 
@@ -168,7 +160,7 @@
 }
 
 // compare sills
-int sill_compare(struct int_par *xD, struct flgs *flg, struct var_par *var_par, struct points *pnts)
+void sill_compare(struct int_par *xD, struct flgs *flg, struct var_par *var_par, struct points *pnts)
 {
   // local variables
   double sill_hz = var_par->hz.sill;     // sill in horizontal direction
@@ -198,6 +190,8 @@
     xD->aniso_ratio = var_par->hz.h_range / var_par->vert.h_range;  // anisotropic ratio
     geometric_anisotropy(xD, pnts);                                 // exaggerate z coords and build a new spatial index 
   }
+
+  return 0;
 }
 
 // formulation of variogram functions
@@ -219,7 +213,6 @@
   double radius;   // square distance of the point couple
   double h;
   double vert;
-  double h_ratio;
   double teor_var, result = 0.; // estimated value of the theoretical variogram
 
   int n_cycles = (type == 2 && var_par->function != 5) ? 2 : 1; // # of cycles (bivariate (not linear) or univariate)
@@ -382,7 +375,7 @@
   int n = index->n_values;       // # of selected points
   mat_struct *GM = GM_all;       // whole G matrix
 
-  int i, j, k, N1 = GM->rows, n1 = n+1, *dinR, *dini, *dinj;
+  int i, j, N1 = GM->rows, n1 = n+1, *dinR, *dini, *dinj;
   doublereal *dbo, *dbx, *dbu, *dbl, *md, *mu, *ml, *m1r, *m1c;
 
   mat_struct *sub;               // new submatrix
@@ -453,7 +446,6 @@
 {
   // Local variables
   int i3 = xD->i3;             // interpolation: 2D or 3D
-  int bivar = xD->bivar;       // variogram: uni- or bivariate
   int type = var_par->type;    // variogram: hz / vert / aniso / bivar 
   double *r;                   // xyz coordinates of input points
 
@@ -474,7 +466,6 @@
   int n1 = n + 1;
   
   int i;           // index of elements and length of g0 vector
-  double teor_var; // estimated value based on theoretical variogram and distance of the input points
   double *dr;      // coordinate differences dx, dy, dz between couples of points
   mat_struct *g0;  // vector of estimated differences between known and unknown values 
 
@@ -590,15 +581,13 @@
   double ratio = type == 3 ? xD->aniso_ratio : 1.;    // anisotropic ratio
   mat_struct *GM = var_par->GM;        // GM = theor_var(distances)
  
-  int i, j;
+  int i;
   int n_vals;
-  int n1;
   double max_dist = type == 2 ? var_par->horizontal.max_dist : var_par->max_dist;
   double max_dist_vert = type == 2 ? var_par->vertical.max_dist : var_par->max_dist;
   
   double *search;               // coordinates of the search point
   struct ilist *list;
-  struct RTree_Rect *r_cell;
   mat_struct *GM_sub;
   mat_struct *GM_Inv, *g0, *w0;
   double rslt_OK;
@@ -632,7 +621,7 @@
     n_vals = list->n_values;               // # of overlapping rectangles
 
     if (n_vals > 0 ) { // if positive:
-      correct_indices(i3, list, r, pnts, var_par);
+      correct_indices(list, r, pnts, var_par);
 
       GM_sub = submatrix(list, GM, &xD->report); // create submatrix using indices
       GM_Inv = G_matrix_inverse(GM_sub);         // inverse matrix
@@ -675,7 +664,7 @@
   G_message(_("Cross validation results have been written into <%s>"), crossvalid->name);
 
   if (report->name) {
-    double quant05, quant10, quant25, quant50, quant75, quant90, quant95;
+    double quant95;
     fprintf(report->fp, "\n************************************************\n");
     fprintf(report->fp, "*** Cross validation results ***\n");
 
@@ -683,11 +672,5 @@
     
     fprintf(report->fp, "Quantile of absolute values\n");
     quant95 = quantile(0.95, n, absval, report); 
-    //quant90 = quantile(0.90, n, absval, report);
-    //quant75 = quantile(0.75, n, absval, report);
-    //quant50 = quantile(0.50, n, absval, report); 
-    //quant25 = quantile(0.25, n, absval, report);
-    //quant10 = quantile(0.10, n, absval, report);
-    //quant05 = quantile(0.05, n, absval, report);
   }
 }

Modified: grass-addons/grass7/vector/v.kriging/utils_write.c
===================================================================
--- grass-addons/grass7/vector/v.kriging/utils_write.c	2015-07-08 04:13:49 UTC (rev 65544)
+++ grass-addons/grass7/vector/v.kriging/utils_write.c	2015-07-08 11:43:17 UTC (rev 65545)
@@ -210,7 +210,7 @@
   double *gamma = var_pars->gamma->vals;
   double sill = var_pars->sill;
 
-  int i, j; // index
+  int i; // index
   FILE *fp;
   int file_length;
   



More information about the grass-commit mailing list