[med-svn] [Git][med-team/cufflinks][master] More patches, not finalised

Andreas Tille (@tille) gitlab at salsa.debian.org
Sun Dec 7 09:18:56 GMT 2025



Andreas Tille pushed to branch master at Debian Med / cufflinks


Commits:
f196f271 by Andreas Tille at 2025-12-07T10:18:34+01:00
More patches, not finalised

- - - - -


1 changed file:

- debian/patches/gcc15.patch


Changes:

=====================================
debian/patches/gcc15.patch
=====================================
@@ -5,7 +5,41 @@ Description: Build with gcc-15
 
 --- a/src/locfit/lffuns.h
 +++ b/src/locfit/lffuns.h
-@@ -105,7 +105,7 @@ extern int ident, locfit(), lf_iter();
+@@ -4,8 +4,10 @@
+ /* FILES IN THE src DIRECTORY */
+ 
+ /* adap.c */
+-extern double afit(), aband2(), aband3();
+-extern INT ainitband();
++extern double afit();
++extern double aband2(design *des, lfit *lf, double h0);
++extern double aband3(design *des, lfit *lf, double h0);
++extern INT ainitband(design *des, lfit *lf);
+ 
+ /* band.c */
+ extern void band(), kdeselect();
+@@ -86,8 +88,9 @@ extern void setstrval();
+ extern INT ppwhat(), restyp();
+ 
+ /* lf_vari.c */
+-extern void comp_vari(), local_df();
+-extern double comp_infl();
++extern void comp_vari(lfit *lf, design *des, double *tr, double *t0);
++extern void local_df(lfit *lf, design *des, double *tr);
++extern double comp_infl(lfit *lf, design *des);
+ 
+ /* linalg.c */
+ extern void svd(), hsvdsolve();
+@@ -99,19 +102,23 @@ extern double innerprod(), m_trace();
+ extern INT svdsolve();
+ 
+ /* locfit.c or parfit.c (most) */
+-extern int ident, locfit(), lf_iter();
++extern int ident;
++extern int locfit(lfit *lf, design *des, double h, int noit);
++extern int lf_iter();
+ 
+ /* math.c */
  extern double lflgamma(), lferf(), lferfc(), lfdaws();
  extern double ptail(), logit(), expit();
  //extern double lgamma(), erf(), erfc();
@@ -14,7 +48,16 @@ Description: Build with gcc-15
  
  /* minmax.c */
  extern double ipower(), minmax();
-@@ -148,8 +148,9 @@ extern int stm(), pmatch(), matchlf(), m
+ 
+ /* nbhd.c */
+-extern double kordstat(), nbhd(), rho();
++extern double kordstat(double *x, INT k, INT n, INT *ind);
++extern double nbhd(lfit *lf, design *des, double fxh, INT redo, INT nn);
++extern double rho(double *x, double *sc, INT d, INT kt, INT *sty);
+ 
+ /* odint.c */
+ extern INT onedint();
+@@ -148,8 +155,9 @@ extern int stm(), pmatch(), matchlf(), m
  extern void strip();
  
  /* wdiag.c */
@@ -28,7 +71,31 @@ Description: Build with gcc-15
  extern double W(), weight(), weightd(), Wd(), Wdd(), wint();
 --- a/src/locfit/wdiag.c
 +++ b/src/locfit/wdiag.c
-@@ -56,11 +56,7 @@ INT n, m, *ind;
+@@ -18,11 +18,7 @@ static double *wd;
+ extern double robscale;
+ extern void unitvec();
+ 
+-void nnresproj(lf,des,u,m,p,mi)
+-lfit *lf;
+-design *des;
+-double *u;
+-INT m, p, *mi;
++void nnresproj(lfit *lf, design *des, double *u, INT m, INT p, INT *mi)
+ { INT i, j;
+   double link[LLEN];
+   setzero(des->f1,p);
+@@ -35,9 +31,7 @@ INT m, p, *mi;
+     u[i] -= innerprod(des->f1,d_xi(des,i),p)*des->w[i];
+ }
+ 
+-void wdexpand(l,n,ind,m)
+-double *l;
+-INT n, m, *ind;
++void wdexpand(double *l, INT n, INT m, INT *ind)
+ { INT i, j, t;
+   double z;
+   for (j=m; j<n; j++) { l[j] = 0.0; ind[j] = -1; }
+@@ -56,11 +50,7 @@ INT n, m, *ind;
    { l[i] = ((j>=0) && (ind[j]==i)) ? l[j--] : 0.0; } */
  }
  
