* installing *source* package ‘locfit’ ... ** package ‘locfit’ successfully unpacked and MD5 sums checked ** using staged installation ** libs using C compiler: ‘Apple clang version 14.0.3 (clang-1403.0.22.14.1)’ using SDK: ‘MacOSX11.3.sdk’ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c S_enter.c -o S_enter.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c band.c -o band.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c dbinom.c -o dbinom.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c dens_haz.c -o dens_haz.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c dens_int.c -o dens_int.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c dens_odi.c -o dens_odi.o S_enter.c:257:22: warning: passing arguments to 'lfkernel' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MKER] = lfkernel(str[0]); ^ S_enter.c:258:22: warning: passing arguments to 'lffamily' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MTG] = lffamily(str[1]); ^ S_enter.c:259:20: warning: passing arguments to 'lflink' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MLINK]= lflink(str[2]); ^ S_enter.c:261:20: warning: passing arguments to 'lfacri' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MACRI]= lfacri(str[4]); ^ S_enter.c:262:22: warning: passing arguments to 'lfketype' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MKT] = lfketype(str[5]); ^ S_enter.c:271:13: warning: passing arguments to 'lfit_alloc' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lfit_alloc(&lf); ^ S_enter.c:306:8: warning: passing arguments to 'scb' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] scb(&des,&lf); ^ S_enter.c:312:16: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { startlf(&des,&lf,procv,0); ^ S_enter.c:313:31: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (!lf_error) ressumm(&lf,&des); ^ S_enter.c:315:19: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] else startlf(&des,&lf,procvvord,0); ^ S_enter.c:318:14: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(&des,&lf,procvraw,0); ^ S_enter.c:321:14: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(&des,&lf,procvhatm,(int)mi[MKER]!=WPARM); ^ S_enter.c:324:16: warning: passing arguments to 'constants' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] constants(&des,&lf); ^ S_enter.c:328:12: warning: passing arguments to 'rband' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] rband(&des,&lf,kap,lf.dv.deriv,lf.dv.nd); ^ S_enter.c:331:14: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(&des,&lf,procv,1); ^ S_enter.c:332:16: warning: passing arguments to 'dens_lscv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dens_lscv(&des,&lf); ^ S_enter.c:425:22: warning: passing arguments to 'pc_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf.pc.lwk = pc_reqd(mi[MDIM],p); ^ S_enter.c:426:8: warning: passing arguments to 'pcchk' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] pcchk(&lf.pc,(int)mi[MDIM],p,0); ^ S_enter.c:452:51: warning: passing arguments to 'ppwhat' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] preplot(&lf,xx,res,se,what[1][0],m,*where,ppwhat(what[0])); ^ S_enter.c:479:21: warning: passing arguments to 'pc_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf.pc.lwk= pc_reqd(mi[MDIM],mi[MP],0); ^ S_enter.c:480:8: warning: passing arguments to 'pcchk' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] pcchk(&lf.pc,mi[MDIM],mi[MP],0); ^ S_enter.c:487:24: warning: passing arguments to 'ppwhat' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitted(&lf,fit,ppwhat(what[0]),*cv,*st,restyp(what[1])); ^ S_enter.c:487:48: warning: passing arguments to 'restyp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitted(&lf,fit,ppwhat(what[0]),*cv,*st,restyp(what[1])); ^ S_enter.c:487:9: warning: passing arguments to 'fitted' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitted(&lf,fit,ppwhat(what[0]),*cv,*st,restyp(what[1])); ^ S_enter.c:515:15: warning: passing arguments to 'atree_grow' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] atree_grow(NULL, &lf, lf.evs.ce, nt, term, box, &box[d]); ^ S_enter.c:519:18: warning: passing arguments to 'triang_grow' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] triang_grow(NULL,&lf,&lf.evs.ce[i*vc],nt,term); ^ In file included from S_enter.c:14: In file included from ./local.h:107: ./lffuns.h:51:23: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void trchck(), guessnv(), lfit_alloc(); ^ void S_enter.c:523:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void guessnv(int *lw, char **evt, double *dp, int *mi, int *nvc, int *mg) ^ S_enter.c:531:31: warning: passing arguments to 'lfevstr' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MEV] = ev(&evs) = lfevstr(evt[0]); ^ S_enter.c:532:21: warning: passing arguments to 'lfketype' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MKT] = lfketype(evt[1]); ^ S_enter.c:540:20: warning: passing arguments to 'atree_guessnv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] atree_guessnv(&evs,&nvm,&ncm,&vc,d,dp[DALP]); ^ S_enter.c:554:20: warning: passing arguments to 'kdtre_guessnv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] kdtre_guessnv(&evs,&nvm,&ncm,&vc,n,d,dp[DALP]); ^ S_enter.c:579:17: warning: passing arguments to 'calcp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] mi[MP] = calcp(&sp,d); ^ S_enter.c:580:19: warning: passing arguments to 'des_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lw[0] = des_reqd(n,(int)mi[MP]); ^ S_enter.c:581:20: warning: passing arguments to 'lfit_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lw[1] = lfit_reqd(d,nvm,ncm,(int)mi[MGETH]); ^ S_enter.c:582:20: warning: passing arguments to 'lfit_reqi' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lw[2] = lfit_reqi(nvm,ncm,vc); ^ S_enter.c:583:19: warning: passing arguments to 'des_reqi' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lw[6] = des_reqi(n,(int)mi[MP]); ^ S_enter.c:584:18: warning: passing arguments to 'pc_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lw[3] = pc_reqd(d,(int)mi[MP]); ^ S_enter.c:588:20: warning: passing arguments to 'k0_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { lw[4] = k0_reqd(d,n,0); ^ S_enter.c:596:32: warning: passing arguments to 'k0_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case GKAP: lw[4] = k0_reqd(d,n,0); /* kappa0 */ ^ band.c:20:15: warning: passing arguments to 'procvraw' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] k = procvraw(des,lf,v); ^ band.c:21:8: warning: passing arguments to 'wdiag' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wdiag(&lf->lfd, &lf->sp, des,des->wd,&lf->dv,0,1,0); ^ band.c:26:50: warning: passing arguments to 'ipower' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] bi = prwt(&lf->lfd,ii)*fabs(des->wd[i]*ipower(des->di[ii],deg(&lf->sp)+1)); ^ band.c:48:22: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (cri<64) startlf(bdes,blf,pv,0); ^ band.c:51:14: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ressumm(blf,bdes); ^ band.c:56:14: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ressumm(blf,bdes); ^ band.c:112:34: warning: passing arguments to 'factorial' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (cri==BIND) pen /= factorial(deg(&lf->sp)+1); ^ band.c:135:10: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procv,0); ^ band.c:136:10: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ressumm(lf,des); ^ band.c:144:12: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ik = wint(1,NULL,0,WGAUS); ^ band.c:150:30: warning: passing arguments to 'Wconv4' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] sd += (2-(i==j))*Wconv4(z,WGAUS)/(ik*ik); ^ band.c:163:12: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ik = wint(1,NULL,0,WGAUS); ^ band.c:169:30: warning: passing arguments to 'Wconv6' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] td += (2-(i==j))*Wconv6(z,WGAUS)/(ik*ik); ^ band.c:174:14: warning: passing arguments to 'Wconv4' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] c1 = Wconv4(0.0,WGAUS); ^ band.c:175:12: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] c2 = wint(1,&j,1,WGAUS); ^ band.c:176:13: warning: passing arguments to 'Wconv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] c3 = Wconv(0.0,WGAUS); /* (2*c1/(c2*c3))^(1/7)=1.357 */ ^ In file included from band.c:6: In file included from ./local.h:107: ./lffuns.h:16:34: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void band(), kdeselect(), kdecri(); ^ void band.c:182:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void kdecri(double *x, double h, double *res, double c, int k, int ker, int n) ^ band.c:191:12: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ik = wint(1,NULL,0,ker); ^ band.c:199:18: warning: passing arguments to 'W' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] r0 += W(s,ker); ^ band.c:200:23: warning: passing arguments to 'Wd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] d0 += s*s*Wd(s,ker); ^ band.c:204:35: warning: passing arguments to 'W' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] res[0] += -2*log(r0)+pen*W(0.0,ker)/(n*h*ik*r0); ^ band.c:205:33: warning: passing arguments to 'W' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] res[1] += -2*d0/r0-pen*W(0.0,ker)/(n*h*ik*r0)*(d0/r0+1.0/h); ^ band.c:213:18: warning: passing arguments to 'W' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] r0 += W(s,ker); ^ band.c:214:23: warning: passing arguments to 'Wd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] d0 += s*s*Wd(s,ker); ^ band.c:228:18: warning: passing arguments to 'W' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wij = W(s,ker); ^ band.c:239:22: warning: passing arguments to 'Wconv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] r0 += Wconv(s,ker); ^ band.c:240:28: warning: passing arguments to 'Wconv1' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] d0 += -s*s*Wconv1(s,ker); ^ band.c:243:26: warning: passing arguments to 'Wd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] d1 += -s*s*Wd(s,ker); ^ band.c:259:25: warning: passing arguments to 'Wconv4' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] r0 += 2*Wconv4(s,ker); ^ band.c:260:27: warning: passing arguments to 'Wconv5' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] d0 += 2*s*Wconv5(s,ker); ^ band.c:265:16: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] d1 = wint(1,&j,1,ker); ^ band.c:266:17: warning: passing arguments to 'Wconv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] r1 = Wconv(0.0,ker); ^ band.c:274:28: warning: passing arguments to 'Wikk' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] res[1] = exp(log(Wikk(WGAUS,0)/(d0*n))/5)-h; ^ band.c:280:28: warning: passing arguments to 'Wikk' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] res[1] = exp(log(Wikk(WGAUS,0)/(d0*n))/5)-h; ^ In file included from band.c:6: In file included from ./local.h:107: ./lffuns.h:16:21: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void band(), kdeselect(), kdecri(); ^ void band.c:334:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void kdeselect(double *band, double *x, Sint *ind, double h0, double h1, ^ band.c:343:19: warning: passing arguments to 'kordstat' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] scale = kordstat(x,n+1-k,n,ind) - kordstat(x,k,n,ind); ^ band.c:343:45: warning: passing arguments to 'kordstat' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] scale = kordstat(x,n+1-k,n,ind) - kordstat(x,k,n,ind); ^ dens_haz.c:56:16: warning: passing arguments to 'weight' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wt = weight(haz_lfd, haz_sp, dfx, NULL, h, 0, 0.0); ^ dens_haz.c:57:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(haz_lfd, haz_sp, dfx,NULL,ff,NULL); ^ dens_haz.c:138:21: warning: passing arguments to 'onedint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { st = onedint(haz_sp,ncf,ilim[0]/hs,il1/hs,prod_wk[0]); ^ dens_haz.c:154:31: warning: passing arguments to 'W' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] prod_wk[j][0] = ef * W(dfx[j]/(h*haz_lfd->sca[j]),ker(haz_sp)); ^ dens_haz.c:160:18: warning: passing arguments to 'prodintresp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] prodintresp(resp,prod_wk,d,deg(haz_sp),p); ^ In file included from dens_haz.c:25: In file included from ./local.h:107: ./lffuns.h:26:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int hazint(); ^ void dens_haz.c:171:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int hazint(double *t, double *resp, double *resp1, double *cf, double h) ^ In file included from dens_haz.c:25: In file included from ./local.h:107: ./lffuns.h:25:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void haz_init(); ^ void dens_haz.c:179:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void haz_init(lfdata *lfd, design *des, smpar *sp, double *il) ^ dens_odi.c:65:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y0 = lf_exp(cf[0]+l0*cf[1]); ^ dens_odi.c:66:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = lf_exp(cf[0]+l1*cf[1]); ^ dens_odi.c:127:16: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { bi = lf_exp(cf[0]+cf[1]*d+cf[2]*d*d)/c; ^ dens_odi.c:129:33: warning: passing arguments to 'ptail' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { if (a0>6) I[0] = (y0*ptail(-a0)-y1*ptail(-a1))/c; ^ dens_odi.c:129:47: warning: passing arguments to 'ptail' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { if (a0>6) I[0] = (y0*ptail(-a0)-y1*ptail(-a1))/c; ^ dens_odi.c:133:35: warning: passing arguments to 'ptail' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { if (a1< -6) I[0] = (y1*ptail(a1)-y0*ptail(a0))/c; ^ dens_odi.c:133:48: warning: passing arguments to 'ptail' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { if (a1< -6) I[0] = (y1*ptail(a1)-y0*ptail(a0))/c; ^ dens_odi.c:138:16: warning: passing arguments to 'lfdaws' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] I[0] = (y1*daws(a1)-y0*daws(a0))/c; ^ ./local.h:40:23: note: expanded from macro 'daws' #define daws(x) lfdaws(x) ^ dens_odi.c:138:28: warning: passing arguments to 'lfdaws' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] I[0] = (y1*daws(a1)-y0*daws(a0))/c; ^ ./local.h:40:23: note: expanded from macro 'daws' #define daws(x) lfdaws(x) ^ dens_odi.c:157:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype]In file included from dens_int.c:21: In file included from ./local.h:107: ./lffuns.h:30:41: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dens_renorm(), dens_lscv(), lforder(); ^ void dens_int.c:29:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void lforder(Sint *ind, double *x, int l, int r) ^ dens_int.c:85:11: warning: passing arguments to 'recurint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] recurint(0.0,dlt,cf,I,0,WRECT); ^ dens_int.c:91:11: warning: passing arguments to 'recurint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] recurint(0.0,dlt,cf,I,0,WRECT); ^ In file included from dens_int.c:21: In file included from ./local.h:107: ./lffuns.h:29:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double dens_integrate(); ^ void dens_int.c:102:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double dens_integrate(lfit *lf, design *des, int z) ^ In file included from dens_int.c:21: In file included from ./local.h:107: ./lffuns.h:30:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dens_renorm(), dens_lscv(), lforder(); ^ void dens_int.c:184:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void dens_renorm(lfit *lf, design *des) ^ In file included from dens_int.c:21: In file included from ./local.h:107: ./lffuns.h:30:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dens_renorm(), dens_lscv(), lforder(); ^ void dens_int.c:194:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void dens_lscv(design *des, lfit *lf) ^ dens_int.c:207:37: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fh = base(&lf->lfd,i)+dointpoint(lf,x,PCOEF,evo,i); ^ dens_int.c:209:22: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] infl = dointpoint(lf,x,PT0,evo,i); ^ y0 = lf_exp(cf[0]+l0*(cf[1]+l0*cf[2])); ^ dens_odi.c:158:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = lf_exp(cf[0]+l1*(cf[1]+l1*cf[2])); ^ dens_odi.c:197:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y0 = lf_exp(cf[0]+l0*(cf[1]+cf[2]*l0)); ^ dens_odi.c:198:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = lf_exp(cf[0]+l1*(cf[1]+cf[2]*l1)); ^ dens_odi.c:215:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y0 = lf_exp(cf[0]+l0*l0*cf[2]); ^ dens_odi.c:216:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = lf_exp(cf[0]+l1*l1*cf[2]); ^ dens_odi.c:266:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y0 = lf_exp(cf[0]+l0*(cf[1]+l0*cf[2])); ^ dens_odi.c:267:14: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = lf_exp(cf[0]+l1*(cf[1]+l1*cf[2])); ^ In file included from dens_odi.c:19: In file included from ./local.h:107: ./lffuns.h:109:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void recurint(); ^ void dens_odi.c:307:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void recurint(double l0, double l2, double *cf, double *resp, int p, int ker) ^ dens_odi.c:315:16: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { s = wtaylor(wt,0.0,ker); ^ dens_odi.c:331:16: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] s = wtaylor(wt,l0,ker); ^ dens_odi.c:340:16: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] s = wtaylor(wt,l0,ker); ^ dens_odi.c:351:18: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { s = wtaylor(wt,l1,ker); ^ dens_odi.c:367:18: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { s = wtaylor(wt,l1,ker); ^ dens_odi.c:379:18: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { s = wtaylor(wt,l0,ker); ^ dens_odi.c:386:18: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { s = wtaylor(wt,l2,ker); ^ dens_odi.c:398:16: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { s = wtaylor(wt,l2,ker); ^ dens_odi.c:411:14: warning: passing arguments to 'wtaylor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] s = wtaylor(wt,l0,ker); ^ In file included from dens_odi.c:19: In file included from ./local.h:107: ./lffuns.h:108:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int onedint(); ^ void dens_odi.c:463:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int onedint(smpar *sp, double *cf, double l0, double l1, double *resp) /* int W(u)u^j exp(..), j=0..2*deg */ ^ dens_odi.c:504:12: warning: passing arguments to 'W' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] W(fabs(u),ker(sp))*exp(MIN(y,300.0)); ^ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c density.c -o density.o In file included from density.c:6: In file included from ./local.h:107: ./lffuns.h:21:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void prodintresp(), prresp(); ^ void density.c:23:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void prresp(double *coef, double *resp, int p) ^ density.c:40:14: warning: passing arguments to 'weight' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wt = weight(den_lfd, den_sp, u, NULL, hh, 0, 0.0); ^ density.c:46:9: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(den_lfd, den_sp, u,NULL,ff,NULL); ^ density.c:48:17: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wt *= lf_exp(innerprod(ff,cff,p)); ^ density.c:65:11: warning: passing arguments to 'simpsonm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] simpsonm(mif,ilim,&ilim[d],d,resp1,mg,resp2); ^ density.c:80:20: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] resp1[0] = wint(d,NULL,0,ker(den_sp))*hd; ^ density.c:82:25: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jj[0] = 2; w0 = wint(d,jj,1,ker(den_sp))*hd*h*h; ^ density.c:91:16: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] w0 = wint(d,jj,2,ker(den_sp)) * hd*h*h*h*h; ^ density.c:94:14: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] w1 = wint(d,jj,1,ker(den_sp)) * hd*h*h*h*h/4; ^ density.c:111:24: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] resp1[0] = lf_exp(cf[0])*wint(d,NULL,0,ker(den_sp))*hd; ^ density.c:111:36: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] resp1[0] = lf_exp(cf[0])*wint(d,NULL,0,ker(den_sp))*hd; ^ density.c:121:22: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] g[0] = lf_exp(cf[0]+w0*nb/2+d*log(S2PI/2.5)); ^ density.c:126:25: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { wt = wu = lf_exp(cf[0]); ^ density.c:127:18: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] w0 = wint(d,NULL,0,ker(den_sp)); g[0] = wt*w0; ^ density.c:132:33: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jj[0] = 2*j; w0 = wint(d,jj,1,ker(den_sp)); ^ density.c:135:48: warning: passing arguments to 'wint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { jj[0] = 2; jj[1] = 2*j-2; w1 = wint(d,jj,2,ker(den_sp)); ^ In file included from density.c:6: In file included from ./local.h:107: ./lffuns.h:21:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void prodintresp(), prresp(); ^ void density.c:162:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void prodintresp(double *resp, double prod_wk[MXDIM][2*MXDEG+1], int dim, int deg, int p) ^ 9 warnings generated. density.c:209:17: warning: passing arguments to 'onedint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] st = onedint(den_sp,cf,ilim[i]/hs,ilim[i+dim]/hs,prod_wk[i]); ^ density.c:243:10: warning: passing arguments to 'eig_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] eig_dec(C,P,d); ^ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c ev_atree.c -o ev_atree.o density.c:277:13: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] z = lf_exp(d*0.918938533+cf[0]+nb/2)/det; ^ In file included from density.c:6: In file included from ./local.h:107: ./lffuns.h:19:24: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int densinit(), likeden(); ^ void density.c:282:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int likeden(double *coef, double *lk0, double *f1, double *A) ^ density.c:289:31: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf_status = (den_des->itype)(den_des->xev,A,den_des->xtwx.Q,coef,den_des->h); ^ density.c:380:18: warning: passing arguments to 'iscompact' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (iscompact(ker(den_sp))) ^ density.c:403:19: warning: passing arguments to 'iscompact' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (!iscompact(ker(den_sp))) return(INVLD); ^ density.c:412:24: warning: passing arguments to 'iscompact' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return( iscompact(ker(den_sp)) ? IMULT : INVLD ); ^ In file included from density.c:6: In file included from ./local.h:107: ./lffuns.h:19:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int densinit(), likeden(); ^ void density.c:421:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int densinit(lfdata *lfd, design *des, smpar *sp, double *cf) ^ density.c:470:34: warning: passing arguments to 'haz_init' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (fam(den_sp)==THAZ) haz_init(lfd,des,sp,ilim); ^ 12 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c ev_interp.c -o ev_interp.o In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:38:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double linear_interp(), cubic_interp(), rectcell_interp(); ^ void ev_interp.c:8:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double linear_interp(double h, double d, double f0, double f1) ^ In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:40:25: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void exvvalpv(), hermite2(); ^ void ev_interp.c:14:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void hermite2(double x, double z, double *phi) ^ In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:38:32: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double linear_interp(), cubic_interp(), rectcell_interp(); ^ void ev_interp.c:38:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double cubic_interp(double h, double f0, double f1, double d0, double d1) ^ In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:37:29: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double dointpoint(), cubintd(); ^ void ev_interp.c:45:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double cubintd(double h, double f0, double f1, double d0, double d1) ^ In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:38:48: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double linear_interp(), cubic_interp(), rectcell_interp(); ^ void ev_interp.c:64:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double rectcell_interp(double *x, double vv[64][64], double *ll, double *ur, int d, int nc) ^ In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:39:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int exvval(); ^ void ev_interp.c:113:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int exvval(fitpt *fp, double *vv, int nv, int d, int what, int z) ^ In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:40:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void exvvalpv(), hermite2(); ^ void ev_interp.c:159:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void exvvalpv(double *vv, double *vl, double *vr, int d, int k, double dl, int nc) ^ In file included from ev_atree.c:10: In file included from ./local.h:107: ./lffuns.h:33:42: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void atree_start(), atree_grow(), atree_guessnv(); ^ void ev_atree.c:16:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void atree_guessnv(evstruc *evs, int *nvm, int *ncm, int *vc, int d, double alp) ^ In file included from ev_interp.c:6: In file included from ./local.h:107: ./lffuns.h:37:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double dointpoint(), cubintd(); ^ void ev_interp.c:227:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double dointpoint(lfit *lf, double *x, int what, int ev, int j) ^ ev_interp.c:242:30: warning: passing arguments to 'kdtre_int' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case EKDTR: f = kdtre_int(fp,evs,x,what); break; ^ ev_interp.c:243:30: warning: passing arguments to 'atree_int' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case ETREE: f = atree_int(lf,x,what); break; ^ ev_interp.c:244:32: warning: passing arguments to 'triang_int' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case EPHULL: f = triang_int(lf,x,what); break; ^ ev_interp.c:248:31: warning: passing arguments to 'sphere_int' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case ESPHR: f = sphere_int(lf,x,what); break; ^ ev_interp.c:252:18: warning: passing arguments to 'addparcomp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] f += addparcomp(lf,x,what); ^ In file included from ev_atree.c:10: In file included from ./local.h:107: ./lffuns.h:33:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void atree_start(), atree_grow(), atree_guessnv(); ^ void ev_atree.c:83:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void atree_grow(design *des, lfit *lf, Sint *ce, Sint *ct, Sint *term, double *ll, double *ur) ^ ev_atree.c:111:24: warning: passing arguments to 'newsplit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nce[i] = newsplit(des,lf,i0,i1,pv); ^ In file included from ev_atree.c:10: In file included from ./local.h:107: ./lffuns.h:33:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void atree_start(), atree_grow(), atree_guessnv(); ^ void ev_atree.c:126:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void atree_start(design *des, lfit *lf) ^ ev_atree.c:135:9: warning: passing arguments to 'trchck' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] trchck(lf,nvm,ncm,vc); ^ ev_atree.c:151:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,i); ^ In file included from ev_atree.c:10: In file included from ./local.h:107: ./lffuns.h:34:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double atree_int(); ^ void ev_atree.c:162:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double atree_int(lfit *lf, double *x, int what) ^ ev_atree.c:177:16: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nc = exvval(fp,vv[i],i,d,what,1); ^ ev_atree.c:189:20: warning: passing arguments to 'findpt' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { nv = findpt(fp,evs,(int)ce[i],(int)ce[i+tk]); ^ ev_atree.c:194:35: warning: passing arguments to 'exvvalpv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (evs->s[nv]) exvvalpv(vv[i+tk],vv[i],vv[i+tk],d,ns,h,nc); ^ ev_atree.c:195:32: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] else exvval(fp,vv[i+tk],nv,d,what,1); ^ ev_atree.c:199:35: warning: passing arguments to 'exvvalpv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (evs->s[nv]) exvvalpv(vv[i],vv[i],vv[i+tk],d,ns,h,nc); ^ ev_atree.c:200:32: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] else exvval(fp,vv[i],nv,d,what,1); ^ ev_atree.c:204:25: warning: passing arguments to 'rectcell_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(rectcell_interp(x,vv,ll,ur,d,nc)); ^ 39 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c ev_kdtre.c -o ev_kdtre.o In file included from ev_kdtre.c:11: In file included from ./local.h:107: ./lffuns.h:43:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void kdtre_start(), kdtre_guessnv(); ^ void ev_kdtre.c:16:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void kdtre_guessnv(evstruc *evs, int *nvm, int *ncm, int *vc, int n, int d, double alp) ^ In file included from ev_kdtre.c:11: In file included from ./local.h:107: ./lffuns.h:43:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void kdtre_start(), kdtre_guessnv(); ^ void ev_kdtre.c:137:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void kdtre_start(design *des, lfit *lf) ^ ev_kdtre.c:144:9: warning: passing arguments to 'trchck' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] trchck(lf,nvm,ncm,vc); ^ ev_kdtre.c:207:16: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,nv); ^ ev_kdtre.c:216:35: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] for (i=0; i<nv; i++) des->vfun(des,lf,i); ^ ev_kdtre.c:276:16: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nc = exvval(fp,g0,j0,2,what,0); ^ ev_kdtre.c:277:16: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nc = exvval(fp,g1,j1,2,what,0); ^ ev_kdtre.c:279:28: warning: passing arguments to 'linear_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] gg[k] = linear_interp((x[(k>1)]-v0),v1-v0,g0[0],g1[0]); ^ ev_kdtre.c:281:15: warning: passing arguments to 'hermite2' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { hermite2(x[(k>1)]-v0,v1-v0,phi); ^ ev_kdtre.c:289:25: warning: passing arguments to 'linear_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] s += linear_interp(x[k]-ll[k],ur[k]-ll[k],gg[3-2*k],gg[2-2*k]); ^ ev_kdtre.c:292:15: warning: passing arguments to 'hermite2' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { hermite2(x[k]-ll[k],ur[k]-ll[k],phi); ^ In file included from ev_kdtre.c:11: In file included from ./local.h:107: ./lffuns.h:44:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double kdtre_int(); ^ void ev_kdtre.c:299:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double kdtre_int(fitpt *fp, evstruc *evs, double *x, int what) ^ ev_kdtre.c:320:35: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] for (j=0; j<vc; j++) nc = exvval(fp,vv[j],(int)ce[j],d,what,0); ^ ev_kdtre.c:321:23: warning: passing arguments to 'rectcell_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ff = rectcell_interp(x,vv,ll,ur,d,nc); ^ 40 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c ev_main.c -o ev_main.o In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:51:34: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void trchck(), guessnv(), lfit_alloc(); ^ void ev_main.c:12:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void lfit_alloc(lfit *lf) ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:53:34: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int findpt(), newsplit(), lfit_reqd(), lfit_reqi(); ^ void ev_main.c:17:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lfit_reqd(int d, int nvm, int ncm, int geth) ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:53:47: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int findpt(), newsplit(), lfit_reqd(), lfit_reqi(); ^ void ev_main.c:23:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lfit_reqi(int nvm, int ncm, int vc) ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:51:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void trchck(), guessnv(), lfit_alloc(); ^ void ev_main.c:28:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void trchck(lfit *lf, int nvm, int ncm, int vc) ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:52:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dataf(), gridf(), crossf(), xbarf(), preset(); ^ void ev_main.c:80:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void dataf(design *des, lfit *lf) ^ ev_main.c:92:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { des->vfun(des,lf,i); ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:52:41: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dataf(), gridf(), crossf(), xbarf(), preset(); ^ void ev_main.c:105:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void xbarf(design *des, lfit *lf) ^ ev_main.c:112:12: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,0); ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:52:50: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dataf(), gridf(), crossf(), xbarf(), preset(); ^ void ev_main.c:117:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void preset(design *des, lfit *lf) ^ ev_main.c:125:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,i); ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:52:31: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dataf(), gridf(), crossf(), xbarf(), preset(); ^ void ev_main.c:131:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void crossf(design *des, lfit *lf) ^ ev_main.c:147:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,i); ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:52:22: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dataf(), gridf(), crossf(), xbarf(), preset(); ^ void ev_main.c:153:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void gridf(design *des, lfit *lf) ^ ev_main.c:173:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,i); ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:53:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int findpt(), newsplit(), lfit_reqd(), lfit_reqi(); ^ void ev_main.c:178:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int findpt(fitpt *fp, evstruc *evs, int i0, int i1) ^ In file included from ev_main.c:6: In file included from ./local.h:107: ./lffuns.h:53:22: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int findpt(), newsplit(), lfit_reqd(), lfit_reqi(); ^ void ev_main.c:191:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int newsplit(design *des, lfit *lf, int i0, int i1, int pv) ^ ev_main.c:219:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,nv); ^ 18 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c ev_sphere.c -o ev_sphere.o In file included from ev_sphere.c:9: In file included from ./local.h:107: ./lffuns.h:47:29: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void sphere_start(), sphere_guessnv(); ^ void ev_sphere.c:14:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void sphere_guessnv(int *nvm, int *ncm, int *vc, int *mg) ^ In file included from ev_sphere.c:9: In file included from ./local.h:107: ./lffuns.h:47:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void sphere_start(), sphere_guessnv(); ^ void ev_sphere.c:21:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void sphere_start(design *des, lfit *lf) ^ ev_sphere.c:28:9: warning: passing arguments to 'trchck' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] trchck(lf,nv,0,0); ^ ev_sphere.c:45:16: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->vfun(des,lf,ct); ^ In file included from ev_sphere.c:9: In file included from ./local.h:107: ./lffuns.h:48:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double sphere_int(); ^ void ev_sphere.c:53:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double sphere_int(lfit *lf, double *x, int what) ^ ev_sphere.c:81:14: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nc = exvval(&lf->fp,v[0],ce[0],2,what,1); ^ ev_sphere.c:82:14: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nc = exvval(&lf->fp,v[1],ce[1],2,what,1); ^ ev_sphere.c:83:14: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nc = exvval(&lf->fp,v[2],ce[2],2,what,1); ^ ev_sphere.c:84:14: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nc = exvval(&lf->fp,v[3],ce[3],2,what,1); ^ ev_sphere.c:110:25: warning: passing arguments to 'rectcell_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(rectcell_interp(xx,v,ll,ur,2,nc)); ^ 21 warnings generated. 13 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c ev_trian.c -o ev_trian.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c family.c -o family.o In file included from ev_trian.c:6: In file included from ./local.h:107: ./lffuns.h:56:44: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void triang_start(), triang_grow(), triang_guessnv(); ^ void ev_trian.c:26:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void triang_guessnv(int *nvm, int *ncm, int *vc, int d, int mk) ^ ev_trian.c:43:15: warning: passing arguments to 'rho' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] di = rho(dfx,lf->lfd.sca,d,KSPH,NULL); ^ In file included from ev_trian.c:6: In file included from ./local.h:107: ./lffuns.h:56:29: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void triang_start(), triang_grow(), triang_guessnv(); ^ void ev_trian.c:77:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void triang_grow(design *des, lfit *lf, Sint *ce, Sint *ct, Sint *term) ^ ev_trian.c:96:21: warning: passing arguments to 'newsplit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] pv[0] = newsplit(des,lf,(int)ce[im],(int)ce[jm],0); ^ ev_trian.c:106:19: warning: passing arguments to 'newsplit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] = newsplit(des,lf,(int)ce[i],(int)ce[j],le[i*vc+j]<=cut(&lf->evs)); ^ ev_trian.c:140:21: warning: passing arguments to 'newsplit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] pv[0] = newsplit(des,tr,(int)ce[im],(int)ce[jm],0); ^ ev_trian.c:152:19: warning: passing arguments to 'newsplit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] = newsplit(des,tr,(int)ce[i],(int)ce[j],le[i*d+j]<=cut(&tr->evs)); ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:60:33: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int links(), stdlinks(), defaultlink(), validlinks(); ^ void family.c:12:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int defaultlink(int link, int family) ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:60:48: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int links(), stdlinks(), defaultlink(), validlinks(); ^ void family.c:50:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int validlinks(int link, int family) ^ family.c:104:24: warning: passing arguments to 'ptail' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dp = ((z>6) ? ptail(-z) : exp(-z*z/2)/pz)/2.5066283; ^ family.c:267:33: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dp = exp((y-1)*log(wmu)-wmu-LGAMMA(y))/pt; ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ family.c:338:41: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dg = exp((w-1)*log(y/mean)-y/mean-LGAMMA(w)); ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ family.c:346:37: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dg = exp((w-1)*log(th*y)-th*y-LGAMMA(w)); ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ family.c:395:15: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dp = -exp(LGAMMA(w+y)-LGAMMA(w)-LGAMMA(y)+(y-1)*th+(w+y-2)*log(p))/pt; ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ family.c:395:27: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dp = -exp(LGAMMA(w+y)-LGAMMA(w)-LGAMMA(y)+(y-1)*th+(w+y-2)*log(p))/pt; ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ family.c:395:37: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] dp = -exp(LGAMMA(w+y)-LGAMMA(w)-LGAMMA(y)+(y-1)*th+(w+y-2)*log(p))/pt; ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:61:33: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double b2(), b3(), b4(), lf_link(), invlink(); ^ void family.c:482:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double lf_link(double y, int lin) ^ family.c:487:30: warning: passing arguments to 'logit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case LLOGIT: return(logit(y)); ^ In file included from ev_trian.c:6: In file included from ./local.h:107: ./lffuns.h:56:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void triang_start(), triang_grow(), triang_guessnv(); ^ void ev_trian.c:231:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void triang_start(design *des, lfit *lf) ^ ev_trian.c:243:9: warning: passing arguments to 'trchck' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] trchck(lf,nvm,ncm,vc); ^ ev_trian.c:249:10: warning: passing arguments to 'eig_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] eig_dec(V,P,d); ^ ev_trian.c:287:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { des->vfun(des,lf,i); ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:61:44: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double b2(), b3(), b4(), lf_link(), invlink(); ^ void family.c:496:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double invlink(double th, int lin) ^ ev_trian.c:318:family.c:500:31: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case LLOG: return(lf_exp(th)); ^ family.c:501:30: warning: passing arguments to 'expit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case LLOGIT: return(expit(th)); ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:60:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int links(), stdlinks(), defaultlink(), validlinks(); ^ void family.c:512:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int links(double th, double y, int fam, int link, double *res, int c, double w, double rs) ^ 30: warning: passing arguments to 'cubic_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] vals0[0] = cubic_interp(lb,vals0[0],vals1[0],deriv0,deriv1); ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:60:21: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int links(), stdlinks(), defaultlink(), validlinks(); ^ void family.c:555:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int stdlinks(double *res, lfdata *lfd, smpar *sp, int i, double th, double rs) ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:61:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double b2(), b3(), b4(), lf_link(), invlink(); ^ void family.c:565:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double b2(double th, int tg, double w) ^ family.c:570:32: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case TPOIS: return(w*lf_exp(th)); ^ family.c:572:16: warning: passing arguments to 'expit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y = expit(th); ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:61:21: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype]ev_trian.c:403:24: warning: passing arguments to 'cubic_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] cfe[0] = cubic_interp(lb,cg[3],cg[0],d0,d1); ^ ev_trian.c:404:19: warning: passing arguments to 'cubintd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] cfe[1] = cubintd(lb,cg[3],cg[0],d0,d1); ^ ev_trian.c:408:22: warning: passing arguments to 'cubic_interp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(cubic_interp(gam,cfo[0],cfe[0],d0,d1)); ^ extern double b2(), b3(), b4(), lf_link(), invlink(); ^ void family.c:579:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double b3(double th, int tg, double w) ^ family.c:584:32: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case TPOIS: return(w*lf_exp(th)); ^ family.c:586:16: warning: passing arguments to 'expit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y = expit(th); ^ In file included from family.c:6: In file included from ./local.h:107: ./lffuns.h:61:27: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double b2(), b3(), b4(), lf_link(), invlink(); ^ void family.c:593:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double b4(double th, int tg, double w) ^ family.c:598:32: warning: passing arguments to 'lf_exp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case TPOIS: return(w*lf_exp(th)); ^ family.c:600:16: warning: passing arguments to 'expit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y = expit(th); y = y*(1-y); ^ ev_trian.c:416:34: warning: passing arguments to 'exvval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (evs->s[i]==0) return(exvval(fp,vv,i,d,what,0)); ^ In file included from ev_trian.c:6: In file included from ./local.h:107: ./lffuns.h:57:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double triang_int(); ^ void ev_trian.c:436:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double triang_int(lfit *lf, double *x, int what) ^ 31 warnings generated. 28 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c fitted.c -o fitted.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c frend.c -o frend.o In file included from fitted.c:15: In file included from ./local.h:107: ./lffuns.h:126:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double resid(); ^ void fitted.c:17:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double resid(double y, double w, double th, int fam, int ty, double *res) ^ In file included from fitted.c:15: In file included from ./local.h:107: ./lffuns.h:64:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void fitted(); ^ void fitted.c:68:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void fitted(lfit *lf, double *fit, int what, int cv, int st, int ty) ^ fitted.c:79:20: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] th = dointpoint(lf,xx,what,evo,i); ^ fitted.c:83:15: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] stdlinks(link,&lf->lfd,&lf->sp,i,th,rsc(&lf->fp)); ^ fitted.c:85:25: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { inl = dointpoint(lf,xx,PT0,evo,i); ^ fitted.c:89:19: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] stdlinks(link,&lf->lfd,&lf->sp,i,th,rsc(&lf->fp)); ^ fitted.c:91:33: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (st) var = dointpoint(lf,xx,PNLX,evo,i); ^ In file included from frend.c:6: In file included from ./local.h:107: ./lffuns.h:67:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void ressumm(); ^ void frend.c:30:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void ressumm(lfit *lf, design *des) ^ frend.c:53:45: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->th[i] = base(&lf->lfd,i)+dointpoint(lf,u,PCOEF,evo,i); ^ frend.c:64:11: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] locfit(&lf->lfd,des,&lf->sp,1,0); ^ frend.c:77:11: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] locfit(&lf->lfd,des,&lf->sp,1,0); ^ frend.c:85:20: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] t0 = dointpoint(lf,u,PT0,evo,i); ^ frend.c:86:20: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] t1 = dointpoint(lf,u,PNLX,evo,i); ^ frend.c:87:13: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] stdlinks(link,&lf->lfd,&lf->sp,i,des->th[i],rsc(fp)); ^ frend.c:123:12: warning: passing arguments to 'lforder' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lforder(ind,evp(fp),0,nv-1); ^ In file included from frend.c:6: In file included from ./local.h:107: ./lffuns.h:68:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double rss(); ^ void frend.c:142:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double rss(lfit *lf, design *des, double *df) ^ 17 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lf_adap.c -o lf_adap.o 9 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lf_dercor.c -o lf_dercor.o 31 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lf_fitfun.c -o lf_fitfun.o lf_adap.c:32:8: warning: passing arguments to 'wdiag' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wdiag(lfd, sp, des,l,dv,0,1,0); ^ lf_adap.c:42:17: warning: passing arguments to 'factorial' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] p1 = factorial(deg(sp)+1); ^ lf_adap.c:68:9: warning: passing arguments to 'nbhd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nbhd(lfd,des,z,redo,sp); ^ lf_adap.c:70:38: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (des->h>ho) lf_status = locfit(lfd,des,sp,noit,0,0); ^ lf_adap.c:78:15: warning: passing arguments to 'local_df' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] local_df(lfd,sp,des,t); ^ lf_adap.c:82:15: warning: passing arguments to 'local_df' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] local_df(lfd,sp,des,t); ^ lf_adap.c:113:9: warning: passing arguments to 'nbhd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nbhd(lfd,des,0,1,sp); ^ lf_adap.c:114:15: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (locfit(lfd,des,sp,1,0,0) > 0) WARN(("aband2: failed fit")); ^ lf_adap.c:115:13: warning: passing arguments to 'local_df' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] local_df(lfd,sp,des,t); ^ lf_adap.c:167:9: warning: passing arguments to 'nbhd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nbhd(lfd,des,0,1,sp); ^ lf_adap.c:168:15: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (locfit(lfd,des,sp,1,0,0) > 0) WARN(("aband3: failed fit")); ^ lf_adap.c:169:13: warning: passing arguments to 'local_df' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] local_df(lfd,sp,des,t); ^ In file included from lf_fitfun.c:23: In file included from ./local.h:107: ./lffuns.h:123:59: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int procvhatm(), procv(), procvraw(), procvvord(), calcp(); ^ void lf_fitfun.c:25:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int calcp(smpar *sp, int d) ^ In file included from lf_dercor.c:18: In file included from ./local.h:107: ./lffuns.h:71:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void dercor(); ^ void lf_dercor.c:21:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void dercor(lfdata *lfd, smpar *sp, design *des, double *coef) ^ lf_dercor.c:32:9: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd, sp, des->xev,des->xev,des->f1,NULL); ^ lf_dercor.c:33:14: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); ^ lf_dercor.c:40:13: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] stdlinks(link,lfd,sp,ii,des->th[i],robscale); ^ In file included from lf_fitfun.c:23: In file included from ./local.h:107: ./lffuns.h:75:21: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int calcp(), coefnumber(); ^ void lf_fitfun.c:48:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int coefnumber(deriv *dv, int kt, int d, int deg) ^ lf_dercor.c:42:29: warning: passing arguments to 'weightd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { wd = des->w[i]*weightd(datum(lfd,j,ii)-des->xev[j],lfd->sca[j], ^ In file included from lf_fitfun.c:23: In file included from ./local.h:107: ./lffuns.h:74:23: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void fitfun(), makecfn(), designmatrix(); ^ void lf_fitfun.c:74:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void makecfn(smpar *sp, design *des, deriv *dv, int d) ^ In file included from lf_fitfun.c:23: In file included from ./local.h:107: ./lffuns.h:74:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void fitfun(), makecfn(), designmatrix(); ^ void lf_fitfun.c:125:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void fitfun(lfdata *lfd, smpar *sp, double *x, double *t, double *f, deriv *dv) ^ lf_fitfun.c:133:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] sp->vbasis(xx,t,1,lfd->d,&i,1,npar(sp),f); ^ In file included from lf_adap.c:13: In file included from ./local.h:107: ./lffuns.h:13:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int alocfit(); ^ void lf_adap.c:198:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int alocfit(lfdata *lfd, smpar *sp, deriv *dv, design *des) ^ lf_adap.c:210:7: warning: passing arguments to 'nbhd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nbhd(lfd,des,0,1,sp); ^ lf_adap.c:211:21: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf_status = locfit(lfd,des,sp,0,0,0); ^ 34 warnings generated. In file included from lf_fitfun.c:23: In file included from ./local.h:107: ./lffuns.h:74:34: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void fitfun(), makecfn(), designmatrix(); ^ void lf_fitfun.c:233:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void designmatrix(lfdata *lfd, smpar *sp, design *des) ^ lf_fitfun.c:243:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] sp->vbasis(lfd->x,des->xev,lfd->n,lfd->d,des->ind,des->n,p,X); ^ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lf_nbhd.c -o lf_nbhd.o 6 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lf_robust.c -o lf_robust.o In file included from lf_nbhd.c:11: In file included from ./local.h:107: ./lffuns.h:78:27: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double kordstat(), rho(); ^ void lf_nbhd.c:13:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double rho(double *x, double *sc, int d, int kt, int *sty) ^ In file included from lf_nbhd.c:11: In file included from ./local.h:107: ./lffuns.h:78:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double kordstat(), rho(); ^ void lf_nbhd.c:49:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double kordstat(double *x, int k, int n, Sint *ind) ^ lf_nbhd.c:145:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] h = sp->vb(des->xev); ^ lf_nbhd.c:169:23: warning: passing arguments to 'weight' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->w[m] = weight(lfd, sp, &xd[i], &x, h, 1, des->di[i]); ^ lf_nbhd.c:178:23: warning: passing arguments to 'weight' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->w[m] = weight(lfd, sp, &xd[i], &x, h, 1, des->di[i]); ^ In file included from lf_nbhd.c:11: In file included from ./local.h:107: ./lffuns.h:79:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void nbhd(); ^ void lf_nbhd.c:208:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void nbhd(lfdata *lfd, design *des, int nn, int redo, smpar *sp) ^ lf_nbhd.c:256:20: warning: passing arguments to 'minmax' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { des->h = minmax(lfd,des,sp); ^ lf_nbhd.c:261:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] h = sp->vb(des->xev); ^ lf_nbhd.c:267:23: warning: passing arguments to 'weight' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->w[m] = weight(lfd, sp, u, des->xev, h, 1, des->di[i]); ^ In file included from lf_robust.c:26: In file included from ./local.h:107: ./lffuns.h:82:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double median(); ^ void lf_robust.c:36:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double median(double *x, int n) ^ lf_robust.c:77:13: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] stdlinks(link,lfd,sp,ii,des->th[i],rs); ^ lf_robust.c:102:10: warning: passing arguments to 'links' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] links(des->th[i],resp(lfd,ii),fam&127,lin,link,cens(lfd,ii),prwt(lfd,ii),1.0); ^ lf_robust.c:115:9: warning: passing arguments to 'lfiter' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lfiter(rob_des,rob_mxit); ^ In file included from lf_robust.c:26: In file included from ./local.h:107: ./lffuns.h:83:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lf_robust(); ^ void lf_robust.c:123:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void lf_robust(lfdata *lfd, smpar *sp, design *des, int mxit) ^ 11 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lf_vari.c -o lf_vari.o lf_vari.c:52:17: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] (des->itype)(des->xev, M2, M12, des->cf, h); ^ lf_vari.c:60:15: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { stdlinks(link,lfd,sp,(int)des->ind[i],des->th[i],robscale); ^ lf_vari.c:70:16: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,&M12[i*p]); ^ In file included from lf_vari.c:11: In file included from ./local.h:107: ./lffuns.h:91:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lf_vcov(), comp_vari(), local_df(); ^ void lf_vari.c:73:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void lf_vcov(lfdata *lfd, smpar *sp, design *des) ^ lf_vari.c:89:11: warning: passing arguments to 'chol_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_dec(M2,p,p); ^ lf_vari.c:95:34: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] for (i=0; i<p; i++) jacob_solve(&des->xtwx,&M2[i*p]); ^ In file included from lf_vari.c:11: In file included from ./local.h:107: ./lffuns.h:91:24: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lf_vcov(), comp_vari(), local_df(); ^ void lf_vari.c:107:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void comp_vari(lfdata *lfd, smpar *sp, design *des, double *tr, double *t0) ^ lf_vari.c:119:14: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); ^ In file included from lf_vari.c:11: In file included from ./local.h:107: ./lffuns.h:91:37: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lf_vcov(), comp_vari(), local_df(); ^ void lf_vari.c:131:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void local_df(lfdata *lfd, smpar *sp, design *des, double *tr) ^ lf_vari.c:148:14: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); ^ lf_vari.c:158:13: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { stdlinks(link,lfd,sp,(int)des->ind[i],des->th[i],robscale); ^ lf_vari.c:163:16: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { jacob_solve(&des->xtwx,&m2[i*p]); ^ 7 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lf_wdiag.c -o lf_wdiag.o 16 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c lfstr.c -o lfstr.o lf_wdiag.c:27:13: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { stdlinks(link,lfd,sp,(int)des->ind[j],des->th[j],robscale); ^ lf_wdiag.c:30:14: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); ^ In file included from lf_wdiag.c:12: In file included from ./local.h:107: ./lffuns.h:147:21: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int wdiag(), wdiagp(); ^ void lf_wdiag.c:57:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int wdiagp(lfdata *lfd, smpar *sp, design *des, double *lx, paramcomp *pc, deriv *dv, int deg, int ty, int exp) ^ lf_wdiag.c:70:9: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd,sp,des->xev,pc->xbar,des->f1,dv); ^ lf_wdiag.c:72:16: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { jacob_solve(&pc->xtwx,des->f1); ^ lf_wdiag.c:77:15: warning: passing arguments to 'jacob_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_hsolve(&pc->xtwx,des->f1); ^ lf_wdiag.c:86:13: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd,sp,des->xev,pc->xbar,l1,dv); ^ lf_wdiag.c:87:19: warning: passing arguments to 'jacob_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_hsolve(&pc->xtwx,l1); ^ lf_wdiag.c:97:15: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd,sp,des->xev,pc->xbar,l1,dv); ^ lf_wdiag.c:98:21: warning: passing arguments to 'jacob_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_hsolve(&pc->xtwx,l1); ^ In file included from lf_wdiag.c:12: In file included from ./local.h:107: ./lffuns.h:147:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int wdiag(), wdiagp(); ^ void lf_wdiag.c:104:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int wdiag(lfdata *lfd, smpar *sp, design *des, double *lx, deriv *dv, int deg, int ty, int exp) ^ lf_wdiag.c:130:19: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (nd>0) fitfun(lfd,sp,des->xev,des->xev,des->f1,dv); /* c(0) */ ^ lf_wdiag.c:132:14: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); /* c(0) (X^TWX)^{-1} */ ^ lf_wdiag.c:137:17: warning: passing arguments to 'Wd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { wd[i] = Wd(des->di[ii]/h,ker(sp)); ^ lf_wdiag.c:140:45: warning: passing arguments to 'weightd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lxd[j*m+i] = lx[i]*des->w[i]*weightd(dfx[j],lfd->sca[j], ^ lf_wdiag.c:145:18: warning: passing arguments to 'Wdd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { wdd = Wdd(des->di[ii]/h,ker(sp)); ^ lf_wdiag.c:164:13: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd,sp,des->xev,des->xev,des->f1,dv); ^ lf_wdiag.c:166:17: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { stdlinks(link,lfd,sp,(int)des->ind[k],des->th[k],robscale); ^ lf_wdiag.c:171:18: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); /* (...)(XTWX)^{-1} */ ^ lf_wdiag.c:178:34: warning: passing arguments to 'weightd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wdw = des->w[k]*weightd(dfx[j],lfd->sca[j],d,ker(sp), ^ lf_wdiag.c:193:13: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd,sp,des->xev,des->xev,des->f1,dv); ^ lf_wdiag.c:194:18: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); ^ lf_wdiag.c:208:15: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd,sp,des->xev,des->xev,des->f1,dv); ^ lf_wdiag.c:209:20: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&des->xtwx,des->f1); ^ lf_wdiag.c:225:13: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { stdlinks(link,lfd,sp,(int)des->ind[i],des->th[i],robscale); ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:143:19: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int stm(), pmatch(), matchlf(), matchrt(), checkltor(), checkrtol(); ^ void lfstr.c:36:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int pmatch(char *z, char **strings, int *vals, int n, int def) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:86:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int lffamily(), lfkernel(), lfketype(), lflink(); ^ void lfstr.c:60:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lffamily(char *z) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:86:24: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int lffamily(), lfkernel(), lfketype(), lflink(); ^ void lfstr.c:86:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lfkernel(char *z) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:86:36: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int lffamily(), lfkernel(), lfketype(), lflink(); ^ void lfstr.c:93:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lfketype(char *z) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:86:48: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int lffamily(), lfkernel(), lfketype(), lflink(); ^ void lfstr.c:102:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lflink(char *z) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:87:22: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int deitye(), lfevstr(), lfacri(); ^ void lfstr.c:112:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lfevstr(char *z) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:87:33: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int deitye(), lfevstr(), lfacri(); ^ void lfstr.c:127:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int lfacri(char *z) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:88:22: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int ppwhat(), restyp(); ^ void lfstr.c:140:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int restyp(char *z) ^ In file included from lfstr.c:24: In file included from ./local.h:107: ./lffuns.h:88:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int ppwhat(), restyp(); ^ void lfstr.c:149:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int ppwhat(char *z) ^ 15 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c locfit.c -o locfit.o In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:95:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lfdata_init(), smpar_init(), deriv_init(), des_init(), lfiter(); ^ void locfit.c:20:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void lfdata_init(lfdata *lfd) ^ 12 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_chol.c -o m_chol.o In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:95:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lfdata_init(), smpar_init(), deriv_init(), des_init(), lfiter(); ^ void locfit.c:32:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void smpar_init(smpar *sp, lfdata *lfd) ^ locfit.c:45:19: warning: passing arguments to 'calcp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] npar(sp) = calcp(sp,lfd->d); ^ In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:95:42: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lfdata_init(), smpar_init(), deriv_init(), des_init(), lfiter(); ^ void locfit.c:48:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void deriv_init(deriv *dv) ^ In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:94:22: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int locfit(), des_reqd(), des_reqi(); ^ void locfit.c:53:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int des_reqd(int n, int p) ^ locfit.c:56:38: warning: passing arguments to 'jac_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(n*(p+5)+2*p*p+4*p + jac_reqd(p)); ^ In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:94:34: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int locfit(), des_reqd(), des_reqi(); ^ void locfit.c:58:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int des_reqi(int n, int p) ^ In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:95:56: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lfdata_init(), smpar_init(), deriv_init(), des_init(), lfiter(); ^ void locfit.c:63:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void des_init(design *des, int n, int p) ^ locfit.c:97:16: warning: passing arguments to 'jac_alloc' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] z = jac_alloc(&des->xtwx,p,z); ^ locfit.c:135:25: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf_status = stdlinks(link,lf_lfd,lf_sp,ii,lf_des->th[i],robscale); ^ locfit.c:155:25: warning: passing arguments to 'prresp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (lf_debug>4) prresp(coef,Z,p); ^ locfit.c:197:22: warning: passing arguments to 'median' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->cf[0] = median(des->res,des->n); ^ locfit.c:228:10: warning: passing arguments to 'links' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] links(base(lfd,ii),resp(lfd,ii),fam(lf_sp),LINIT,link,cens(lfd,ii),prwt(lfd,ii),1.0); ^ locfit.c:256:25: warning: passing arguments to 'logit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->cf[0] = logit(s1/s0)-sb/s0; ^ In file included from m_chol.c:7: ./mutil.h:27:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void jacob_dec(), chol_dec(), eig_dec(); ^ void m_chol.c:12:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void chol_dec(double *A, int n, int p) ^ In file included from m_chol.c:7: ./mutil.h:28:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int jacob_solve(), chol_solve(), eig_solve(); ^ void m_chol.c:35:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int chol_solve(double *A, double *v, int n, int p) ^ In file included from m_chol.c:7: ./mutil.h:29:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int jacob_hsolve(),chol_hsolve(),eig_hsolve(); ^ void m_chol.c:51:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int chol_hsolve(double *A, double *v, int n, int p) ^ In file included from m_chol.c:7: ./mutil.h:30:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double jacob_qf(), chol_qf(), eig_qf(); ^ void m_chol.c:63:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double chol_qf(double *A, double *v, int n, int p) ^ locfit.c:284:15: warning: passing arguments to 'designmatrix' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] designmatrix(lfd,sp,des); ^ locfit.c:287:25: warning: passing arguments to 'defaultlink' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] link(sp) = defaultlink(link(sp),fam(sp)); ^ locfit.c:295:22: warning: passing arguments to 'densinit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(densinit(lfd,des,sp,des->cf)); ^ In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:95:68: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void lfdata_init(), smpar_init(), deriv_init(), des_init(), lfiter(); ^ void locfit.c:306:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void lfiter(design *des, int maxit) ^ In file included from locfit.c:6: In file included from ./local.h:107: ./lffuns.h:94:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int locfit(), des_reqd(), des_reqi(); ^ void locfit.c:332:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int locfit(lfdata *lfd, design *des, smpar *sp, int noit, int nb, int cv) ^ locfit.c:355:15: warning: passing arguments to 'nbhd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (nb) nbhd(lfd,des,(int)(lfd->n*nn(sp)+1e-12),0,sp); ^ locfit.c:361:14: warning: passing arguments to 'lf_robust' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf_robust(lfd,sp,des,lf_maxit); ^ locfit.c:383:12: warning: passing arguments to 'lf_vcov' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf_vcov(lfd,sp,des); ^ 12 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_eigen.c -o m_eigen.o In file included from m_eigen.c:10: ./mutil.h:27:42: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void jacob_dec(), chol_dec(), eig_dec(); ^ void m_eigen.c:26:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void eig_dec(double *X, double *P, int d) ^ In file included from m_eigen.c:10: ./mutil.h:28:42: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int jacob_solve(), chol_solve(), eig_solve(); ^ void m_eigen.c:69:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int eig_solve(jacobian *J, double *x) ^ In file included from m_eigen.c:10: ./mutil.h:29:42: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int jacob_hsolve(),chol_hsolve(),eig_hsolve(); ^ void m_eigen.c:100:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int eig_hsolve(jacobian *J, double *v) ^ In file included from m_eigen.c:10: ./mutil.h:30:42: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double jacob_qf(), chol_qf(), eig_qf(); ^ void m_eigen.c:129:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double eig_qf(jacobian *J, double *v) ^ 18 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_icirc.c -o m_icirc.o In file included from m_icirc.c:5: ./mutil.h:93:51: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void simpsonm(), simpson4(), integ_disc(), integ_circ(); ^ void m_icirc.c:22:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void integ_circ(int (*f)(), double r, double *orig, double *res, int mint, int b) ^ m_icirc.c:44:11: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nr = f(x,2,tres,M); ^ In file included from m_icirc.c:5: ./mutil.h:93:37: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void simpsonm(), simpson4(), integ_disc(), integ_circ(); ^ void m_icirc.c:52:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void integ_disc(int (*f)(), int (*fb)(), double *fl, double *res, double *resb, int *mg) ^ m_icirc.c:72:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nr = f(x,2,tres,NULL); ^ m_icirc.c:78:17: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nrb = fb(x,2,tres,M); ^ 8 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_imont.c -o m_imont.o m_imont.c:15:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void setzero(); ^ In file included from m_imont.c:14: ./mutil.h:94:29: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void integ_sphere(), monte(), rn3(); ^ void m_imont.c:20:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void monte(int (*f)(), double *ll, double *ur, int d, double *res, int n) ^ m_imont.c:31:11: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nr = f(x,d,tres,NULL); ^ 7 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_isimp.c -o m_isimp.o 21 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_isphr.c -o m_isphr.o 30 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_jacob.c -o m_jacob.o m_isimp.c:13:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void setzero(); ^ m_isimp.c:37:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nrd = fd(x,d,res2,M); ^ m_isimp.c:60:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nrc = fc(x,d,res2,M); ^ m_isimp.c:83:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nrb = fb(x,d,res2,M); ^ In file included from m_isimp.c:12: ./mutil.h:93:25: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void simpsonm(), simpson4(), integ_disc(), integ_circ(); ^ void m_isimp.c:95:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void simpson4(int (*f)(), int (*fb)(), int (*fc)(), int (*fd)(), double *ll, double *ur, int d, double *res, double *resb, double *resc, double *resd, int *mg, double *res2) ^ m_isimp.c:113:11: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nr = f(x,d,res2,NULL); ^ In file included from m_isimp.c:12: ./mutil.h:93:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void simpsonm(), simpson4(), integ_disc(), integ_circ(); ^ void m_isimp.c:142:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void simpsonm(int (*f)(), double *ll, double *ur, int d, double *res, int *mg, double *res2) ^ In file included from m_isimp.c:12: ./mutil.h:95:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double simpson(), sptarea(); ^ void m_isimp.c:148:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double simpson(double (*f)(), double l0, double l1, int m) ^ m_isimp.c:156:41: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] sum += (2+2*(i&1)-(i==0)-(i==m)) * f(x); ^ In file included from m_isphr.c:1: ./mutil.h:94:38: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void integ_sphere(), monte(), rn3(); ^ void m_isphr.c:56:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void rn3(double *a) ^ In file included from m_isphr.c:1: ./mutil.h:95:26: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double simpson(), sptarea(); ^ void m_isphr.c:63:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double sptarea(double *a, double *b, double *c) ^ m_isphr.c:119:11: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nr = f(u,3,tres,NULL); ^ m_isphr.c:127:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nrb = fb(u,3,tres,M); ^ In file included from m_isphr.c:1: ./mutil.h:94:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void integ_sphere(), monte(), rn3(); ^ void m_isphr.c:191:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void integ_sphere(int (*f)(), int (*fb)(), double *fl, double *Res, double *Resb, int *mg) ^ In file included from m_jacob.c:10: ./mutil.h:25:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int jac_reqd(); ^ void m_jacob.c:14:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int jac_reqd(int p) { return(2*p*(p+1)); } ^ In file included from m_jacob.c:10: ./mutil.h:26:16: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double *jac_alloc(); ^ void m_jacob.c:16:9: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double *jac_alloc(jacobian *J, int p, double *wk) ^ In file included from m_jacob.c:10: ./mutil.h:27:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void jacob_dec(), chol_dec(), eig_dec(); ^ void m_jacob.c:29:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void jacob_dec(jacobian *J, int meth) ^ m_jacob.c:39:14: warning: passing arguments to 'eig_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] eig_dec(J->Z,J->Q,J->p); ^ m_jacob.c:48:14: warning: passing arguments to 'eig_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] eig_dec(J->Z,J->Q,J->p); ^ m_jacob.c:52:15: warning: passing arguments to 'chol_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_dec(J->Z,J->p,J->p); ^ In file included from m_jacob.c:10: ./mutil.h:28:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int jacob_solve(), chol_solve(), eig_solve(); ^ void m_jacob.c:58:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int jacob_solve(jacobian *J, double *v) /* (X^T W X)^{-1} v */ ^ 4 warnings generated. m_jacob.c:67:23: warning: passing arguments to 'eig_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(eig_solve(J,v)); ^ m_jacob.c:70:23: warning: passing arguments to 'eig_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] rank = eig_solve(J,v); ^ m_jacob.c:74:24: warning: passing arguments to 'chol_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(chol_solve(J->Z,v,J->p,J->p)); ^ In file included from m_jacob.c:10: ./mutil.h:29:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int jacob_hsolve(),chol_hsolve(),eig_hsolve(); ^ void m_jacob.c:80:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int jacob_hsolve(jacobian *J, double *v) /* J^{-1/2} v */ ^ m_jacob.c:89:24: warning: passing arguments to 'eig_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(eig_hsolve(J,v)); ^ m_jacob.c:92:24: warning: passing arguments to 'eig_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(eig_hsolve(J,v)); ^ m_jacob.c:94:25: warning: passing arguments to 'chol_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(chol_hsolve(J->Z,v,J->p,J->p)); ^ In file included from m_jacob.c:10: ./mutil.h:30:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double jacob_qf(), chol_qf(), eig_qf(); ^ void m_jacob.c:100:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double jacob_qf(jacobian *J, double *v) /* vT J^{-1} v */ ^ m_jacob.c:109:20: warning: passing arguments to 'eig_qf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(eig_qf(J,v)); ^ m_jacob.c:112:20: warning: passing arguments to 'eig_qf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(eig_qf(J,v)); ^ m_jacob.c:114:21: warning: passing arguments to 'chol_qf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(chol_qf(J->Z,v,J->p,J->p)); ^ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_max.c -o m_max.o 27 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_qr.c -o m_qr.o m_max.c:50:10: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y = f(x); ^ m_max.c:77:19: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x0 = xlo; y0 = f(xlo); ^ m_max.c:78:19: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x3 = xhi; y3 = f(xhi); ^ m_max.c:79:45: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x1 = gold_rat*x0 + (1-gold_rat)*x3; y1 = f(x1); ^ m_max.c:80:45: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x2 = gold_rat*x3 + (1-gold_rat)*x1; y2 = f(x2); ^ m_max.c:86:49: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x1 = gold_rat*x0 + (1-gold_rat)*x3; y1 = f(x1); ^ m_max.c:91:49: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x2 = gold_rat*x3 + (1-gold_rat)*x1; y2 = f(x2); ^ m_max.c:96:49: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x1 = gold_rat*x0 + (1-gold_rat)*x3; y1 = f(x1); ^ m_max.c:97:49: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x2 = gold_rat*x3 + (1-gold_rat)*x1; y2 = f(x2); ^ m_max.c:119:19: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x0 = xlo; y0 = f(x0); ^ m_max.c:120:19: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x2 = xhi; y2 = f(x2); ^ m_max.c:121:25: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x1 = (x0+x2)/2; y1 = f(x1); ^ m_max.c:133:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = f(x1); ^ m_max.c:157:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ynew = f(xnew); ^ m_max.c:183:9: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fr = F(coef, &f, f1, J->Z); J->st = JAC_RAW; ^ m_max.c:188:23: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] rank = jacob_solve(J,f1); ^ m_max.c:205:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fr = F(coef, &f, f1, J->Z); J->st = JAC_RAW; ^ 8 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_solve.c -o m_solve.o m_solve.c:54:10: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ylo = f(xlo)-c; ^ m_solve.c:55:10: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] yhi = f(xhi)-c; ^ m_solve.c:61:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = f(x1) - c; ^ m_solve.c:69:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y1 = f(x1) - c; ^ m_solve.c:89:10: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y = f(x)-c; ^ m_solve.c:109:10: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { y = f(x0)-c; ^ m_solve.c:110:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] x0 -= y/f1(x0); ^ m_solve.c:122:11: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { x1 = f(x0); ^ 8 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_svd.c -o m_svd.o 8 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c m_vector.c -o m_vector.o 17 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c math.c -o math.o In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:99:56: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double lflgamma(), lferf(), lferfc(), lfdaws(), lf_exp(); ^ ./lffuns.h:99:36: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double lflgamma(), lferf(), lferfc(), lfdaws(), lf_exp(); ^ void math.c:32:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double lferfc(double); ^ In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:99:27: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double lflgamma(), lferf(), lferfc(), lfdaws(), lf_exp(); ^ void math.c:34:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double lferf(double x) ^ In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:99:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double lflgamma(), lferf(), lferfc(), lfdaws(), lf_exp(); ^ void math.c:67:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double lflgamma(double x) ^ In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:99:46: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double lflgamma(), lferf(), lferfc(), lfdaws(), lf_exp(); ^ void math.c:89:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double lfdaws(double x) ^ In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:100:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double ptail(), logit(), expit(); ^ void math.c:134:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double ptail(double x) /* exp(x*x/2)*int_{-\infty}^x exp(-u^2/2)du for x < -6 */ ^ In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:100:24: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double ptail(), logit(), expit(); ^ void math.c:148:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double logit(double x) ^ In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:100:33: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double ptail(), logit(), expit(); ^ void math.c:153:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double expit(double x) ^ In file included from math.c:30: In file included from ./local.h:107: ./lffuns.h:102:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int factorial(); ^ void math.c:163:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int factorial(int n) ^ 24 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c minmax.c -o minmax.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c pcomp.c -o pcomp.o In file included from minmax.c:9: In file included from ./local.h:107: ./lffuns.h:105:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double ipower(), minmax(); ^ void minmax.c:23:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double ipower(double x, int n) ^ minmax.c:75:12: warning: passing arguments to 'jacob_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_dec(J,JAC_EIGD); ^ 12 warnings generated. minmax.c:193:18: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(J,f1); ^ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c preplot.c -o preplot.o In file included from minmax.c:9: In file included from ./local.h:107: ./lffuns.h:105:25: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double ipower(), minmax(); ^ void minmax.c:266:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double minmax(lfdata *lfd, design *des, smpar *sp) ^ minmax.c:279:17: warning: passing arguments to 'factorial' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] p1 = factorial(d1); ^ minmax.c:284:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(lfd, sp, u,des->xev,d_xi(des,i),NULL); ^ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c prob.c -o prob.o In file included from pcomp.c:10: In file included from ./local.h:107: ./lffuns.h:114:23: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int pc_reqd(), noparcomp(); ^ void pcomp.c:12:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int noparcomp(smpar *sp, int geth) ^ In file included from pcomp.c:10: In file included from ./local.h:107: ./lffuns.h:114:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int pc_reqd(), noparcomp(); ^ void pcomp.c:27:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int pc_reqd(int d, int p) ^ pcomp.c:30:28: warning: passing arguments to 'jac_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { return(d + 2*p + jac_reqd(p)); ^ In file included from pcomp.c:10: In file included from ./local.h:107: ./lffuns.h:113:57: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void compparcomp(), subparcomp(), subparcomp2(), pcchk(); ^ void pcomp.c:33:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void pcchk(paramcomp *pc, int d, int p, int lc) ^ pcomp.c:51:16: warning: passing arguments to 'jac_alloc' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] z = jac_alloc(&pc->xtwx,p,z); ^ In file included from pcomp.c:10: In file included from ./local.h:107: ./lffuns.h:113:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void compparcomp(), subparcomp(), subparcomp2(), pcchk(); ^ void pcomp.c:55:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void compparcomp(design *des, lfdata *lfd, smpar *sp, paramcomp *pc, int geth, ^ pcomp.c:89:13: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] k = locfit(lfd,des,sp,0,0,0); ^ In file included from pcomp.c:10: In file included from ./local.h:107: ./lffuns.h:113:28: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void compparcomp(), subparcomp(), subparcomp2(), pcchk(); ^ void pcomp.c:125:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void subparcomp(design *des, lfit *lf, double *coef) ^ pcomp.c:138:9: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, des->xev,pc->xbar,des->f1,dv); ^ pcomp.c:145:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, des->xev,pc->xbar,des->f1,dv); ^ preplot.c:34:22: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fit[i] = dointpoint(lf,x,what,ev,i); ^ preplot.c:36:22: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] sef[i] = dointpoint(lf,x,PNLX,ev,i); ^ preplot.c:42:21: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { lik = dointpoint(lf,x,PLIK,ev,i); ^ preplot.c:43:21: warning: passing arguments to 'dointpoint' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] rdf = dointpoint(lf,x,PRDF,ev,i); ^ In file included from pcomp.c:10: In file included from ./local.h:107: ./lffuns.h:113:42: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void compparcomp(), subparcomp(), subparcomp2(), pcchk(); ^ void pcomp.c:151:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void subparcomp2(design *des, lfit *lf, double *vr, double *il) ^ pcomp.c:166:9: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, des->xev,pc->xbar,des->f1,dv); ^ pcomp.c:168:14: warning: passing arguments to 'jacob_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_solve(&pc->xtwx,des->f1); ^ pcomp.c:177:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, des->xev,pc->xbar,pc->f,dv); ^ In file included from pcomp.c:10: In file included from ./local.h:107: ./lffuns.h:112:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double addparcomp(); ^ void pcomp.c:185:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double addparcomp(lfit *lf, double *x, int c) ^ pcomp.c:195:9: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, x,pc->xbar,pc->f,&lf->dv); ^ pcomp.c:198:22: warning: passing arguments to 'jacob_qf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { y = sqrt(jacob_qf(&pc->xtwx,pc->f)); ^ 17 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c procv.c -o procv.o In file included from procv.c:6: In file included from ./local.h:107: ./lffuns.h:123:34: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int procvhatm(), procv(), procvraw(), procvvord(), calcp(); ^ void procv.c:16:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int procvraw(design *des, lfit *lf, int v) ^ procv.c:27:23: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf_status = locfit(&lf->lfd,des,&lf->sp,0,1,0); ^ procv.c:29:24: warning: passing arguments to 'alocfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lf_status = alocfit(&lf->lfd,&lf->sp,&lf->dv,des); ^ procv.c:35:28: warning: passing arguments to 'dercor' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { if (dc(&lf->fp)) dercor(&lf->lfd,&lf->sp,des,coef); ^ procv.c:36:15: warning: passing arguments to 'subparcomp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] subparcomp(des,lf,coef); ^ In file included from procv.c:6: In file included from ./local.h:107: ./lffuns.h:123:25: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int procvhatm(), procv(), procvraw(), procvvord(), calcp(); ^ void procv.c:63:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int procv(design *des, lfit *lf, int v) ^ procv.c:119:12: warning: passing arguments to 'comp_vari' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] comp_vari(&lf->lfd,&lf->sp,des,trc,t0); ^ procv.c:131:14: warning: passing arguments to 'subparcomp2' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] subparcomp2(des,lf,vari,t0); ^ procv.c:150:13: warning: passing arguments to 'stdlinks' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] stdlinks(link,&lf->lfd,&lf->sp,(int)des->ind[i],th,robscale); ^ In file included from procv.c:6: In file included from ./local.h:107: ./lffuns.h:123:46: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int procvhatm(), procv(), procvraw(), procvvord(), calcp(); ^ void procv.c:157:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int procvvord(design *des, lfit *lf, int v) ^ procv.c:174:35: warning: passing arguments to 'calcp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->p = npar(&lf->sp) = calcp(&lf->sp,lf->lfd.d); ^ procv.c:175:15: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] k = locfit(&lf->lfd,des,&lf->sp,0, i==deg0(&lf->sp),0); ^ procv.c:177:13: warning: passing arguments to 'local_df' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] local_df(&lf->lfd,&lf->sp,des,tr); ^ procv.c:199:35: warning: passing arguments to 'calcp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des->p = npar(&lf->sp) = calcp(&lf->sp,lf->lfd.d); ^ procv.c:200:15: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] k = locfit(&lf->lfd,des,&lf->sp,0,0,0); ^ In file included from procv.c:6: In file included from ./local.h:107: ./lffuns.h:123:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int procvhatm(), procv(), procvraw(), procvvord(), calcp(); ^ void procv.c:213:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int procvhatm(design *des, lfit *lf, int v) ^ procv.c:222:10: warning: passing arguments to 'wdiag' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wdiag(&lf->lfd,&lf->sp,des,l,&lf->dv,0,1,1); ^ procv.c:225:11: warning: passing arguments to 'wdiagp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] wdiagp(&lf->lfd,&lf->sp,des,l,&lf->pc,&lf->dv,0,1,1); ^ clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c scb.c -o scb.o clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c scb_cons.c -o scb_cons.o In file included from scb_cons.c:13: ./tube.h:18:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int k0_reqd(); ^ void scb_cons.c:18:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int k0_reqd(int d, int n, int uc) ^ scb.c:28:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, &x1,pc->xbar,v1,NULL); ^ scb.c:29:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, &x2,pc->xbar,v2,NULL); ^ scb.c:30:17: warning: passing arguments to 'jacob_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_hsolve(&lf->pc.xtwx,v1); ^ scb.c:31:17: warning: passing arguments to 'jacob_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] jacob_hsolve(&lf->pc.xtwx,v2); ^ scb.c:39:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { fitfun(&lf->lfd, &lf->sp, &x1,des->xev,wk,NULL); ^ scb.c:44:11: warning: passing arguments to 'fitfun' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] fitfun(&lf->lfd, &lf->sp, &x2,des->xev,wk,NULL); ^ scb.c:73:13: warning: passing arguments to 'b3' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] b3i = b3(des->th[i],fam(&lf->sp),prwt(&lf->lfd,ii)); ^ scb.c:74:13: warning: passing arguments to 'b4' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] b4i = b4(des->th[i],fam(&lf->sp),prwt(&lf->lfd,ii)); ^ scb.c:94:15: warning: passing arguments to 'b3' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] b3j = b3(des->th[j],fam(&lf->sp),prwt(&lf->lfd,jj)); ^ scb.c:189:15: warning: passing arguments to 'procv' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] st = procv(des,lf,v); ^ In file included from scb.c:6: In file included from ./local.h:107: ./lffuns.h:129:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void scb(), cscbsim(); ^ void scb.c:224:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void scb(design *des, lfit *lf) ^ scb.c:232:24: warning: passing arguments to 'calcp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] npar(&lf->sp) = calcp(&lf->sp,lf->lfd.d); ^ scb.c:233:11: warning: passing arguments to 'des_init' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des_init(des,lf->lfd.n,npar(&lf->sp)); ^ scb.c:234:30: warning: passing arguments to 'defaultlink' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] link(&lf->sp) = defaultlink(link(&lf->sp),fam(&lf->sp)); ^ scb.c:240:23: warning: passing arguments to 'constants' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nterms = constants(des,lf); ^ scb.c:241:23: warning: passing arguments to 'critval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] scb_crit = critval(0.05,lf->fp.kap,nterms,lf->lfd.d,TWO_SIDED,0.0,GAUSS); ^ scb.c:246:23: warning: passing arguments to 'critval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] scb_crit = critval(0.05,lf->fp.kap,1,lf->lfd.d,TWO_SIDED,0.0,GAUSS); ^ scb.c:250:10: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procvscb2,0); ^ scb.c:254:12: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ressumm(lf,des); ^ scb_cons.c:51:16: warning: passing arguments to 'chol_hsolve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_hsolve(fd,&lij[i*m],m,dd+1); ^ scb_cons.c:63:19: warning: passing arguments to 'chol_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_solve(fd,v,m,dd+1); ^ scb_cons.c:69:19: warning: passing arguments to 'chol_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_solve(fd,v,m,dd+1); ^ scb_cons.c:179:18: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] m = globm = wdf(x,ft,r); ^ scb_cons.c:182:26: warning: passing arguments to 'chol_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (use_covar) chol_dec(fd,m,d+1); ^ scb_cons.c:256:26: warning: passing arguments to 'chol_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (use_covar) chol_dec(fd,m,d+1); ^ scb_cons.c:267:15: warning: passing arguments to 'chol_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_solve(fd,u,m,d); ^ scb_cons.c:272:17: warning: passing arguments to 'chol_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_solve(fd,v,m,d); ^ scb_cons.c:322:26: warning: passing arguments to 'chol_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (use_covar) chol_dec(fd,m,d+1); ^ scb_cons.c:336:15: warning: passing arguments to 'chol_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_solve(fd,u1,m,d); ^ scb_cons.c:337:15: warning: passing arguments to 'chol_solve' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] chol_solve(fd,u2,m,d-1); ^ scb_cons.c:381:26: warning: passing arguments to 'chol_dec' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (use_covar) chol_dec(fd,m,d+1); ^ scb_cons.c:397:6: warning: passing arguments to 'rn3' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] rn3(a0); rn3(a1); ^ scb_cons.c:397:15: warning: passing arguments to 'rn3' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] rn3(a0); rn3(a1); ^ scb_cons.c:398:22: warning: passing arguments to 'sptarea' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] n0[0] = det*sptarea(a0,a1,a2); ^ scb_cons.c:411:12: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] n = wdf(x,l0,0); ^ In file included from scb_cons.c:13: ./tube.h:17:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int tube_constants(); ^ void scb_cons.c:429:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int tube_constants(int (*f)(), int d, int m, int ev, int *mg, double *fl, ^ scb_cons.c:455:12: warning: passing arguments to 'monte' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] monte(k0x,fl,&fl[d],d,k0,mg[0]); ^ scb_cons.c:458:27: warning: passing arguments to 'integ_disc' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (d==2) integ_disc(k0x,l1x,fl,k0,l0,mg); ^ scb_cons.c:459:29: warning: passing arguments to 'integ_sphere' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (d==3) integ_sphere(k0x,l1x,fl,k0,l0,mg); ^ scb_cons.c:462:30: warning: passing arguments to 'simpson4' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (use_covar) simpson4(k0x,l1x,m0x,n0x,fl,&fl[d],d,k0,l0,m0,n0,mg,z); ^ scb_cons.c:463:30: warning: passing arguments to 'simpson4' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] else simpson4(k0x,l1x,m0x,n0x,fl,&fl[d],d,k0,l0,m0,n0,mg,z); ^ 4 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c scb_crit.c -o scb_crit.o 24 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c scb_iface.c -o scb_iface.o scb_iface.c:19:11: warning: passing arguments to 'locfit' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { locfit(lfd_scb,des_scb,&lf_scb->sp,1,1); ^ scb_iface.c:20:14: warning: passing arguments to 'wdiag' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] m = wdiag(lfd_scb, scb_sp, des_scb,l,&lf_scb->dv,reqd,2,0); ^ scb_iface.c:23:15: warning: passing arguments to 'wdiagp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] m = wdiagp(lfd_scb, scb_sp, des_scb,l,&lf_scb->pc,&lf_scb->dv,reqd,2,0); ^ scb_crit.c:37:28: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] return(2*exp(d*LOGPI/2.0-LGAMMA(d/2.0))); ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ In file included from scb_iface.c:6: In file included from ./local.h:107: ./lffuns.h:132:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int constants(); ^ void scb_iface.c:48:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int constants(design *des, lfit *lf) ^ scb_iface.c:66:23: warning: passing arguments to 'calcp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] npar(scb_sp) = calcp(scb_sp,lf->lfd.d); ^ scb_iface.c:67:11: warning: passing arguments to 'des_init' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des_init(des,m,npar(scb_sp)); ^ scb_iface.c:68:13: warning: passing arguments to 'set_scales' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] set_scales(&lf->lfd); ^ scb_iface.c:69:11: warning: passing arguments to 'set_flim' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] set_flim(&lf->lfd,&lf->evs); ^ scb_iface.c:70:14: warning: passing arguments to 'compparcomp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] compparcomp(des,&lf->lfd,&lf->sp,&lf->pc,geth(&lf->fp),ker(scb_sp)!=WPARM); ^ scb_iface.c:72:15: warning: passing arguments to 'k0_reqd' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] rw = k0_reqd(d,m,0); ^ scb_iface.c:78:22: warning: passing arguments to 'tube_constants' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] nt = tube_constants(scbfitter,d,m,ev(evs),mg(evs),evs->fl, ^ In file included from scb_crit.c:9: In file included from ./local.h:95: ./tube.h:16:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double tailp(), taild(); ^ void scb_crit.c:100:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double tailp(double c, double *k0, int m, int d, int s, double nu, int process) ^ In file included from scb_crit.c:9: In file included from ./local.h:95: ./tube.h:16:24: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double tailp(), taild(); ^ void scb_crit.c:111:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double taild(double c, double *k0, int m, int d, int s, double nu, int process) ^ In file included from scb_crit.c:9: In file included from ./local.h:95: ./tube.h:15:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double critval(); ^ void scb_crit.c:122:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double critval(double alpha, double *k0, int m, int d, int s, double nu, int process) ^ scb_crit.c:164:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { tp = tpf(c,k0,m,d,s,nu)-alpha; ^ scb_crit.c:165:13: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] td = tdf(c,k0,m,d,s,nu); ^ 12 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c simul.c -o simul.o 20 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c smisc.c -o smisc.o simul.c:21:14: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] yy[i] = f(xx[i],des,tr,meth); ^ simul.c:30:11: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y[2] = f(x[2],des,tr,meth); ^ simul.c:36:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y[1] = f(x[1],des,tr,meth); ^ simul.c:42:15: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] y[2] = f(x[2],des,tr,meth); ^ simul.c:70:10: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procv,0); ^ simul.c:71:10: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ressumm(lf,des); ^ simul.c:86:10: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procv,0); ^ simul.c:87:10: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ressumm(lf,des); ^ simul.c:119:12: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procv,0); ^ simul.c:124:21: warning: passing arguments to 'Wikk' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] h5 = sig2 * Wikk(ker(&lf->sp),dg0) / th; ^ simul.c:147:12: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procv,0); ^ simul.c:163:10: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procv,0); ^ simul.c:176:12: warning: passing arguments to 'Wikk' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype]smisc.c:15:19: warning: passing arguments to 'critval' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] z[i] = critval(1-cov[i], k0, (int)(*m), (int)(*d), TWO_SIDED,*rdf, (*rdf==0) ? GAUSS : TPROC); ^ hh = Wikk(mk,dg0)*sig2/th22*(n-20.0)/n; ^ smisc.c:21:9: warning: passing arguments to 'kdecri' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] kdecri(x,*h,res,0.0,3,WGAUS,*n); ^ smisc.c:30:12: warning: passing arguments to 'kdeselect' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] kdeselect(band,x,ind,*h0,*h1,imeth,(int)*nmeth,(int)*ker,(int)mi[MN]); ^ In file included from simul.c:6: In file included from ./local.h:107: ./lffuns.h:135:54: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void liksim(), scbsim(), scbmax(), regband(), rband(); ^ void simul.c:180:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void rband(design *des, lfit *lf, double *hhat, int *meth, int nmeth) ^ simul.c:189:10: warning: passing arguments to 'startlf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf(des,lf,procv,0); ^ simul.c:190:10: warning: passing arguments to 'ressumm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] ressumm(lf,des); ^ 8 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c startlf.c -o startlf.o 3 warnings generated. clang -arch x86_64 -std=gnu17 -I"/Library/Frameworks/R.framework/Resources/include" -DNDEBUG -I/opt/R/x86_64/include -fPIC -falign-functions=64 -Wall -g -O2 -c weight.c -o weight.o In file included from startlf.c:21: In file included from ./local.h:107: ./lffuns.h:138:50: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void set_flim(), set_scales(), startlf(), lfit_init(); ^ void startlf.c:44:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void lfit_init(lfit *lf) ^ startlf.c:47:14: warning: passing arguments to 'lfdata_init' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] lfdata_init(&lf->lfd); ^ startlf.c:49:13: warning: passing arguments to 'smpar_init' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] smpar_init(&lf->sp,&lf->lfd); ^ startlf.c:50:13: warning: passing arguments to 'deriv_init' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] deriv_init(&lf->dv); ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:150:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double W(), weight(), weightd(), Wd(), Wdd(), wint(); ^ void weight.c:14:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double W(double u, int ker) ^ In file included from startlf.c:21: In file included from ./local.h:107: ./lffuns.h:138:13: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void set_flim(), set_scales(), startlf(), lfit_init(); ^ void startlf.c:60:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void set_flim(lfdata *lfd, evstruc *evs) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:152:12: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int iscompact(), wtaylor(); ^ void weight.c:43:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int iscompact(int ker) ^ In file included from startlf.c:21: In file included from ./local.h:107: ./lffuns.h:138:25: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void set_flim(), set_scales(), startlf(), lfit_init(); ^ void startlf.c:110:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void set_scales(lfdata *lfd) ^ weight.c:82:23: warning: passing arguments to 'rho' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if (!hasdi) di = rho(u,lfd->sca,lfd->d,KSPH,lfd->sty); ^ In file included from startlf.c:21: In file included from ./local.h:107: ./lffuns.h:138:39: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern void set_flim(), set_scales(), startlf(), lfit_init();In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:150:20: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double W(), weight(), weightd(), Wd(), Wdd(), wint(); ^ void weight.c:93:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double weight(lfdata *lfd, smpar *sp, double *x, double *t, double h, int hasdi, double di) ^ ^ void startlf.c:121:6: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] void startlf(design *des, lfit *lf, int (*vfun)(), int nopc) ^ startlf.c:129:24: warning: passing arguments to 'calcp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] npar(&lf->sp) = calcp(&lf->sp,lf->lfd.d); ^ startlf.c:131:11: warning: passing arguments to 'des_init' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] des_init(des,n,npar(&lf->sp)); ^ startlf.c:135:14: warning: passing arguments to 'compparcomp' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] compparcomp(des,&lf->lfd,&lf->sp,&lf->pc,geth(&lf->fp),nopc); ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:150:30: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double W(), weight(), weightd(), Wd(), Wdd(), wint(); ^ void weight.c:136:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double weightd(double u, double sc, int d, int ker, int kt, double h, int sty, double di) ^ startlf.c:136:10: warning: passing arguments to 'makecfn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] makecfn(&lf->sp,des,&lf->dv,lf->lfd.d); ^ startlf.c:151:30: warning: passing arguments to 'triang_start' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] { case EPHULL: triang_start(des,lf); break; ^ startlf.c:152:23: warning: passing arguments to 'dataf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case EDATA: dataf(des,lf); break; ^ startlf.c:153:24: warning: passing arguments to 'crossf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case ECROS: crossf(des,lf); break; ^ startlf.c:154:23: warning: passing arguments to 'gridf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case EGRID: gridf(des,lf); break; ^ startlf.c:155:29: warning: passing arguments to 'atree_start' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case ETREE: atree_start(des,lf); break; ^ startlf.c:157:29: warning: passing arguments to 'kdtre_start' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case EKDTR: kdtre_start(des,lf); break; ^ startlf.c:158:24: warning: passing arguments to 'preset' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case EPRES: preset(des,lf); break; ^ startlf.c:159:23: warning: passing arguments to 'xbarf' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype]In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:150:41: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double W(), weight(), weightd(), Wd(), Wdd(), wint(); ^ void weight.c:165:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wd(double u, int ker) ^ case EXBAR: xbarf(des,lf); break; ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:150:47: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double W(), weight(), weightd(), Wd(), Wdd(), wint(); ^ void weight.c:185:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wdd(double u, int ker) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:150:54: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] startlf.cextern double W(), weight(), weightd(), Wd(), Wdd(), wint(); ^ void weight.c:206:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double wint(int d, int *j, int nj, int ker) ^ weight.c:233:30: warning: :162:30: warning: passing arguments to 'sphere_start' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case ESPHR: sphere_start(des,lf); break; ^ startlf.c:163:31: warning: passing arguments to a function without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case ESPEC: lf->evs.espec(des,lf); break; ^ startlf.c:168:55: warning: passing arguments to 'dens_renorm' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] if ((de_renorm) && (fam(&lf->sp)==TDEN)) dens_renorm(lf,des); ^ passing arguments to 'factorial' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case WEXPL: I = factorial(dj-1)/ipower(EFACT,dj); break; ^ weight.c:233:43: warning: passing arguments to 'ipower' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] case WEXPL: I = factorial(dj-1)/ipower(EFACT,dj); break; ^ weight.c:237:22: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] z = (d-nj)*LOGPI/2-LGAMMA(dj/2.0); ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ weight.c:238:29: warning: passing arguments to 'Rf_lgammafn' without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] for (k=0; k<nj; k++) z += LGAMMA((j[k]+1)/2.0); ^ ./local.h:89:32: note: expanded from macro 'LGAMMA' #define LGAMMA(arg) Rf_lgammafn(arg) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:152:25: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern int iscompact(), wtaylor(); ^ void weight.c:247:5: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] int wtaylor(double *f, double x, int ker) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:151:15: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double Wconv(), Wconv1(), Wconv4(), Wconv5(), Wconv6(), Wikk(); ^ void weight.c:319:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wconv(double v, int ker) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:151:24: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double Wconv(), Wconv1(), Wconv4(), Wconv5(), Wconv6(), Wikk(); ^ void weight.c:346:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wconv1(double v, int ker) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:151:34: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double Wconv(), Wconv1(), Wconv4(), Wconv5(), Wconv6(), Wikk(); ^ void weight.c:370:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wconv4(double v, int ker) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:151:44: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double Wconv(), Wconv1(), Wconv4(), Wconv5(), Wconv6(), Wikk(); ^ void weight.c:385:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wconv5(double v, int ker) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:151:54: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double Wconv(), Wconv1(), Wconv4(), Wconv5(), Wconv6(), Wikk(); ^ void weight.c:400:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wconv6(double v, int ker) ^ In file included from weight.c:10: In file included from ./local.h:107: ./lffuns.h:151:64: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] extern double Wconv(), Wconv1(), Wconv4(), Wconv5(), Wconv6(), Wikk(); ^ void weight.c:418:8: warning: a function declaration without a prototype is deprecated in all versions of C and is not supported in C2x [-Wdeprecated-non-prototype] double Wikk(int ker, int deg) ^ 9 warnings generated. 17 warnings generated. 22 warnings generated. 26 warnings generated. 33 warnings generated. 25 warnings generated. clang -arch x86_64 -std=gnu17 -dynamiclib -Wl,-headerpad_max_install_names -undefined dynamic_lookup -L/Library/Frameworks/R.framework/Resources/lib -L/opt/R/x86_64/lib -o locfit.so S_enter.o band.o dbinom.o dens_haz.o dens_int.o dens_odi.o density.o ev_atree.o ev_interp.o ev_kdtre.o ev_main.o ev_sphere.o ev_trian.o family.o fitted.o frend.o lf_adap.o lf_dercor.o lf_fitfun.o lf_nbhd.o lf_robust.o lf_vari.o lf_wdiag.o lfstr.o locfit.o m_chol.o m_eigen.o m_icirc.o m_imont.o m_isimp.o m_isphr.o m_jacob.o m_max.o m_qr.o m_solve.o m_svd.o m_vector.o math.o minmax.o pcomp.o preplot.o prob.o procv.o scb.o scb_cons.o scb_crit.o scb_iface.o simul.o smisc.o startlf.o weight.o -F/Library/Frameworks/R.framework/.. -framework R -Wl,-framework -Wl,CoreFoundation installing to /Volumes/Builds/packages/big-sur-x86_64/results/4.4/locfit.Rcheck/00LOCK-locfit/00new/locfit/libs ** generating debug symbols (dSYM) ** R ** data ** byte-compile and prepare package for lazy loading ** help *** installing help indices ** building package indices ** testing if installed package can be loaded from temporary location ** checking absolute paths in shared objects and dynamic libraries ** testing if installed package can be loaded from final location ** testing if installed package keeps a record of temporary installation path * DONE (locfit)