#include #define RVEC(A) int A##n, double*A##p #define RMAT(A) int A##r, int A##c, double* A##p #define KRVEC(A) int A##n, const double*A##p #define KRMAT(A) int A##r, int A##c, const double* A##p #define CVEC(A) int A##n, gsl_complex*A##p #define CMAT(A) int A##r, int A##c, gsl_complex* A##p #define KCVEC(A) int A##n, const gsl_complex*A##p #define KCMAT(A) int A##r, int A##c, const gsl_complex* A##p #include #include #include #include #include #include #include #include #include #include #include #include #include #include #include #define MACRO(B) do {B} while (0) #define ERROR(CODE) MACRO(return CODE;) #define REQUIRES(COND, CODE) MACRO(if(!(COND)) {ERROR(CODE);}) #define OK return 0; #define MIN(A,B) ((A)<(B)?(A):(B)) #define MAX(A,B) ((A)>(B)?(A):(B)) #ifdef DBG #define DEBUGMSG(M) printf("*** calling aux C function: %s\n",M); #else #define DEBUGMSG(M) #endif #define CHECK(RES,CODE) MACRO(if(RES) return CODE;) #ifdef DBG #define DEBUGMAT(MSG,X) printf(MSG" = \n"); gsl_matrix_fprintf(stdout,X,"%f"); printf("\n"); #else #define DEBUGMAT(MSG,X) #endif #ifdef DBG #define DEBUGVEC(MSG,X) printf(MSG" = \n"); gsl_vector_fprintf(stdout,X,"%f"); printf("\n"); #else #define DEBUGVEC(MSG,X) #endif #define DVVIEW(A) gsl_vector_view A = gsl_vector_view_array(A##p,A##n) #define DMVIEW(A) gsl_matrix_view A = gsl_matrix_view_array(A##p,A##r,A##c) #define CVVIEW(A) gsl_vector_complex_view A = gsl_vector_complex_view_array((double*)A##p,A##n) #define CMVIEW(A) gsl_matrix_complex_view A = gsl_matrix_complex_view_array((double*)A##p,A##r,A##c) #define KDVVIEW(A) gsl_vector_const_view A = gsl_vector_const_view_array(A##p,A##n) #define KDMVIEW(A) gsl_matrix_const_view A = gsl_matrix_const_view_array(A##p,A##r,A##c) #define KCVVIEW(A) gsl_vector_complex_const_view A = gsl_vector_complex_const_view_array((double*)A##p,A##n) #define KCMVIEW(A) gsl_matrix_complex_const_view A = gsl_matrix_complex_const_view_array((double*)A##p,A##r,A##c) #define V(a) (&a.vector) #define M(a) (&a.matrix) #define GCVEC(A) int A##n, gsl_complex*A##p #define KGCVEC(A) int A##n, const gsl_complex*A##p #define BAD_SIZE 2000 #define BAD_CODE 2001 #define MEM 2002 #define BAD_FILE 2003 void no_abort_on_error() { gsl_set_error_handler_off(); } int toScalarR(int code, KRVEC(x), RVEC(r)) { REQUIRES(rn==1,BAD_SIZE); DEBUGMSG("toScalarR"); KDVVIEW(x); double res; switch(code) { case 0: { res = gsl_blas_dnrm2(V(x)); break; } case 1: { res = gsl_blas_dasum(V(x)); break; } case 2: { res = gsl_vector_max_index(V(x)); break; } case 3: { res = gsl_vector_max(V(x)); break; } case 4: { res = gsl_vector_min_index(V(x)); break; } case 5: { res = gsl_vector_min(V(x)); break; } default: ERROR(BAD_CODE); } rp[0] = res; OK } inline double sign(double x) { if(x>0) { return +1.0; } else if (x<0) { return -1.0; } else { return 0.0; } } inline gsl_complex complex_abs(gsl_complex z) { gsl_complex r; r.dat[0] = gsl_complex_abs(z); r.dat[1] = 0; return r; } inline gsl_complex complex_signum(gsl_complex z) { gsl_complex r; double mag; if (z.dat[0] == 0 && z.dat[1] == 0) { r.dat[0] = 0; r.dat[1] = 0; } else { mag = gsl_complex_abs(z); r.dat[0] = z.dat[0]/mag; r.dat[1] = z.dat[1]/mag; } return r; } #define OP(C,F) case C: { for(k=0;k1,BAD_SIZE); gsl_poly_complex_workspace * w = gsl_poly_complex_workspace_alloc (an); int res = gsl_poly_complex_solve ((double*)ap, an, w, (double*)zp); CHECK(res,res); gsl_poly_complex_workspace_free (w); OK; } int vector_fscanf(char*filename, RVEC(a)) { DEBUGMSG("gsl_vector_fscanf"); DVVIEW(a); FILE * f = fopen(filename,"r"); CHECK(!f,BAD_FILE); int res = gsl_vector_fscanf(f,V(a)); CHECK(res,res); fclose (f); OK } int vector_fprintf(char*filename, char*fmt, RVEC(a)) { DEBUGMSG("gsl_vector_fprintf"); DVVIEW(a); FILE * f = fopen(filename,"w"); CHECK(!f,BAD_FILE); int res = gsl_vector_fprintf(f,V(a),fmt); CHECK(res,res); fclose (f); OK } int vector_fread(char*filename, RVEC(a)) { DEBUGMSG("gsl_vector_fread"); DVVIEW(a); FILE * f = fopen(filename,"r"); CHECK(!f,BAD_FILE); int res = gsl_vector_fread(f,V(a)); CHECK(res,res); fclose (f); OK } int vector_fwrite(char*filename, RVEC(a)) { DEBUGMSG("gsl_vector_fwrite"); DVVIEW(a); FILE * f = fopen(filename,"w"); CHECK(!f,BAD_FILE); int res = gsl_vector_fwrite(f,V(a)); CHECK(res,res); fclose (f); OK } int matrix_fprintf(char*filename, char*fmt, int ro, RMAT(m)) { DEBUGMSG("matrix_fprintf"); FILE * f = fopen(filename,"w"); CHECK(!f,BAD_FILE); int i,j,sr,sc; if (ro==1) { sr = mc; sc = 1;} else { sr = 1; sc = mr;} #define AT(M,r,c) (M##p[(r)*sr+(c)*sc]) for (i=0; isize,sizeof(double)); int k; for(k=0;ksize;k++) { p[k] = gsl_vector_get(x,k); } double res = f(x->size,p); free(p); return res; } // this version returns info about intermediate steps int minimize(int method, double f(int, double*), double tolsize, int maxit, KRVEC(xi), KRVEC(sz), RMAT(sol)) { REQUIRES(xin==szn && solr == maxit && solc == 3+xin,BAD_SIZE); DEBUGMSG("minimizeList (nmsimplex)"); gsl_multimin_function my_func; // extract function from pars my_func.f = only_f_aux_min; my_func.n = xin; my_func.params = f; size_t iter = 0; int status; double size; const gsl_multimin_fminimizer_type *T; gsl_multimin_fminimizer *s = NULL; // Initial vertex size vector KDVVIEW(sz); // Starting point KDVVIEW(xi); // Minimizer nmsimplex, without derivatives switch(method) { case 0 : {T = gsl_multimin_fminimizer_nmsimplex; break; } #ifdef GSL110 case 1 : {T = gsl_multimin_fminimizer_nmsimplex; break; } #else case 1 : {T = gsl_multimin_fminimizer_nmsimplex2; break; } #endif default: ERROR(BAD_CODE); } s = gsl_multimin_fminimizer_alloc (T, my_func.n); gsl_multimin_fminimizer_set (s, &my_func, V(xi), V(sz)); do { status = gsl_multimin_fminimizer_iterate (s); size = gsl_multimin_fminimizer_size (s); solp[iter*solc+0] = iter+1; solp[iter*solc+1] = s->fval; solp[iter*solc+2] = size; int k; for(k=0;kx,k); } iter++; if (status) break; status = gsl_multimin_test_size (size, tolsize); } while (status == GSL_CONTINUE && iter <= maxit); int i,j; for (i=iter; isize,sizeof(double)); int k; for(k=0;ksize;k++) { p[k] = gsl_vector_get(x,k); } double res = fdf->f(x->size,p); free(p); return res; } void df_aux_min(const gsl_vector * x, void * pars, gsl_vector * g) { Tfdf * fdf = ((Tfdf*) pars); double* p = (double*)calloc(x->size,sizeof(double)); double* q = (double*)calloc(g->size,sizeof(double)); int k; for(k=0;ksize;k++) { p[k] = gsl_vector_get(x,k); } fdf->df(x->size,p,g->size,q); for(k=0;ksize;k++) { gsl_vector_set(g,k,q[k]); } free(p); free(q); } void fdf_aux_min(const gsl_vector * x, void * pars, double * f, gsl_vector * g) { *f = f_aux_min(x,pars); df_aux_min(x,pars,g); } int minimizeD(int method, double f(int, double*), int df(int, double*, int, double*), double initstep, double minimpar, double tolgrad, int maxit, KRVEC(xi), RMAT(sol)) { REQUIRES(solr == maxit && solc == 2+xin,BAD_SIZE); DEBUGMSG("minimizeWithDeriv (conjugate_fr)"); gsl_multimin_function_fdf my_func; // extract function from pars my_func.f = f_aux_min; my_func.df = df_aux_min; my_func.fdf = fdf_aux_min; my_func.n = xin; Tfdf stfdf; stfdf.f = f; stfdf.df = df; my_func.params = &stfdf; size_t iter = 0; int status; const gsl_multimin_fdfminimizer_type *T; gsl_multimin_fdfminimizer *s = NULL; // Starting point KDVVIEW(xi); // conjugate gradient fr switch(method) { case 0 : {T = gsl_multimin_fdfminimizer_conjugate_fr; break; } case 1 : {T = gsl_multimin_fdfminimizer_conjugate_pr; break; } case 2 : {T = gsl_multimin_fdfminimizer_vector_bfgs; break; } case 3 : {T = gsl_multimin_fdfminimizer_vector_bfgs2; break; } case 4 : {T = gsl_multimin_fdfminimizer_steepest_descent; break; } default: ERROR(BAD_CODE); } s = gsl_multimin_fdfminimizer_alloc (T, my_func.n); gsl_multimin_fdfminimizer_set (s, &my_func, V(xi), initstep, minimpar); do { status = gsl_multimin_fdfminimizer_iterate (s); solp[iter*solc+0] = iter+1; solp[iter*solc+1] = s->f; int k; for(k=0;kx,k); } iter++; if (status) break; status = gsl_multimin_test_gradient (s->gradient, tolgrad); } while (status == GSL_CONTINUE && iter <= maxit); int i,j; for (i=iter; isize,sizeof(double)); double* q = (double*)calloc(y->size,sizeof(double)); int k; for(k=0;ksize;k++) { p[k] = gsl_vector_get(x,k); } f(x->size,p,y->size,q); for(k=0;ksize;k++) { gsl_vector_set(y,k,q[k]); } free(p); free(q); return 0; //hmmm } int root(int method, void f(int, double*, int, double*), double epsabs, int maxit, KRVEC(xi), RMAT(sol)) { REQUIRES(solr == maxit && solc == 1+2*xin,BAD_SIZE); DEBUGMSG("root_only_f"); gsl_multiroot_function my_func; // extract function from pars my_func.f = only_f_aux_root; my_func.n = xin; my_func.params = f; size_t iter = 0; int status; const gsl_multiroot_fsolver_type *T; gsl_multiroot_fsolver *s; // Starting point KDVVIEW(xi); switch(method) { case 0 : {T = gsl_multiroot_fsolver_hybrids;; break; } case 1 : {T = gsl_multiroot_fsolver_hybrid; break; } case 2 : {T = gsl_multiroot_fsolver_dnewton; break; } case 3 : {T = gsl_multiroot_fsolver_broyden; break; } default: ERROR(BAD_CODE); } s = gsl_multiroot_fsolver_alloc (T, my_func.n); gsl_multiroot_fsolver_set (s, &my_func, V(xi)); do { status = gsl_multiroot_fsolver_iterate (s); solp[iter*solc+0] = iter+1; int k; for(k=0;kx,k); } for(k=xin;k<2*xin;k++) { solp[iter*solc+k+1] = gsl_vector_get(s->f,k-xin); } iter++; if (status) /* check if solver is stuck */ break; status = gsl_multiroot_test_residual (s->f, epsabs); } while (status == GSL_CONTINUE && iter <= maxit); int i,j; for (i=iter; isize,sizeof(double)); double* q = (double*)calloc(y->size,sizeof(double)); int k; for(k=0;ksize;k++) { p[k] = gsl_vector_get(x,k); } (fjf->f)(x->size,p,y->size,q); for(k=0;ksize;k++) { gsl_vector_set(y,k,q[k]); } free(p); free(q); return 0; } int jf_aux_root(const gsl_vector * x, void * pars, gsl_matrix * jac) { Tfjf * fjf = ((Tfjf*) pars); double* p = (double*)calloc(x->size,sizeof(double)); double* q = (double*)calloc((x->size)*(x->size),sizeof(double)); int i,j,k; for(k=0;ksize;k++) { p[k] = gsl_vector_get(x,k); } (fjf->jf)(x->size,p,x->size,x->size,q); k=0; for(i=0;isize;i++) { for(j=0;jsize;j++){ gsl_matrix_set(jac,i,j,q[k++]); } } free(p); free(q); return 0; } int fjf_aux_root(const gsl_vector * x, void * pars, gsl_vector * f, gsl_matrix * g) { f_aux_root(x,pars,f); jf_aux_root(x,pars,g); return 0; } int rootj(int method, int f(int, double*, int, double*), int jac(int, double*, int, int, double*), double epsabs, int maxit, KRVEC(xi), RMAT(sol)) { REQUIRES(solr == maxit && solc == 1+2*xin,BAD_SIZE); DEBUGMSG("root_fjf"); gsl_multiroot_function_fdf my_func; // extract function from pars my_func.f = f_aux_root; my_func.df = jf_aux_root; my_func.fdf = fjf_aux_root; my_func.n = xin; Tfjf stfjf; stfjf.f = f; stfjf.jf = jac; my_func.params = &stfjf; size_t iter = 0; int status; const gsl_multiroot_fdfsolver_type *T; gsl_multiroot_fdfsolver *s; // Starting point KDVVIEW(xi); switch(method) { case 0 : {T = gsl_multiroot_fdfsolver_hybridsj;; break; } case 1 : {T = gsl_multiroot_fdfsolver_hybridj; break; } case 2 : {T = gsl_multiroot_fdfsolver_newton; break; } case 3 : {T = gsl_multiroot_fdfsolver_gnewton; break; } default: ERROR(BAD_CODE); } s = gsl_multiroot_fdfsolver_alloc (T, my_func.n); gsl_multiroot_fdfsolver_set (s, &my_func, V(xi)); do { status = gsl_multiroot_fdfsolver_iterate (s); solp[iter*solc+0] = iter+1; int k; for(k=0;kx,k); } for(k=xin;k<2*xin;k++) { solp[iter*solc+k+1] = gsl_vector_get(s->f,k-xin); } iter++; if (status) /* check if solver is stuck */ break; status = gsl_multiroot_test_residual (s->f, epsabs); } while (status == GSL_CONTINUE && iter <= maxit); int i,j; for (i=iter; if)(t,P->n,y,P->n,f); return GSL_SUCCESS; } int odejac (double t, const double y[], double *dfdy, double dfdt[], void *params) { Tode * P = ((Tode*) params); (P->j)(t,P->n,y,P->n,P->n,dfdy); int j; for (j=0; j< P->n; j++) dfdt[j] = 0.0; return GSL_SUCCESS; } int ode(int method, double h, double eps_abs, double eps_rel, int f(double, int, const double*, int, double*), int jac(double, int, const double*, int, int, double*), KRVEC(xi), KRVEC(ts), RMAT(sol)) { const gsl_odeiv_step_type * T; switch(method) { case 0 : {T = gsl_odeiv_step_rk2; break; } case 1 : {T = gsl_odeiv_step_rk4; break; } case 2 : {T = gsl_odeiv_step_rkf45; break; } case 3 : {T = gsl_odeiv_step_rkck; break; } case 4 : {T = gsl_odeiv_step_rk8pd; break; } case 5 : {T = gsl_odeiv_step_rk2imp; break; } case 6 : {T = gsl_odeiv_step_rk4imp; break; } case 7 : {T = gsl_odeiv_step_bsimp; break; } case 8 : {T = gsl_odeiv_step_gear1; break; } case 9 : {T = gsl_odeiv_step_gear2; break; } default: ERROR(BAD_CODE); } gsl_odeiv_step * s = gsl_odeiv_step_alloc (T, xin); gsl_odeiv_control * c = gsl_odeiv_control_y_new (eps_abs, eps_rel); gsl_odeiv_evolve * e = gsl_odeiv_evolve_alloc (xin); Tode P; P.f = f; P.j = jac; P.n = xin; gsl_odeiv_system sys = {odefunc, odejac, xin, &P}; double t = tsp[0]; double* y = (double*)calloc(xin,sizeof(double)); int i,j; for(i=0; i< xin; i++) { y[i] = xip[i]; solp[i] = xip[i]; } for (i = 1; i < tsn ; i++) { double ti = tsp[i]; while (t < ti) { gsl_odeiv_evolve_apply (e, c, s, &sys, &t, ti, &h, y); // if (h < hmin) h = hmin; } for(j=0; j