@@ -41,7 +108,20 @@ Description: Build with gcc-15
  { INT i, j, p, *mi, *deriv, nd;
    double *l1;
    mi = lf->mi; p = des->p;
-@@ -221,10 +217,7 @@ INT deg, ty, exp;
+@@ -95,11 +85,7 @@ INT deg, ty, exp;
+   return(p);
+ }
+ 
+-INT wdiag(lf,des,lx,deg,ty,exp)
+-lfit *lf;
+-design *des;
+-double *lx;
+-INT deg, ty, exp;
++INT wdiag(lfit *lf, design *des, double *lx, INT deg, INT ty, INT exp)
+ /* deg=0: l(x) only.
+    deg=1: l(x), l'(x) (approx/exact ? mi[MDC] );
+    deg=2: l(x), l'(x), l''(x);
+@@ -221,10 +207,7 @@ INT deg, ty, exp;
    return(m);
  }
  
@@ -53,7 +133,7 @@ Description: Build with gcc-15
  { INT k = 0, n;
    double *l;
    n = (ident==0) ? lf->mi[MN] : des->p;
-@@ -238,8 +231,7 @@ INT v;
+@@ -238,8 +221,7 @@ INT v;
  extern lfit lf;
  extern design des;
  
@@ -65,11 +145,12 @@ Description: Build with gcc-15
    i = getarg(v,"ev",0);
 --- a/src/locfit/adap.c
 +++ b/src/locfit/adap.c
-@@ -11,11 +11,12 @@
+@@ -11,11 +11,13 @@
  */
  
  #include "local.h"
 +extern INT wdiagp(lfit *lf, design *des, double *lx, INT deg, INT ty, INT exp);
++extern INT wdiag(lfit *lf, design *des, double *lx, INT deg, INT ty, INT exp);
 +extern int factorial(int n);
  
  static double hmin;
@@ -80,7 +161,7 @@ Description: Build with gcc-15
  { double y;
  /* return(-2*lk/(t0*exp(pen*log(1-t2/t0)))); */
    /* return((-2*lk+pen*t2)/t0); */
-@@ -23,9 +24,7 @@ double lk, t0, t2, pen;
+@@ -23,9 +25,7 @@ double lk, t0, t2, pen;
    return(y);
  }
  
@@ -91,7 +172,7 @@ Description: Build with gcc-15
  { int i, ii, j, p, p1;
    double sv, sb, *l, dp;
    l = des->wd;
-@@ -52,9 +51,7 @@ static double mcp, clo, cup;
+@@ -52,9 +52,7 @@ static double mcp, clo, cup;
    or DFXH components)
  */
  
