=================================================================== RCS file: /home/cvs/OpenXM_contrib2/asir2000/engine/Fgfs.c,v retrieving revision 1.5 retrieving revision 1.20 diff -u -p -r1.5 -r1.20 --- OpenXM_contrib2/asir2000/engine/Fgfs.c 2002/10/23 07:54:58 1.5 +++ OpenXM_contrib2/asir2000/engine/Fgfs.c 2004/02/03 23:31:57 1.20 @@ -1,17 +1,53 @@ -/* $OpenXM: OpenXM_contrib2/asir2000/engine/Fgfs.c,v 1.4 2002/09/30 06:13:07 noro Exp $ */ +/* $OpenXM: OpenXM_contrib2/asir2000/engine/Fgfs.c,v 1.19 2003/03/12 02:06:11 noro Exp $ */ #include "ca.h" void cont_pp_mv_sf(VL vl,VL rvl,P p,P *c,P *pp); void gcdsf_main(VL vl,P *pa,int m,P *r); void ugcdsf(P *pa,int m,P *r); -void head_monomial(V v,P p,P *coef,P *term); +void head_monomial(VL vl,V v,P p,P *coef,P *term); void sqfrsfmain(VL vl,P f,DCP *dcp); void pthrootsf(P f,Q m,P *r); void partial_sqfrsf(VL vl,V v,P f,P *r,DCP *dcp); void gcdsf(VL vl,P *pa,int k,P *r); void mfctrsfmain(VL vl, P f, DCP *dcp); +void next_evaluation_point(int *mev,int n); +void estimatelc_sf(VL vl,VL rvl,P c,DCP dc,int *mev,P *lcp); +void mfctrsf_hensel(VL vl,VL rvl,P f,P pp0,P u0,P v0,P lcu,P lcv,int *mev,P *up); +void substvp_sf(VL vl,VL rvl,P f,int *mev,P *r); +void shift_sf(VL vl, VL rvl, P f, int *mev, int sgn, P *r); +void adjust_coef_sf(VL vl,VL rvl,P lcu,P u0,int *mev,P *r); +void extended_gcd_modyk(P u0,P v0,V x,V y,int dy,P *cu,P *cv); +void poly_to_gfsn_poly(VL vl,P f,V v,P *r); +void gfsn_poly_to_poly(VL vl,P f,V v,P *r); +void poly_to_gfsn_poly_main(P f,V v,P *r); +void gfsn_poly_to_poly_main(P f,V v,P *r); +void gfsn_univariate_to_sfbm(P f,int dy,BM *r); +void sfbm_to_gfsn_univariate(BM f,V x,V y,P *r); +void monomialfctr_sf(VL vl,P p,P *pr,DCP *dcp) +{ + VL nvl,avl; + Q d; + P f,t,s; + DCP dc0,dc; + Obj obj; + + clctv(vl,p,&nvl); + for ( dc0 = 0, avl = nvl, f = p; avl; avl = NEXT(avl) ) { + getmindeg(avl->v,f,&d); + if ( d ) { + MKV(avl->v,t); + simp_ff((Obj)t,&obj); t = (P)obj; + NEXTDC(dc0,dc); DEG(dc) = d; COEF(dc) = t; + pwrp(vl,t,d,&s); divsp(vl,f,s,&t); f = t; + } + } + if ( dc0 ) + NEXT(dc) = 0; + *pr = f; *dcp = dc0; +} + void lex_lc(P f,P *c) { if ( !f || NUM(f) ) @@ -37,13 +73,14 @@ void sqfrsf(VL vl, P f, DCP *dcp) { DCP dc,dct; Obj obj; - P t,s,c; - VL tvl,nvl; + P t,s,c,cont; + VL tvl,onevl; simp_ff((Obj)f,&obj); f = (P)obj; lex_lc(f,&c); divsp(vl,f,c,&t); f = t; - monomialfctr(vl,f,&t,&dc); f = t; + monomialfctr_sf(vl,f,&t,&dc); f = t; clctv(vl,f,&tvl); vl = tvl; + NEWVL(onevl); NEXT(onevl)=0; if ( !vl ) ; else if ( !NEXT(vl) ) { @@ -52,9 +89,9 @@ void sqfrsf(VL vl, P f, DCP *dcp) } else { t = f; for ( tvl = vl; tvl; tvl = NEXT(tvl) ) { - reordvar(vl,tvl->v,&nvl); - cont_pp_mv_sf(vl,NEXT(nvl),t,&c,&s); t = s; - sqfrsf(vl,c,&dct); + onevl->v = tvl->v; + cont_pp_mv_sf(vl,onevl,t,&cont,&s); t = s; + sqfrsf(vl,cont,&dct); dc = append_dc(dc,NEXT(dct)); } sqfrsfmain(vl,t,&dct); @@ -338,7 +375,7 @@ void gcdsf_main(VL vl,P *pa,int m,P *r) for ( i = 0; i < m; i++ ) { reorderp(nvl,vl,pa[i],&t); cont_pp_mv_sf(nvl,rvl,t,&pc[i],&ps[i]); - head_monomial(vmin,ps[i],&ph[i],&t); + head_monomial(nvl,vmin,ps[i],&ph[i],&t); } ugcdsf(pc,m,&cont); ugcdsf(ph,m,&hg); @@ -364,7 +401,7 @@ void gcdsf_main(VL vl,P *pa,int m,P *r) substp(nvl,ps[i],vmin,s,&ph[i]); /* ge = GCD(ps[0]|x=s,...,ps[m-1]|x=s) */ gcdsf(nvl,ph,m,&ge); - head_monomial(vmin,ge,&ce,&he); + head_monomial(nvl,vmin,ge,&ce,&he); if ( NUM(he) ) { *r = cont; return; @@ -431,12 +468,11 @@ void gcdsf_main(VL vl,P *pa,int m,P *r) } } -void head_monomial(V v,P p,P *coef,P *term) +void head_monomial(VL vl,V v,P p,P *coef,P *term) { P t,s,u; DCP dc; GFS one; - VL vl; itogfs(1,&one); t = (P)one; @@ -461,14 +497,20 @@ void cont_pp_mv_sf(VL vl,VL rvl,P p,P *c,P *pp) MP t; int i,m; P *ps; + struct order_spec *spec, *currentspec; + extern struct order_spec *dp_current_spec; + currentspec = dp_current_spec; + create_order_spec(0,0,spec); + initd(spec); ptod(vl,rvl,p,&dp); for ( t = BDY(dp), m = 0; t; t = NEXT(t), m++ ); ps = (P *)ALLOCA(m*sizeof(P)); for ( t = BDY(dp), i = 0; t; t = NEXT(t), i++ ) ps[i] = C(t); - ugcdsf(ps,m,c); + gcdsf(vl,ps,m,c); divsp(vl,p,*c,pp); + initd(currentspec); } void mfctrsf(VL vl, P f, DCP *dcp) @@ -493,14 +535,20 @@ void mfctrsf(VL vl, P f, DCP *dcp) void mfctrsfmain(VL vl, P f, DCP *dcp) { - VL tvl,nvl; - DCP dc,dc0,dc1,dc2,dct; - int imin,inext,i,n; + VL tvl,nvl,rvl; + DCP dc,dc0,dc1,dc2,dct,lcfdc,dcs; + int imin,inext,i,j,n,k,np; int *da; V vx,vy; V *va; + P *l,*tl; P gcd,g,df,dfmin; P pa[2]; + P f0,pp0,spp0,c,c0,x,y,u,v,lcf,lcu,lcv,u0,v0,t,s; + P ype,yme,fin; + GFS ev,evy; + P *fp0; + int *mev,*win; clctv(vl,f,&tvl); vl = tvl; if ( !vl ) @@ -513,7 +561,7 @@ void mfctrsfmain(VL vl, P f, DCP *dcp) return; } for ( n = 0, tvl = vl; tvl; tvl = NEXT(tvl), n++ ); - va = (V *)ALLOCA(n*sizeof(int)); + va = (V *)ALLOCA(n*sizeof(V)); da = (int *)ALLOCA(n*sizeof(int)); /* find v s.t. diff(f,v) is nonzero and deg(f,v) is minimal */ imin = -1; @@ -538,7 +586,7 @@ void mfctrsfmain(VL vl, P f, DCP *dcp) } pa[0] = f; pa[1] = dfmin; - gcdsf_main(vl,pa,2,&gcd); + gcdsf(vl,pa,2,&gcd); if ( !NUM(gcd) ) { /* f = gcd * f/gcd */ mfctrsfmain(vl,gcd,&dc1); @@ -560,12 +608,17 @@ void mfctrsfmain(VL vl, P f, DCP *dcp) } NEXT(tvl) = 0; - reorderp(nvl,vl,f,&g); + fin = f; + reorderp(nvl,vl,f,&g); f = g; vx = nvl->v; vy = NEXT(nvl)->v; - if ( !NEXT(NEXT(nvl)) ) { + MKV(vx,x); + MKV(vy,y); + /* remaining variables */ + rvl = NEXT(NEXT(nvl)); + if ( !rvl ) { /* bivariate */ - sfbfctr(g,vx,vy,getdeg(vx,g),&dc1); + sfbfctr(f,vx,vy,getdeg(vx,f),&dc1); for ( dc0 = 0; dc1; dc1 = NEXT(dc1) ) { NEXTDC(dc0,dc); DEG(dc) = ONE; @@ -575,4 +628,538 @@ void mfctrsfmain(VL vl, P f, DCP *dcp) *dcp = dc0; return; } + /* n >= 3; nvl = (vx,vy,X) */ + /* find good evaluation pt for X */ + mev = (int *)CALLOC(n-2,sizeof(int)); + while ( 1 ) { + /* lcf(mev)=0 => invalid */ + substvp_sf(nvl,rvl,COEF(DC(f)),mev,&t); + if ( t ) { + substvp_sf(nvl,rvl,f,mev,&f0); + pa[0] = f0; + diffp(nvl,f0,vx,&pa[1]); + if ( pa[1] ) { + gcdsf(nvl,pa,2,&gcd); + /* XXX maybe we have to accept the case where gcd is a poly of y */ + if ( NUM(gcd) ) + break; + } + } + /* XXX if generated indices exceed q of GF(q) => error in indextogfs */ + next_evaluation_point(mev,n-2); + } + /* f0 = f(x,y,mev) */ + /* separate content; f0 may have the content wrt x */ + cont_pp_sfp(nvl,f0,&c0,&pp0); + + /* factorize pp0; pp0 = pp0(x,y+evy) = prod dc */ + sfbfctr_shift(pp0,vx,vy,getdeg(vx,pp0),&evy,&spp0,&dc); pp0 = spp0; + + if ( !NEXT(dc) ) { + /* f is irreducible */ + NEWDC(dc); DEG(dc) = ONE; COEF(dc) = fin; NEXT(dc) = 0; + *dcp = dc; + return; + } + /* ype = y+evy, yme = y-evy */ + addp(nvl,y,(P)evy,&ype); subp(nvl,y,(P)evy,&yme); + + /* shift c0; c0 <- c0(y+evy) */ + substp(nvl,c0,vy,ype,&s); c0 = s; + + /* shift f; f <- f(y+evy) */ + substp(nvl,f,vy,ype,&s); f = s; + + /* now f(x,0,mev) = c0 * prod dc */ + + /* factorize lc_x(f) */ + lcf = COEF(DC(f)); + mfctrsf(nvl,lcf,&dct); + /* skip the first element (= a number) */ + lcfdc = NEXT(dct); + + /* np = number of bivariate factors */ + for ( np = 0, dct = dc; dct; dct = NEXT(dct), np++ ); + fp0 = (P *)ALLOCA((np+1)*sizeof(P)); + for ( i = 0, dct = dc; i < np; dct = NEXT(dct), i++ ) + fp0[i] = COEF(dct); + fp0[np] = 0; + l = tl = (P *)ALLOCA((np+1)*sizeof(P)); + win = W_ALLOC(np+1); + + for ( k = 1, win[0] = 1, --np; ; ) { + itogfs(1,&u0); + /* u0 = product of selected factors */ + for ( i = 0; i < k; i++ ) { + mulp(nvl,u0,fp0[win[i]],&t); u0 = t; + } + /* we have to consider the content */ + /* f0 = c0*u0*v0 */ + mulp(nvl,LC(u0),c0,&c); estimatelc_sf(nvl,rvl,c,lcfdc,mev,&lcu); + divsp(nvl,pp0,u0,&v0); + mulp(nvl,LC(v0),c0,&c); estimatelc_sf(nvl,rvl,c,lcfdc,mev,&lcv); + mfctrsf_hensel(nvl,rvl,f,pp0,u0,v0,lcu,lcv,mev,&u); + if ( u ) { + /* save the factor */ + reorderp(vl,nvl,u,&t); + /* y -> y-evy */ + substp(vl,t,vy,yme,tl++); + + /* update f,pp0 */ + divsp(nvl,f,u,&t); f = t; + divsp(nvl,pp0,u0,&t); pp0 = t; + /* update win, fp0 */ + for ( i = 0; i < k-1; i++ ) + for ( j = win[i]+1; j < win[i+1]; j++ ) + fp0[j-i-1] = fp0[j]; + for ( j = win[k-1]+1; j <= np; j++ ) + fp0[j-k] = fp0[j]; + if ( ( np -= k ) < k ) break; + if ( np-win[0]+1 < k ) + if ( ++k <= np ) { + for ( i = 0; i < k; i++ ) + win[i] = i + 1; + continue; + } else + break; + else + for ( i = 1; i < k; i++ ) + win[i] = win[0] + i; + } else { + if ( ncombi(1,np,k,win) == 0 ) + if ( k == np ) break; + else + for ( i = 0, ++k; i < k; i++ ) + win[i] = i + 1; + } + } + reorderp(vl,nvl,f,&t); + /* y -> y-evy */ + substp(vl,t,vy,yme,tl++); + *tl = 0; + for ( dc0 = 0, i = 0; l[i]; i++ ) { + NEXTDC(dc0,dc); DEG(dc) = ONE; COEF(dc) = l[i]; + } + NEXT(dc) = 0; *dcp = dc0; } + +void next_evaluation_point(int *e,int n) +{ + int i,t,j; + + for ( i = n-1; i >= 0; i-- ) + if ( e[i] ) break; + if ( i < 0 ) e[n-1] = 1; + else if ( i == 0 ) { + t = e[0]; e[0] = 0; e[n-1] = t+1; + } else { + e[i-1]++; t = e[i]; + for ( j = i; j < n-1; j++ ) + e[j] = 0; + e[n-1] = t-1; + } +} + +/* + * dc : f1^E1*...*fk^Ek + * find e1,...,ek s.t. fi(mev)^ei | c + * and return f1^e1*...*fk^ek + * vl = (vx,vy,rvl) + */ + +void estimatelc_sf(VL vl,VL rvl,P c,DCP dc,int *mev,P *lcp) +{ + DCP dct; + P r,c1,c2,t,s,f; + int i,d; + Q q; + + for ( dct = dc, r = (P)ONE; dct; dct = NEXT(dct) ) { + if ( NUM(COEF(dct)) ) + continue; + /* constant part */ + substvp_sf(vl,rvl,COEF(dct),mev,&f); + d = QTOS(DEG(dct)); + for ( i = 0, c1 = c; i < d; i++ ) + if ( !divtp(vl,c1,f,&c2) ) + break; + else + c1 = c2; + if ( i ) { + STOQ(i,q); + pwrp(vl,COEF(dct),q,&s); mulp(vl,r,s,&t); r = t; + } + } + *lcp = r; +} + +void substvp_sf(VL vl,VL rvl,P f,int *mev,P *r) +{ + int i; + VL tvl; + P g,t; + GFS ev; + + for ( g = f, i = 0, tvl = rvl; tvl; tvl = NEXT(tvl), i++ ) { + if ( !mev ) + ev = 0; + else + indextogfs(mev[i],&ev); + substp(vl,g,tvl->v,(P)ev,&t); g = t; + } + *r = g; +} + +/* + * f <- f(X+sgn*mev) + */ + +void shift_sf(VL vl, VL rvl, P f, int *mev, int sgn, P *r) +{ + VL tvl; + int i; + P x,g,t,s; + GFS ev; + + for ( g = f, tvl = rvl, i = 0; tvl; tvl = NEXT(tvl), i++ ) { + if ( !mev[i] ) + continue; + indextogfs(mev[i],&ev); + MKV(tvl->v,x); + if ( sgn > 0 ) + addp(vl,x,(P)ev,&t); + else + subp(vl,x,(P)ev,&t); + substp(vl,g,tvl->v,t,&s); g = s; + } + *r = g; +} + +/* + * pp(f(0)) = u0*v0 + */ + +void mfctrsf_hensel(VL vl,VL rvl,P f,P pp0,P u0,P v0,P lcu,P lcv,int *mev,P *up) +{ + VL tvl,onevl; + P t,s,w,u,v,ff,si,wu,wv,fj,cont; + UM ydy; + V vx,vy; + int dy,n,i,dbd,nv,j; + int *md; + P *uh,*vh; + P x,du0,dv0,m,q,r,fin; + P *cu,*cv; + GFSN inv; + + /* check the validity of lc's and adjust coeffs */ + /* f -> lcu*lcv*x^(m+l)+... */ + mulp(vl,lcu,lcv,&t); + if ( !divtp(vl,t,LC(f),&m) ) { + *up = 0; return; + } + mulp(vl,m,f,&t); f = t; + /* u0 = am x^m+ ... -> lcu*x^m + a(m-1)*(lcu(mev)/am)*x^(m-1)+... */ + /* v0 = bm x^l+ ... -> lcv*x^l + b(l-1)*(lcv(mev)/bl)*x^(l-1)+... */ + adjust_coef_sf(vl,rvl,lcu,u0,mev,&u); + adjust_coef_sf(vl,rvl,lcv,v0,mev,&v); + + /* f <- f(X+mev), u <- u(X+mev), v <- v(X+mev) */ + fin = f; + shift_sf(vl,rvl,f,mev,1,&s); f = s; + shift_sf(vl,rvl,u,mev,1,&s); u = s; + shift_sf(vl,rvl,v,mev,1,&s); v = s; + + vx = vl->v; vy = NEXT(vl)->v; + n = getdeg(vx,f); + dy = getdeg(vy,f)+1; + MKV(vx,x); + cu = (P *)ALLOCA((n+1)*sizeof(P)); + cv = (P *)ALLOCA((n+1)*sizeof(P)); + + /* ydy = y^dy */ + ydy = C_UMALLOC(dy); DEG(ydy) = dy; COEF(ydy)[dy] = _onesf(); + setmod_gfsn(ydy); + + /* (R[y]/(y^dy))[x,X] */ + poly_to_gfsn_poly(vl,f,vy,&ff); + poly_to_gfsn_poly(vl,u,vy,&t); u = t; + poly_to_gfsn_poly(vl,v,vy,&t); v = t; + substvp_sf(vl,rvl,u,0,&u0); + substvp_sf(vl,rvl,v,0,&v0); + + /* compute a(x,y), b(x,y) s.t. a*u0+b*v0 = 1 mod y^dy */ + extended_gcd_modyk(u0,v0,vx,vy,dy,&cu[0],&cv[0]); + + /* dv0 = LC(v0)^(-1)*v0 mod y^dy */ + invgfsn((GFSN)LC(v0),&inv); mulp(vl,v0,(P)inv,&dv0); + + /* cu[i]*u0+cv[i]*v0 = x^i mod y^dy */ + /* (x*cu[i])*u0+(x*cv[i])*v0 = x^(i+1) */ + /* x*cu[i] = q*dv0+r => cu[i+1] = r */ + /* cv[i+1]*v0 = x*cv[i]*v0+q*u0*dv0 = (x*cv[i]+q*u0*inv)*v0 */ + for ( i = 1; i <= n; i++ ) { + mulp(vl,x,cu[i-1],&m); divsrp(vl,m,dv0,&q,&cu[i]); + mulp(vl,x,cv[i-1],&m); mulp(vl,q,(P)inv,&t); + mulp(vl,t,u0,&s); + addp(vl,m,s,&cv[i]); + } + +#if 0 + /* XXX : check */ + for ( i = 0; i <= n; i++ ) { + mulp(vl,cu[i],u0,&m); mulp(vl,cv[i],v0,&s); + addp(vl,m,s,&w); + printexpr(vl,w); + fprintf(asir_out,"\n"); + } +#endif + + dbd = dbound(vx,f)+1; + + /* extract homogeneous parts */ + W_CALLOC(dbd,P,uh); W_CALLOC(dbd,P,vh); + for ( i = 0; i <= dbd; i++ ) { + exthpc(vl,vx,u,i,&uh[i]); exthpc(vl,vx,v,i,&vh[i]); + } + + /* register degrees in each variables */ + for ( nv = 0, tvl = rvl; tvl; tvl = NEXT(tvl), nv++ ); + md = (int *)ALLOCA(nv*sizeof(int)); + for ( i = 0, tvl = rvl; i < nv; tvl = NEXT(tvl), i++ ) + md[i] = getdeg(tvl->v,f); + + /* XXX for removing content of factor wrt vx */ + NEWVL(onevl); onevl->v = vx; NEXT(onevl) = 0; + + for ( j = 1; j <= dbd; j++ ) { + for ( i = 0, tvl = rvl; i < nv; tvl = NEXT(tvl), i++ ) + if ( getdeg(tvl->v,u)+getdeg(tvl->v,v) > md[i] ) { + *up = 0; + return; + } + for ( i = 0, t = 0; i <= j; i++ ) { + mulp(vl,uh[i],vh[j-i],&s); addp(vl,s,t,&w); t = w; + } + + /* s = degree j part of (f-uv) */ + exthpc(vl,vx,ff,j,&fj); subp(vl,fj,t,&s); + for ( i = 0, wu = 0, wv = 0; i <= n; i++ ) { + if ( !s ) + si = 0; + else if ( VR(s) == vx ) + coefp(s,i,&si); + else if ( i == 0 ) + si = s; + else + si = 0; + if ( si ) { + mulp(vl,si,cv[i],&m); addp(vl,wu,m,&t); wu = t; + mulp(vl,si,cu[i],&m); addp(vl,wv,m,&t); wv = t; + } + } + if ( !wu ) { + gfsn_poly_to_poly(vl,u,vy,&t); + shift_sf(vl,rvl,t,mev,-1,&s); + if ( divtp(vl,fin,s,&q) ) { + cont_pp_mv_sf(vl,onevl,s,&cont,up); + return; + } + } + if ( !wv ) { + gfsn_poly_to_poly(vl,v,vy,&t); + shift_sf(vl,rvl,t,mev,-1,&s); + if ( divtp(vl,fin,s,&q) ) { + cont_pp_mv_sf(vl,onevl,q,&cont,up); + return; + } + } + addp(vl,u,wu,&t); u = t; + addp(vl,uh[j],wu,&t); uh[j] = t; + addp(vl,v,wv,&t); v = t; + addp(vl,vh[j],wv,&t); vh[j] = t; + } + gfsn_poly_to_poly(vl,u,vy,&t); + shift_sf(vl,rvl,t,mev,-1,&s); + if ( divtp(vl,fin,s,&q) ) + cont_pp_mv_sf(vl,onevl,s,&cont,up); + else + *up = 0; +} + +void adjust_coef_sf(VL vl,VL rvl,P lcu,P u0,int *mev,P *r) +{ + P lcu0,cu; + DCP dc0,dcu,dc; + + substvp_sf(vl,rvl,lcu,mev,&lcu0); + divsp(vl,lcu0,LC(u0),&cu); + for ( dc0 = 0, dcu = DC(u0); dcu; dcu = NEXT(dcu) ) { + if ( !dc0 ) { + NEXTDC(dc0,dc); + COEF(dc) = lcu; + } else { + NEXTDC(dc0,dc); + mulp(vl,cu,COEF(dcu),&COEF(dc)); + } + DEG(dc) = DEG(dcu); + } + NEXT(dc) = 0; + MKP(VR(u0),dc0,*r); +} + +void extended_gcd_modyk(P u0,P v0,V x,V y,int dy,P *cu,P *cv) +{ + BM g,h,a,b; + + gfsn_univariate_to_sfbm(u0,dy,&g); + gfsn_univariate_to_sfbm(v0,dy,&h); + sfexgcd_by_hensel(g,h,dy,&a,&b); + sfbm_to_gfsn_univariate(a,x,y,cu); + sfbm_to_gfsn_univariate(b,x,y,cv); +} + +/* (F[y])[x] -> F[x][y] */ + +void gfsn_univariate_to_sfbm(P f,int dy,BM *r) +{ + int dx,d,i; + BM b; + UM cy; + DCP dc; + + dx = getdeg(VR(f),f); + b = BMALLOC(dx,dy); + DEG(b) = dy; + for ( dc = DC(f); dc; dc = NEXT(dc) ) { + /* d : degree in x, cy : poly in y */ + d = QTOS(DEG(dc)); + cy = BDY((GFSN)COEF(dc)); + for ( i = DEG(cy); i >= 0; i-- ) + COEF(COEF(b)[i])[d] = COEF(cy)[i]; + } + for ( i = 0; i <= dy; i++ ) + degum(COEF(b)[i],dx); + *r = b; +} + +void sfbm_to_gfsn_univariate(BM f,V x,V y,P *r) +{ + P g; + VL vl; + + sfbmtop(f,x,y,&g); + NEWVL(vl); vl->v = x; + NEWVL(NEXT(vl)); NEXT(vl)->v = y; + NEXT(NEXT(vl)) = 0; + poly_to_gfsn_poly(vl,g,y,r); +} + +void poly_to_gfsn_poly(VL vl,P f,V v,P *r) +{ + VL tvl,nvl0,nvl; + P g; + + /* (x,y,...,v,...) -> (x,y,...,v) */ + for ( nvl0 = 0, tvl = vl; tvl; tvl = NEXT(tvl) ) { + if ( tvl->v != v ) { + NEXTVL(nvl0,nvl); + nvl->v = tvl->v; + } + } + NEXTVL(nvl0,nvl); + nvl->v = v; + NEXT(nvl) = 0; + reorderp(nvl0,vl,f,&g); + poly_to_gfsn_poly_main(g,v,r); +} + +void poly_to_gfsn_poly_main(P f,V v,P *r) +{ + int d; + UM u; + GFSN g; + DCP dc,dct,dc0; + + if ( !f ) + *r = f; + else if ( NUM(f) || VR(f) == v ) { + d = getdeg(v,f); + u = UMALLOC(d); + ptosfum(f,u); + MKGFSN(u,g); + *r = (P)g; + } else { + for ( dc0 = 0, dct = DC(f); dct; dct = NEXT(dct) ) { + NEXTDC(dc0,dc); + DEG(dc) = DEG(dct); + poly_to_gfsn_poly_main(COEF(dct),v,&COEF(dc)); + } + NEXT(dc) = 0; + MKP(VR(f),dc0,*r); + } +} + +void gfsn_poly_to_poly(VL vl,P f,V v,P *r) +{ + VL tvl,nvl0,nvl; + P g; + + gfsn_poly_to_poly_main(f,v,&g); + /* (x,y,...,v,...) -> (x,y,...,v) */ + for ( nvl0 = 0, tvl = vl; tvl; tvl = NEXT(tvl) ) { + if ( tvl->v != v ) { + NEXTVL(nvl0,nvl); + nvl->v = tvl->v; + } + } + NEXTVL(nvl0,nvl); + nvl->v = v; + NEXT(nvl) = 0; + reorderp(vl,nvl0,g,r); +} + +void gfsn_poly_to_poly_main(P f,V v,P *r) +{ + DCP dc,dc0,dct; + + if ( !f ) + *r = f; + else if ( NUM(f) ) { + if ( NID((Num)f) == N_GFSN ) + sfumtop(v,BDY((GFSN)f),r); + else + *r = f; + } else { + for ( dc0 = 0, dct = DC(f); dct; dct = NEXT(dct) ) { + NEXTDC(dc0,dc); + DEG(dc) = DEG(dct); + gfsn_poly_to_poly_main(COEF(dct),v,&COEF(dc)); + } + NEXT(dc) = 0; + MKP(VR(f),dc0,*r); + } +} + +void printsfum(UM f) +{ + int i; + + for ( i = DEG(f); i >= 0; i-- ) { + printf("+("); + printf("%d",IFTOF(COEF(f)[i])); + printf(")*y^%d",i); + } +} + +void printsfbm(BM f) +{ + int i; + + for ( i = DEG(f); i >= 0; i-- ) { + printf("+("); + printsfum(COEF(f)[i]); + printf(")*y^%d",i); + } +} +