@@ -102,7 +183,7 @@ Description: Build with gcc-15
  { INT lf_status = LF_OK, p, z, cri, noit, redo;
    double h, ho, t[6];
    p = des->p;
-@@ -98,10 +95,7 @@ lfit   *lf;
+@@ -98,10 +96,7 @@ lfit   *lf;
    each iteration.
  */
  
@@ -114,7 +195,7 @@ Description: Build with gcc-15
  { double t[6], h, h1, nu1, cp, ncp, tlo, tup;
    INT d, inc, n, p, done;
    d = lf->mi[MDIM]; n = lf->mi[MN]; p = lf->mi[MP];
-@@ -149,10 +143,7 @@ double h0;
+@@ -149,10 +144,7 @@ double h0;
    aband3 does a finer search around best h so far. Try
    h*(1-0.2/d), h/(1-0.1/d), h*(1+0.1/d), h*(1+0.2/d)
  */
@@ -205,3 +286,204 @@ Description: Build with gcc-15
  { if (n<=1) return(1.0);
    return(n*factorial(n-1));
  }
+--- a/src/locfit/locfit.c
++++ b/src/locfit/locfit.c
+@@ -13,8 +13,7 @@ int ident=0;
+ int (*like)();
+ extern double robscale;
+ 
+-int likereg(coef, lk0, f1, Z)
+-double *coef, *lk0, *f1, *Z;
++int likereg(double *coef, double *lk0, double *f1, double *Z)
+ { INT i, ii, j, p, *mi;
+     double lk, ww, link[LLEN], *X;
+     lf_status = LF_OK;
+@@ -76,9 +75,7 @@ double *coef, *lk0, *f1, *Z;
+     return(NR_OK);
+ }
+ 
+-INT robustinit(lf,des)
+-lfit *lf;
+-design *des;
++INT robustinit(lfit *lf, design *des)
+ { int i;
+     for (i=0; i<des->n; i++)
+         des->res[i] = resp(lf,des->ind[i])-base(lf,des->ind[i]);
+@@ -88,9 +85,7 @@ design *des;
+     return(LF_OK);
+ }
+ 
+-INT circinit(lf,des)
+-lfit *lf;
+-design *des;
++INT circinit(lfit *lf, design *des)
+ { int i, ii;
+     double s0, s1;
+     s0 = s1 = 0.0;
+@@ -105,9 +100,7 @@ design *des;
+     return(LF_OK);
+ }
+ 
+-INT reginit(lf,des)
+-lfit *lf;
+-design *des;
++INT reginit(lfit *lf, design *des)
+ { int i, ii;
+     double sb, link[LLEN];
+     s0 = s1 = sb = 0;
+@@ -162,9 +155,7 @@ design *des;
+     }
+ }
+ 
+-int lfinit(lf,des)
+-lfit *lf;
+-design *des;
++int lfinit(lfit *lf, design *des)
+ { 
+     //double u[MXDIM];
+     INT *mi;
+@@ -192,9 +183,7 @@ design *des;
+     }
+ }
+ 
+-void lfiter(lf,des)
+-lfit *lf;
+-design *des;
++void lfiter(lfit *lf, design *des)
+ { int err;
+     max_nr(like, des->cf, des->oc, des->res, des->f1,
+            &des->xtwx, (int)des->p, (int)lf->mi[MMXIT], tol, &err);
+@@ -216,11 +205,7 @@ int use_robust_scale(int tg)
+     return(1);
+ }
+ 
+-int locfit(lf,des,h,noit)
+-lfit *lf;
+-design *des;
+-double h;
+-int noit;
++int locfit(lfit *lf, design *des, double h, int noit)
+ { int i, p;
+     
+     if (lf->mi[MDEB]>0)
+--- a/src/locfit/nbhd.c
++++ b/src/locfit/nbhd.c
+@@ -12,9 +12,8 @@
+ 
+ extern vari *vb;
+ 
+-double rho(x,sc,d,kt,sty) /* ||x|| for appropriate distance metric */
+-double *x, *sc;
+-INT d, kt, *sty;
++/* ||x|| for appropriate distance metric */
++double rho(double *x, double *sc, INT d, INT kt, INT *sty)
+ { double rhoi[MXDIM], s;
+   INT i;
+   for (i=0; i<d; i++)
+@@ -48,9 +47,7 @@ INT d, kt, *sty;
+   return(0.0);
+ }
+ 
+-double kordstat(x,k,n,ind)
+-double *x;
+-INT k, n, *ind;
++double kordstat(double *x, INT k, INT n, INT *ind)
+ { INT i, i0, i1, l, r;
+   double piv;
+   if (k<1) return(0.0);
+@@ -75,10 +72,7 @@ INT k, n, *ind;
+ }
+ 
+ /* check if i'th data point is in limits */
+-INT inlim(lf,xlim,i,d)
+-lfit *lf;
+-double *xlim;
+-INT i, d;
++INT inlim(lfit *lf, double *xlim, INT i, INT d)
+ { INT j, k;
+   k = 1;
+   for (j=0; j<d; j++)
+@@ -88,9 +82,7 @@ INT i, d;
+   return(k);
+ }
+ 
+-double compbandwid(di,ind,x,n,d,nn,fxh)
+-double *di, *x, fxh;
+-INT n, d, *ind, nn;
++double compbandwid(double *di, double *x, doubla fxh, INT n, INT d, INT *ind, INT nn)
+ { INT i;
+   double nnh;
+ 
+@@ -114,11 +106,7 @@ INT n, d, *ind, nn;
+ /*
+   fast version of nbhd for ordered 1-d data
+ */
+-double nbhd1(lf,des,k,fxh)
+-lfit *lf;
+-design *des;
+-INT k;
+-double fxh;
++double nbhd1(lfit *lf, design *des, INT k, double fxh)
+ { double x, h, *xd;
+   INT i, l, r, m, n, z;
+   n = lf->mi[MN];
+@@ -181,11 +169,7 @@ double fxh;
+   return(h);
+ }
+ 
+-double nbhd(lf,des,nn,fxh,redo)
+-lfit *lf;
+-design *des;
+-double fxh;
+-INT redo, nn;
++double nbhd(lfit *lf, design *des, double fxh, INT redo, INT nn)
+ { INT d, i, j, m, n, *mi;
+   double h, u[MXDIM];
+ 
+--- a/src/locfit/lf_vari.c
++++ b/src/locfit/lf_vari.c
+@@ -18,10 +18,7 @@ extern double robscale;
+   M12 = (X^T W V X)^{-1} M2
+   Also, for convenience, tr[0] = sum(wi) tr[1] = sum(wi^2).
+ */
+-void vmat(lf, des, M12, M2, tr)
+-lfit *lf;
+-design *des;
+-double *M12, *M2, *tr;
++void vmat(lfit *lf, design *des, double *M12, double *M2, double *tr)
+ { INT i, p, nk, ok;
+   double link[LLEN], h, ww;
+   p = des->p;
+@@ -72,18 +69,13 @@ double *M12, *M2, *tr;
+  * Results stored in des->f1.
+  * This assumes weight function is scaled so that W(0)=1.0.
+  */
+-double comp_infl(lf,des)
+-lfit *lf;
+-design *des;
++double comp_infl(lfit *lf, design *des)
+ { unitvec(des->f1,0,des->p);
+   jacob_solve(&des->xtwx,des->f1);
+   return(des->f1[0]);
+ }
+ 
+-void comp_vari(lf,des,tr,t0)
+-lfit *lf;
+-design *des;
+-double *tr, *t0;
++void comp_vari(lfit *lf, design *des, double *tr, double *t0)
+ { int i, j, k, p;
+   double *M12, *M2;
+   M12 = des->V; M2 = des->P; p = des->p;
+@@ -120,10 +112,7 @@ double *tr, *t0;
+  *   tr[4] = trace( (M1^{-1} M2)^2 )
+  *   tr[5] = var(theta-hat).
+  */
+-void local_df(lf,des,tr)
+-lfit *lf;
+-design *des;
+-double *tr;
++void local_df(lfit *lf, design *des, double *tr)
+ { int i, j, p;
+   double *m2, *V, ww, link[LLEN];
+ 



View it on GitLab: https://salsa.debian.org/med-team/cufflinks/-/commit/f196f2715ade8164355cc2ba8db1f12340fec5bc

-- 
View it on GitLab: https://salsa.debian.org/med-team/cufflinks/-/commit/f196f2715ade8164355cc2ba8db1f12340fec5bc
You're receiving this email because of your account on salsa.debian.org.


-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://alioth-lists.debian.net/pipermail/debian-med-commit/attachments/20251207/38a3a015/attachment-0001.htm>


More information about the debian-med-commit mailing list