| 21 | | ivec straux1(ldmat Ld, double nu, ldmat Ld0, double nu0, ivec belief, int nbest, int max_nrep, double lambda, int order_k, ivec &rgrsout){ |
| | 33 | */ |
| | 34 | |
| | 35 | |
| | 36 | /* bvec str_bitset( bvec in,ivec ns,int nbits){ |
| | 37 | //int index, bitindex,n; |
| | 38 | bvec out = in; |
| | 39 | int n; |
| | 40 | |
| | 41 | for (int i = 0; i < ns.length(); i++){ |
| | 42 | n = ns(i); |
| | 43 | out(n-2) = 1; |
| | 44 | cout << out; |
| | 45 | |
| | 46 | } |
| | 47 | |
| | 48 | return out; |
| | 49 | |
| | 50 | }*/ |
| | 51 | |
| | 52 | |
| | 53 | void str_bitset( bvec &out,ivec ns,int nbits){ |
| | 54 | for (int i = 0; i < ns.length(); i++){ |
| | 55 | out(ns(i)-2) = 1; |
| | 56 | } |
| | 57 | } |
| | 58 | |
| | 59 | |
| | 60 | |
| | 61 | |
| | 62 | |
| | 63 | |
| | 64 | double seloglik1(str_aux in){ |
| | 65 | // This is the loglikelihood (non-constant part) - this should be used in |
| | 66 | // frequent computation |
| | 67 | int len = length(in.d); |
| | 68 | int p1 = in.posit1 - 1; |
| | 69 | |
| | 70 | double i1 = -0.5*in.nu *log(in.d(p1)) -0.5*sum(log(in.d.right(len - p1 -1))); |
| | 71 | double i0 = -0.5*in.nu0*log(in.d0(p1)) -0.5*sum(log(in.d0.right(len - p1 -1))); |
| | 72 | return i1-i0; |
| | 73 | //DEBUGGing print: |
| | 74 | //fprintf('SELOGLIK1: str=%s loglik=%g\n', strPrintstr(in), l);*/ |
| | 75 | |
| | 76 | } |
| | 77 | |
| | 78 | |
| | 79 | void sedydr(mat &r,mat &f,double &Dr,double &Df,int R/*,int jl,int jh ,mat &rout, mat &fout, double &Drout, double &Dfoutint &kr*/){ |
| | 80 | /*SEDYDR dyadic reduction, performs transformation of sum of 2 dyads |
| | 81 | % |
| | 82 | % [rout, fout, Drout, Dfout, kr] = sedydr(r,f,Dr,Df,R,jl,jh); |
| | 83 | % [rout, fout, Drout, Dfout] = sedydr(r,f,Dr,Df,R); |
| | 84 | % |
| | 85 | % Description: dyadic reduction, performs transformation of sum of |
| | 86 | % 2 dyads r*Dr*r'+ f*Df*f' so that the element of r pointed by R is zeroed |
| | 87 | % |
| | 88 | % r : column vector of reduced dyad |
| | 89 | % f : column vector of reducing dyad |
| | 90 | % Dr : scalar with weight of reduced dyad |
| | 91 | % Df : scalar with weight of reducing dyad |
| | 92 | % R : scalar number giving 1 based index to the element of r, |
| | 93 | % which is to be reduced to |
| | 94 | % zero; the corresponding element of f is assumed to be 1. |
| | 95 | % jl : lower index of the range within which the dyads are |
| | 96 | % modified (can be omitted, then everything is updated) |
| | 97 | % jh : upper index of the range within which the dyads are |
| | 98 | % modified (can be omitted then everything is updated) |
| | 99 | % rout,fout,Drout,dfout : resulting two dyads |
| | 100 | % kr : coefficient used in the transformation of r |
| | 101 | % rnew = r + kr*f |
| | 102 | % |
| | 103 | % Description: dyadic reduction, performs transformation of sum of |
| | 104 | % 2 dyads r*Dr*r'+ f*Df*f' so that the element of r indexed by R is zeroed |
| | 105 | % Remark1: Constant mzero means machine zero and should be modified |
| | 106 | % according to the precision of particular machine |
| | 107 | % Remark2: jl and jh are, in fact, obsolete. It takes longer time to |
| | 108 | % compute them compared to plain version. The reason is that we |
| | 109 | % are doing vector operations in m-file. Other reason is that |
| | 110 | % we need to copy whole vector anyway. It can save half of time for |
| | 111 | % c-file, if you use it correctly. (please do tests) |
| | 112 | % |
| | 113 | % Note: naming: |
| | 114 | % se = structure estimation |
| | 115 | % dydr = dyadic reduction |
| | 116 | % |
| | 117 | % Original Fortran design: V. Peterka 17-7-89 |
| | 118 | % Modified for c-language: probably R. Kulhavy |
| | 119 | % Modified for m-language: L. Tesar 2/2003 |
| | 120 | % Updated: Feb 2003 |
| | 121 | % Project: post-ProDaCTool |
| | 122 | % Reference: none*/ |
| | 123 | |
| | 124 | /*if nargin<6; |
| | 125 | update_whole=1; |
| | 126 | else |
| | 127 | update_whole=0; |
| | 128 | end;*/ |
| | 129 | |
| | 130 | double mzero = 1e-32; |
| | 131 | |
| | 132 | if (Dr<mzero){ |
| | 133 | Dr=0; |
| | 134 | } |
| | 135 | |
| | 136 | double r0 = r(R,0); |
| | 137 | double kD = Df; |
| | 138 | double kr = r0 * Dr; |
| | 139 | |
| | 140 | |
| | 141 | Df = kD + r0 * kr; |
| | 142 | |
| | 143 | if (Df > mzero){ |
| | 144 | kD = kD / Df; |
| | 145 | kr = kr / Df; |
| | 146 | }else{ |
| | 147 | kD = 1; |
| | 148 | kr = 0; |
| | 149 | } |
| | 150 | |
| | 151 | Dr = Dr * kD; |
| | 152 | |
| | 153 | // Try to uncomment marked stuff (*) if in numerical problems, but I don't |
| | 154 | // think it can make any difference for normal healthy floating-point unit |
| | 155 | //if update_whole; |
| | 156 | r = r - r0*f; |
| | 157 | // rout(R) = 0; // * could be needed for some nonsense cases(or numeric reasons?), normally not |
| | 158 | f = f + kr*r; |
| | 159 | // fout(R) = 1; // * could be needed for some nonsense cases(or numeric reasons?), normally not |
| | 160 | /*else; |
| | 161 | rout = r; |
| | 162 | fout = f; |
| | 163 | rout(jl:jh) = r(jl:jh) - r0 * f(jl:jh); |
| | 164 | rout(R) = 0; |
| | 165 | fout(jl:jh) = f(jl:jh) + kr * rout(jl:jh); |
| | 166 | end;*/ |
| | 167 | } |
| | 168 | |
| | 169 | |
| | 170 | |
| | 171 | /*mat*/ void seswapudl(mat &L, vec &d , int i/*, vec &dout*/){ |
| | 172 | /*%SESWAPUDL swaps information matrix in decomposition V=L^T diag(d) L |
| | 173 | % |
| | 174 | % [Lout, dout] = seswapudl(L,d,i); |
| | 175 | % |
| | 176 | % L : lower triangular matrix with 1's on diagonal of the decomposistion |
| | 177 | % d : diagonal vector of diagonal matrix of the decomposition |
| | 178 | % i : index of line to be swapped with the next one |
| | 179 | % Lout : output lower triangular matrix |
| | 180 | % dout : output diagional vector of diagonal matrix D |
| | 181 | % |
| | 182 | % Description: |
| | 183 | % Lout' * diag(dout) * Lout = P(i,i+1) * L' * diag(d) * L * P(i,i+1); |
| | 184 | % |
| | 185 | % Where permutation matrix P(i,j) permutates columns if applied from the |
| | 186 | % right and line if applied from the left. |
| | 187 | % |
| | 188 | % Note: naming: |
| | 189 | % se = structure estimation |
| | 190 | % lite = light, simple |
| | 191 | % udl = U*D*L, or more precisely, L'*D*L, also called as ld |
| | 192 | % |
| | 193 | % Design : L. Tesar |
| | 194 | % Updated : Feb 2003 |
| | 195 | % Project : post-ProDaCTool |
| | 196 | % Reference: sedydr*/ |
| | 197 | |
| | 198 | int j = i+1; |
| | 199 | |
| | 200 | double pomd = d(i); |
| | 201 | d(i) = d(j); |
| | 202 | d(j) = pomd; |
| | 203 | |
| | 204 | /*vec pomL = L.get_row(i); |
| | 205 | L.set_row(i, L.get_row(j)); |
| | 206 | L.set_row(j,pomL);*/ |
| | 207 | |
| | 208 | L.swap_rows(i,j); |
| | 209 | L.swap_cols(i,j); |
| | 210 | |
| | 211 | /*pomL = L.get_col(i); |
| | 212 | L.set_col(i, L.get_col(j)); |
| | 213 | L.set_col(j,pomL);*/ |
| | 214 | |
| | 215 | //% We must be working with LINES of matrix L ! |
| | 216 | |
| | 217 | |
| | 218 | |
| | 219 | mat r = L.get_row(i); |
| | 220 | r = r.transpose(); |
| | 221 | r = r.transpose(); |
| | 222 | //???????????????? |
| | 223 | mat f = L.get_row(j); |
| | 224 | f = f.transpose(); |
| | 225 | f = f.transpose(); |
| | 226 | |
| | 227 | |
| | 228 | |
| | 229 | |
| | 230 | double Dr = d(i); |
| | 231 | double Df = d(j); |
| | 232 | |
| | 233 | sedydr(r, f, Dr, Df, j); |
| | 234 | |
| | 235 | |
| | 236 | |
| | 237 | double r0 = r(i,0); |
| | 238 | Dr = Dr*r0*r0; |
| | 239 | r = r/r0; |
| | 240 | |
| | 241 | |
| | 242 | |
| | 243 | mat pom_mat = r.transpose(); |
| | 244 | L.set_row(i, pom_mat.get_row(0)); |
| | 245 | pom_mat = f.transpose(); |
| | 246 | L.set_row(j, pom_mat.get_row(0)); |
| | 247 | |
| | 248 | d(i) = Dr; |
| | 249 | d(j) = Df; |
| | 250 | |
| | 251 | L(i,i) = 1; |
| | 252 | L(j,j) = 1; |
| | 253 | |
| | 254 | |
| | 255 | } |
| | 256 | |
| | 257 | |
| | 258 | void str_bitres(bvec &out,ivec ns,int nbits){ |
| | 259 | |
| | 260 | |
| | 261 | for (int i = 0; i < ns.length(); i++){ |
| | 262 | out(ns(i)-2) = 0; |
| | 263 | } |
| | 264 | |
| | 265 | |
| | 266 | } |
| | 267 | |
| | 268 | str_aux sestrremove(str_aux in,ivec removed_elements){ |
| | 269 | //% Removes elements from regressor |
| | 270 | int n_strL = length(in.strL); |
| | 271 | str_aux out = in; |
| | 272 | for (int i = 0; i < removed_elements.length();i++){ |
| | 273 | |
| | 274 | int f = removed_elements(i); |
| | 275 | int posit1 = (find(out.strL==1))(0); |
| | 276 | int positf = (find(out.strL==f))(0); |
| | 277 | int pom_strL; |
| | 278 | for (int g = positf-1; g >posit1 -1; g--) { |
| | 279 | //% BEGIN: We are swapping g and g+1 NOW!!!! |
| | 280 | seswapudl(out.L, out.d, g); |
| | 281 | seswapudl(out.L0, out.d0, g); |
| | 282 | |
| | 283 | pom_strL = out.strL(g); |
| | 284 | out.strL(g)= out.strL(g+1); |
| | 285 | out.strL(g+1) = pom_strL; |
| | 286 | |
| | 287 | //% END |
| | 288 | } |
| | 289 | } |
| | 290 | out.posit1 = (find(out.strL==1))(0)+1; |
| | 291 | out.strRgr = out.strL.right(n_strL - out.posit1); |
| | 292 | out.strMis = out.strL.left(out.posit1-1); |
| | 293 | str_bitres(out.bitstr,removed_elements,out.nbits); |
| | 294 | out.loglik = seloglik1(out); |
| | 295 | |
| | 296 | return out; |
| | 297 | } |
| | 298 | |
| | 299 | |
| | 300 | ivec setdiff(ivec a, ivec b){ |
| | 301 | ivec pos; |
| | 302 | |
| | 303 | for (int i = 0; i < b.length(); i++){ |
| | 304 | pos = find(a==b(i)); |
| | 305 | for (int j = 0; j < pos.length(); j++){ |
| | 306 | a.del(pos(j)-j); |
| | 307 | } |
| | 308 | } |
| | 309 | return a; |
| | 310 | } |
| | 311 | |
| | 312 | |
| | 313 | |
| | 314 | /* |
| | 315 | |
| | 316 | Array<str_aux> add_new(Array<str_aux> global_best,str_aux newone,int nbest){ |
| | 317 | // Eventually add to global best, but do not go over nbest values |
| | 318 | // Also avoids repeating things, which makes this function awfully slow |
| | 319 | |
| | 320 | Array<str_aux> global_best_out; |
| | 321 | if (global_best.length() >= nbest){ |
| | 322 | //logliks = [global_best.loglik]; |
| | 323 | |
| | 324 | vec logliks(1); |
| | 325 | logliks(0) = global_best(0).loglik; |
| | 326 | for (int j = 1; j < global_best.length(); j++) |
| | 327 | logliks = concat(logliks, global_best(j).loglik); |
| | 328 | |
| | 329 | int i, addit; |
| | 330 | double loglik = min(logliks, i); |
| | 331 | global_best_out = global_best; |
| | 332 | if (loglik < newone.loglik){ |
| | 333 | // if ~any(logliks == new.loglik); |
| | 334 | addit=1; |
| | 335 | |
| | 336 | |
| | 337 | |
| | 338 | if (newone.bitstr.length() == 1) { |
| | 339 | for (int j = 0; j < global_best.length(); j++){ |
| | 340 | for(int i = 0; i < global_best(j).bitstr.length(); i++){ |
| | 341 | |
| | 342 | if (newone.bitstr(0) == global_best(j).bitstr(i)){ |
| | 343 | addit = 0; |
| | 344 | break; |
| | 345 | } |
| | 346 | } |
| | 347 | } |
| | 348 | } |
| | 349 | if (addit){ |
| | 350 | global_best_out(i) = newone; |
| | 351 | // DEBUGging print: |
| | 352 | // fprintf('ADDED structure, add_new: %s, loglik=%g\n', strPrintstr(new), new.loglik); |
| | 353 | } |
| | 354 | } |
| | 355 | } |
| | 356 | else |
| | 357 | global_best_out = concat(global_best, newone); |
| | 358 | |
| | 359 | return global_best_out; |
| | 360 | |
| | 361 | } |
| | 362 | |
| | 363 | */ |
| | 364 | |
| | 365 | void add_new(Array<str_aux> &global_best,str_aux newone,int nbest){ |
| | 366 | // Eventually add to global best, but do not go over nbest values |
| | 367 | // Also avoids repeating things, which makes this function awfully slow |
| | 368 | |
| | 369 | int addit, i = 0; |
| | 370 | if (global_best.length() >= nbest){ |
| | 371 | //logliks = [global_best.loglik]; |
| | 372 | |
| | 373 | |
| | 374 | for (int j = 1; j < global_best.length(); j++){ |
| | 375 | if (global_best(j).loglik < global_best(i).loglik) { |
| | 376 | i = j; |
| | 377 | } |
| | 378 | } |
| | 379 | |
| | 380 | if (global_best(i).loglik < newone.loglik){ |
| | 381 | // if ~any(logliks == new.loglik); |
| | 382 | addit=1; |
| | 383 | |
| | 384 | |
| | 385 | //???????????????????????????????????????????? |
| | 386 | // V MATLABU SE MISTO DVOU A VICE DOUBLU |
| | 387 | // POROVNAVA KAZDY ZVLAST, COZ DISKRIMINUJE |
| | 388 | // VICEROZMERNE (>52) MATICE.. KOD V MATLABU |
| | 389 | // JE ZREJME SPATNE .. TODO |
| | 390 | if (newone.bitstr.length() == 1) { |
| | 391 | for (int j = 0; j < global_best.length(); j++){ |
| | 392 | for(int i = 0; i < global_best(j).bitstr.length(); i++){ |
| | 393 | |
| | 394 | if (newone.bitstr(0) == global_best(j).bitstr(i)){ |
| | 395 | addit = 0; |
| | 396 | break; |
| | 397 | } |
| | 398 | } |
| | 399 | } |
| | 400 | } |
| | 401 | |
| | 402 | |
| | 403 | //????????????????????????????????????????????????? |
| | 404 | |
| | 405 | if (addit){ |
| | 406 | global_best(i) = newone; |
| | 407 | // DEBUGging print: |
| | 408 | // fprintf('ADDED structure, add_new: %s, loglik=%g\n', strPrintstr(new), new.loglik); |
| | 409 | } |
| | 410 | } |
| | 411 | } |
| | 412 | else |
| | 413 | global_best = concat(global_best, newone); |
| | 414 | |
| | 415 | } |
| | 416 | |
| | 417 | |
| | 418 | |
| | 419 | |
| | 420 | |
| | 421 | |
| | 422 | str_aux sestrinsert(str_aux in,ivec inserted_elements){ |
| | 423 | // Moves elements into regressor |
| | 424 | int n_strL = in.strL.length(); |
| | 425 | str_aux out = in; |
| | 426 | for (int j = 0;j < inserted_elements.length(); j++){ |
| | 427 | int f = inserted_elements(j); |
| | 428 | int posit1 = (find(out.strL==1))(0); |
| | 429 | int positf = (find(out.strL==f))(0); |
| | 430 | for (int g = positf; g <= posit1-1; g++ ){ |
| | 431 | |
| | 432 | // BEGIN: We are swapping g and g+1 NOW!!!! |
| | 433 | seswapudl(out.L, out.d, g); |
| | 434 | seswapudl(out.L0, out.d0, g); |
| | 435 | |
| | 436 | |
| | 437 | int pom_strL = out.strL(g); |
| | 438 | out.strL(g)= out.strL(g+1); |
| | 439 | out.strL(g+1) = pom_strL; |
| | 440 | |
| | 441 | // END |
| | 442 | } |
| | 443 | } |
| | 444 | |
| | 445 | out.posit1 = (find(out.strL==1))(0)+1; |
| | 446 | out.strRgr = out.strL.right(n_strL - out.posit1); |
| | 447 | out.strMis = out.strL.left(out.posit1-1); |
| | 448 | str_bitset(out.bitstr,inserted_elements,out.nbits); |
| | 449 | |
| | 450 | out.loglik = seloglik1(out); |
| | 451 | |
| | 452 | |
| | 453 | |
| | 454 | return out; |
| | 455 | |
| | 456 | } |
| | 457 | |
| | 458 | double seloglik2(str_aux in){ |
| | 459 | // This is the loglikelihood (constant part) - this should be added to |
| | 460 | // everything at the end. It needs some computation, so it is useless to |
| | 461 | // make it for all the stuff |
| | 462 | double logpi = log(pi); |
| | 463 | |
| | 464 | double i1 = lgamma(in.nu /2) - 0.5*in.nu *logpi; |
| | 465 | double i0 = lgamma(in.nu0/2) - 0.5*in.nu0*logpi; |
| | 466 | return i1-i0; |
| | 467 | } |
| | 468 | |
| | 469 | |
| | 470 | |
| | 471 | |
| | 472 | ivec straux1(ldmat Ld, double nu, ldmat Ld0, double nu0, ivec belief, int nbest, int max_nrep, double lambda, int order_k, Array<str_aux> &rgrsout/*, stat &statistics*/){ |
| 46 | | full.posit1 = 1; |
| 47 | | //full.nbits = floor(log2(bitmax))-1; //!!!!!!! |
| 48 | | |
| 49 | | return ivec(0); // |
| 50 | | } |
| 51 | | |
| 52 | | |
| 53 | | |
| 54 | | } |
| | 551 | full.posit1 = 1; |
| | 552 | full.bitstr.set_size(n_data-1); |
| | 553 | full.bitstr.clear(); |
| | 554 | str_bitset(full.bitstr,full.strRgr,full.nbits); |
| | 555 | //full.nbits = std::numeric_lim its<double>::digits-1; // number of bits available in double |
| | 556 | /*bvec in(n_data-1); |
| | 557 | in.clear(); |
| | 558 | full.bitstr = str_bitset(in,full.strRgr,full.nbits);*/ |
| | 559 | |
| | 560 | |
| | 561 | |
| | 562 | |
| | 563 | full.loglik = seloglik1(full); // % loglikelihood |
| | 564 | |
| | 565 | |
| | 566 | |
| | 567 | |
| | 568 | |
| | 569 | //% construct full and empty structure |
| | 570 | full = sestrremove(full,belief_out); |
| | 571 | str_aux empty = sestrremove(full,setdiff(full.strRgr,belief_in)); |
| | 572 | |
| | 573 | //% stopping rule calculation: |
| | 574 | |
| | 575 | |
| | 576 | |
| | 577 | |
| | 578 | bmat local_max(0,0); |
| | 579 | int to, muto = 0; |
| | 580 | |
| | 581 | //% statistics: |
| | 582 | //double cputime0 = cputime; |
| | 583 | //if nargout>=3; |
| | 584 | |
| | 585 | CPU_Timer timer; |
| | 586 | timer.start(); |
| | 587 | |
| | 588 | ivec mutos(max_nrep+2); |
| | 589 | vec maxmutos(max_nrep+2); |
| | 590 | mutos.zeros(); |
| | 591 | maxmutos.zeros(); |
| | 592 | |
| | 593 | |
| | 594 | //end; |
| | 595 | //% ---------------------- |
| | 596 | |
| | 597 | //% For stopping-rule calculation |
| | 598 | //%so = 2^(n_data -1-length(belief_in)- length(belief_out)); % do we use this ? |
| | 599 | //% ---------------------- |
| | 600 | |
| | 601 | ivec all_str = linspace(1,n_data); |
| | 602 | |
| | 603 | Array<str_aux> global_best(1); |
| | 604 | global_best(0) = full; |
| | 605 | |
| | 606 | |
| | 607 | //% MAIN LOOP is here. |
| | 608 | |
| | 609 | str_aux best; |
| | 610 | for (int n_start = -1; n_start <= max_nrep; n_start++){ |
| | 611 | str_aux last,best; |
| | 612 | |
| | 613 | to = n_start+2; |
| | 614 | |
| | 615 | if (n_start == -1){ |
| | 616 | //% start from the full structure |
| | 617 | last = full; |
| | 618 | } |
| | 619 | else {if (n_start == 0) |
| | 620 | //% start from the empty structure |
| | 621 | last = empty; |
| | 622 | |
| | 623 | else{ |
| | 624 | //% start from random structure |
| | 625 | |
| | 626 | ivec last_str = find(to_bvec<int>(::concat<int>(0,floor_i(2*randu(n_data-1)))));// this creates random vector consisting of indexes, and sorted |
| | 627 | last = sestrremove(full,setdiff(all_str,::concat<int>(::concat<int>(1 ,last_str), empty.strRgr))); |
| | 628 | |
| | 629 | } |
| | 630 | } |
| | 631 | //% DEBUGging print: |
| | 632 | //%fprintf('STRUCTURE generated in loop %2i was %s\n', n_start, strPrintstr(last)); |
| | 633 | |
| | 634 | //% The loop is repeated until likelihood stops growing (break condition |
| | 635 | //% used at the end; |
| | 636 | |
| | 637 | |
| | 638 | while (1){ |
| | 639 | //% This structure is going to hold the best elements |
| | 640 | best = last; |
| | 641 | //% Nesting by removing elements (enpoorment) |
| | 642 | ivec removed_items = setdiff(last.strRgr,belief_in); |
| | 643 | |
| | 644 | ivec removed_item; |
| | 645 | str_aux newone; |
| | 646 | |
| | 647 | for (int i = 0; i < removed_items.length(); i++){ |
| | 648 | removed_item = vec_1(removed_items(i)); |
| | 649 | newone = sestrremove(last,removed_item); |
| | 650 | if (nbest>1){ |
| | 651 | add_new(global_best,newone,nbest); |
| | 652 | } |
| | 653 | if (newone.loglik>best.loglik){ |
| | 654 | best = newone; |
| | 655 | } |
| | 656 | } |
| | 657 | //% Nesting by adding elements (enrichment) |
| | 658 | ivec added_items = setdiff(last.strMis,belief_out); |
| | 659 | ivec added_item; |
| | 660 | |
| | 661 | for (int j = 0; j < added_items.length(); j++){ |
| | 662 | added_item = vec_1(added_items(j)); |
| | 663 | newone = sestrinsert(last,added_item); |
| | 664 | if (nbest>1){ |
| | 665 | add_new(global_best,newone,nbest); |
| | 666 | } |
| | 667 | if (newone.loglik>best.loglik){ |
| | 668 | best = newone; |
| | 669 | } |
| | 670 | } |
| | 671 | |
| | 672 | |
| | 673 | |
| | 674 | |
| | 675 | |
| | 676 | //% Break condition if likelihood does not change. |
| | 677 | if (best.loglik <= last.loglik) |
| | 678 | break; |
| | 679 | else |
| | 680 | //% Making best structure last structure. |
| | 681 | last = best; |
| | 682 | |
| | 683 | |
| | 684 | } |
| | 685 | |
| | 686 | |
| | 687 | |
| | 688 | |
| | 689 | |
| | 690 | // % DEBUGging print: |
| | 691 | //%fprintf('STRUCTURE found (local maxima) in loop %2i was %s randun_seed=%11lu randun_counter=%4lu\n', n_start, strPrintstr(best), randn('seed'), RANDUN_COUNTER); |
| | 692 | |
| | 693 | //% Collecting of the best structure in case we don't need the second parameter |
| | 694 | if (nbest<=1){ |
| | 695 | if (best.loglik > global_best(0).loglik){ |
| | 696 | global_best = best; |
| | 697 | } |
| | 698 | } |
| | 699 | |
| | 700 | //% uniqueness of the structure found |
| | 701 | int append = 1; |
| | 702 | |
| | 703 | |
| | 704 | for(int j = 0; j < local_max.rows() ; j++){ |
| | 705 | if (best.bitstr == local_max.get_row(j)){ |
| | 706 | append = 0; |
| | 707 | break; |
| | 708 | } |
| | 709 | } |
| | 710 | |
| | 711 | |
| | 712 | if (append){ |
| | 713 | local_max.append_row(best.bitstr); |
| | 714 | muto = muto + 1; |
| | 715 | } |
| | 716 | |
| | 717 | //% stopping rule: |
| | 718 | double maxmuto = (to-order_k-1)/lambda-to+1; |
| | 719 | if (to>2){ |
| | 720 | if (maxmuto>=muto){ |
| | 721 | //% fprintf('*'); |
| | 722 | break; |
| | 723 | } |
| | 724 | } |
| | 725 | |
| | 726 | // do statistics if necessary: |
| | 727 | //if (nargout>=3){ |
| | 728 | mutos(to-1) = muto; |
| | 729 | maxmutos(to-1) = maxmuto; |
| | 730 | //} |
| | 731 | } |
| | 732 | |
| | 733 | //% Aftermath: The best structure was in: global_best |
| | 734 | |
| | 735 | //% Updating loglikelihoods: we have to add the constant stuff |
| | 736 | |
| | 737 | |
| | 738 | |
| | 739 | for (int f=0 ; f <global_best.length(); f++){ |
| | 740 | global_best(f).loglik = global_best(f).loglik + seloglik2(global_best(f)); |
| | 741 | } |
| | 742 | |
| | 743 | /*for f=1:length(global_best); |
| | 744 | global_best(f).loglik = global_best(f).loglik + seloglik2(global_best(f)); |
| | 745 | end;*/ |
| | 746 | |
| | 747 | |
| | 748 | //% Making first output parameter: |
| | 749 | |
| | 750 | int max_i = 0; |
| | 751 | for (int j = 1; j < global_best.length(); j++) |
| | 752 | if (global_best(max_i).loglik < (global_best(j).loglik)) max_i = j; |
| | 753 | |
| | 754 | best = global_best(max_i); |
| | 755 | |
| | 756 | //% Making the second output parameter |
| | 757 | |
| | 758 | vec logliks(global_best.length()); |
| | 759 | for (int j = 0; j < logliks.length(); j++) |
| | 760 | logliks(j) = global_best(j).loglik; |
| | 761 | |
| | 762 | ivec i = sort_index(logliks); |
| | 763 | rgrsout.set_length(global_best.length()); |
| | 764 | |
| | 765 | for (int j = global_best.length() - 1; j >= 0; j--) |
| | 766 | rgrsout(j) = global_best(i(j)); |
| | 767 | |
| | 768 | //if (nargout>=3); |
| | 769 | |
| | 770 | |
| | 771 | str_statistics statistics; |
| | 772 | |
| | 773 | statistics.allstrs = 2^(n_data -1-length(belief_in) - length(belief_out)); |
| | 774 | statistics.nrand = to-2; |
| | 775 | statistics.unique = muto; |
| | 776 | statistics.to = to; |
| | 777 | statistics.cputime_seconds = timer.get_time(); |
| | 778 | statistics.itemspeed = statistics.to / statistics.cputime_seconds; |
| | 779 | statistics.muto = muto; |
| | 780 | statistics.mutos = mutos; |
| | 781 | statistics.maxmutos = maxmutos; |
| | 782 | //end; |
| | 783 | |
| | 784 | return best.strRgr; |
| | 785 | |
| | 786 | } |
| | 787 | |
| | 788 | #ifdef LADIM |
| | 789 | //% randun seed stuff: |
| | 790 | //%randn('seed',SEED); |
| | 791 | |
| | 792 | //% --------------------- END of MAIN program -------------------- |
| | 793 | |
| | 794 | % This is needed for bitstr manipulations |
| | 795 | /*function out = str_bitset(in,ns,nbits) |
| | 796 | out = in; |
| | 797 | for n = ns; |
| | 798 | index = 1+floor((n-2)/nbits); |
| | 799 | bitindex = 1+rem(n-2,nbits); |
| | 800 | out(index) = bitset(out(index),bitindex); |
| | 801 | end; |
| | 802 | function out = str_bitres(in,ns,nbits) |
| | 803 | out = in; |
| | 804 | for n = ns; |
| | 805 | index = 1+floor((n-2)/nbits); |
| | 806 | bitindex = 1+rem(n-2,nbits); |
| | 807 | mask = bitset(0,bitindex); |
| | 808 | out(index) = bitxor(bitor(out(index),mask),mask); |
| | 809 | end;*/ |
| | 810 | |
| | 811 | function out = strPrintstr(in) |
| | 812 | out = '0'; |
| | 813 | nbits = in.nbits; |
| | 814 | for f = 2:length(in.d0); |
| | 815 | index = 1+floor((f-2)/nbits); |
| | 816 | bitindex = 1+rem(f-2,nbits); |
| | 817 | if bitget(in.bitstr(index),bitindex); |
| | 818 | out(f) = '1'; |
| | 819 | else; |
| | 820 | out(f) = '0'; |
| | 821 | end; |
| | 822 | end; |
| | 823 | |
| | 824 | /*function global_best_out = add_new(global_best,new,nbest) |
| | 825 | % Eventually add to global best, but do not go over nbest values |
| | 826 | % Also avoids repeating things, which makes this function awfully slow |
| | 827 | if length(global_best)>=nbest; |
| | 828 | logliks = [global_best.loglik]; |
| | 829 | [loglik i] = min(logliks); |
| | 830 | global_best_out = global_best; |
| | 831 | if loglik<new.loglik; |
| | 832 | % if ~any(logliks == new.loglik); |
| | 833 | addit=1; |
| | 834 | for f = [global_best.bitstr]; |
| | 835 | if f == new.bitstr; |
| | 836 | addit = 0; |
| | 837 | break; |
| | 838 | end; |
| | 839 | end; |
| | 840 | if addit; |
| | 841 | global_best_out(i) = new; |
| | 842 | % DEBUGging print: |
| | 843 | % fprintf('ADDED structure, add_new: %s, loglik=%g\n', strPrintstr(new), new.loglik); |
| | 844 | end; |
| | 845 | end; |
| | 846 | else; |
| | 847 | global_best_out = [global_best new]; |
| | 848 | end;*/ |
| | 849 | |
| | 850 | /*function out = sestrremove(in,removed_elements); |
| | 851 | % Removes elements from regressor |
| | 852 | n_strL = length(in.strL); |
| | 853 | out = in; |
| | 854 | for f=removed_elements; |
| | 855 | posit1 = find(out.strL==1); |
| | 856 | positf = find(out.strL==f); |
| | 857 | for g=(positf-1):-1:posit1; |
| | 858 | % BEGIN: We are swapping g and g+1 NOW!!!! |
| | 859 | [out.L, out.d] = seswapudl(out.L, out.d, g); |
| | 860 | [out.L0, out.d0] = seswapudl(out.L0, out.d0, g); |
| | 861 | out.strL([g g+1]) = [out.strL(g+1) out.strL(g)]; |
| | 862 | % END |
| | 863 | end; |
| | 864 | end; |
| | 865 | out.posit1 = find(out.strL==1); |
| | 866 | out.strRgr = out.strL((out.posit1+1):n_strL); |
| | 867 | out.strMis = out.strL(1:(out.posit1-1)); |
| | 868 | out.bitstr = str_bitres(out.bitstr,removed_elements,out.nbits); |
| | 869 | out.loglik = seloglik1(out);*/ |
| | 870 | |
| | 871 | /*function out = sestrinsert(in,inserted_elements); |
| | 872 | % Moves elements into regressor |
| | 873 | n_strL = length(in.strL); |
| | 874 | out = in; |
| | 875 | for f=inserted_elements; |
| | 876 | posit1 = find(out.strL==1); |
| | 877 | positf = find(out.strL==f); |
| | 878 | for g=positf:(posit1-1); |
| | 879 | % BEGIN: We are swapping g and g+1 NOW!!!! |
| | 880 | [out.L, out.d] = seswapudl(out.L, out.d, g); |
| | 881 | [out.L0, out.d0] = seswapudl(out.L0, out.d0, g); |
| | 882 | out.strL([g g+1]) = [out.strL(g+1) out.strL(g)]; |
| | 883 | % END |
| | 884 | end; |
| | 885 | end; |
| | 886 | out.posit1 = find(out.strL==1); |
| | 887 | out.strRgr = out.strL((out.posit1+1):n_strL); |
| | 888 | out.strMis = out.strL(1:(out.posit1-1)); |
| | 889 | out.bitstr = str_bitset(out.bitstr,inserted_elements,out.nbits); |
| | 890 | out.loglik = seloglik1(out);*/ |
| | 891 | |
| | 892 | % |
| | 893 | % seloglik_real = seloglik1 + seloglik2 |
| | 894 | % |
| | 895 | |
| | 896 | /*function l = seloglik1(in) |
| | 897 | % This is the loglikelihood (non-constant part) - this should be used in |
| | 898 | % frequent computation |
| | 899 | len = length(in.d); |
| | 900 | p1 = in.posit1; |
| | 901 | |
| | 902 | i1 = -0.5*in.nu *log(in.d (p1)) -0.5*sum(log(in.d ((p1+1):len))); |
| | 903 | i0 = -0.5*in.nu0*log(in.d0(p1)) -0.5*sum(log(in.d0((p1+1):len))); |
| | 904 | l = i1-i0; |
| | 905 | |
| | 906 | % DEBUGGing print: |
| | 907 | % fprintf('SELOGLIK1: str=%s loglik=%g\n', strPrintstr(in), l);*/ |
| | 908 | |
| | 909 | |
| | 910 | function l = seloglik2(in) |
| | 911 | % This is the loglikelihood (constant part) - this should be added to |
| | 912 | % everything at the end. It needs some computation, so it is useless to |
| | 913 | % make it for all the stuff |
| | 914 | logpi = log(pi); |
| | 915 | |
| | 916 | i1 = gammaln(in.nu /2) - 0.5*in.nu *logpi; |
| | 917 | i0 = gammaln(in.nu0/2) - 0.5*in.nu0*logpi; |
| | 918 | l = i1-i0; |
| | 919 | |
| | 920 | |
| | 921 | /*function [Lout, dout] = seswapudl(L,d,i); |
| | 922 | %SESWAPUDL swaps information matrix in decomposition V=L^T diag(d) L |
| | 923 | % |
| | 924 | % [Lout, dout] = seswapudl(L,d,i); |
| | 925 | % |
| | 926 | % L : lower triangular matrix with 1's on diagonal of the decomposistion |
| | 927 | % d : diagonal vector of diagonal matrix of the decomposition |
| | 928 | % i : index of line to be swapped with the next one |
| | 929 | % Lout : output lower triangular matrix |
| | 930 | % dout : output diagional vector of diagonal matrix D |
| | 931 | % |
| | 932 | % Description: |
| | 933 | % Lout' * diag(dout) * Lout = P(i,i+1) * L' * diag(d) * L * P(i,i+1); |
| | 934 | % |
| | 935 | % Where permutation matrix P(i,j) permutates columns if applied from the |
| | 936 | % right and line if applied from the left. |
| | 937 | % |
| | 938 | % Note: naming: |
| | 939 | % se = structure estimation |
| | 940 | % lite = light, simple |
| | 941 | % udl = U*D*L, or more precisely, L'*D*L, also called as ld |
| | 942 | % |
| | 943 | % Design : L. Tesar |
| | 944 | % Updated : Feb 2003 |
| | 945 | % Project : post-ProDaCTool |
| | 946 | % Reference: sedydr |
| | 947 | |
| | 948 | j = i+1; |
| | 949 | |
| | 950 | pomd = d(i); |
| | 951 | d(i) = d(j); |
| | 952 | d(j) = pomd; |
| | 953 | |
| | 954 | pomL = L(i,:); |
| | 955 | L(i,:) = L(j,:); |
| | 956 | L(j,:) = pomL; |
| | 957 | |
| | 958 | pomL = L(:,i); |
| | 959 | L(:,i) = L(:,j); |
| | 960 | L(:,j) = pomL; |
| | 961 | |
| | 962 | % We must be working with LINES of matrix L ! |
| | 963 | |
| | 964 | r = L(i,:)'; |
| | 965 | f = L(j,:)'; |
| | 966 | Dr = d(i); |
| | 967 | Df = d(j); |
| | 968 | |
| | 969 | [r, f, Dr, Df] = sedydr(r, f, Dr, Df, j); |
| | 970 | |
| | 971 | r0 = r(i); |
| | 972 | Dr = Dr*r0*r0; |
| | 973 | r = r/r0; |
| | 974 | |
| | 975 | L(i,:) = r'; |
| | 976 | L(j,:) = f'; |
| | 977 | d(i) = Dr; |
| | 978 | d(j) = Df; |
| | 979 | |
| | 980 | L(i,i) = 1; |
| | 981 | L(j,j) = 1; |
| | 982 | |
| | 983 | Lout = L; |
| | 984 | dout = d;*/ |
| | 985 | |
| | 986 | /*function [rout, fout, Drout, Dfout, kr] = sedydr(r,f,Dr,Df,R,jl,jh); |
| | 987 | %SEDYDR dyadic reduction, performs transformation of sum of 2 dyads |
| | 988 | % |
| | 989 | % [rout, fout, Drout, Dfout, kr] = sedydr(r,f,Dr,Df,R,jl,jh); |
| | 990 | % [rout, fout, Drout, Dfout] = sedydr(r,f,Dr,Df,R); |
| | 991 | % |
| | 992 | % Description: dyadic reduction, performs transformation of sum of |
| | 993 | % 2 dyads r*Dr*r'+ f*Df*f' so that the element of r pointed by R is zeroed |
| | 994 | % |
| | 995 | % r : column vector of reduced dyad |
| | 996 | % f : column vector of reducing dyad |
| | 997 | % Dr : scalar with weight of reduced dyad |
| | 998 | % Df : scalar with weight of reducing dyad |
| | 999 | % R : scalar number giving 1 based index to the element of r, |
| | 1000 | % which is to be reduced to |
| | 1001 | % zero; the corresponding element of f is assumed to be 1. |
| | 1002 | % jl : lower index of the range within which the dyads are |
| | 1003 | % modified (can be omitted, then everything is updated) |
| | 1004 | % jh : upper index of the range within which the dyads are |
| | 1005 | % modified (can be omitted then everything is updated) |
| | 1006 | % rout,fout,Drout,dfout : resulting two dyads |
| | 1007 | % kr : coefficient used in the transformation of r |
| | 1008 | % rnew = r + kr*f |
| | 1009 | % |
| | 1010 | % Description: dyadic reduction, performs transformation of sum of |
| | 1011 | % 2 dyads r*Dr*r'+ f*Df*f' so that the element of r indexed by R is zeroed |
| | 1012 | % Remark1: Constant mzero means machine zero and should be modified |
| | 1013 | % according to the precision of particular machine |
| | 1014 | % Remark2: jl and jh are, in fact, obsolete. It takes longer time to |
| | 1015 | % compute them compared to plain version. The reason is that we |
| | 1016 | % are doing vector operations in m-file. Other reason is that |
| | 1017 | % we need to copy whole vector anyway. It can save half of time for |
| | 1018 | % c-file, if you use it correctly. (please do tests) |
| | 1019 | % |
| | 1020 | % Note: naming: |
| | 1021 | % se = structure estimation |
| | 1022 | % dydr = dyadic reduction |
| | 1023 | % |
| | 1024 | % Original Fortran design: V. Peterka 17-7-89 |
| | 1025 | % Modified for c-language: probably R. Kulhavy |
| | 1026 | % Modified for m-language: L. Tesar 2/2003 |
| | 1027 | % Updated: Feb 2003 |
| | 1028 | % Project: post-ProDaCTool |
| | 1029 | % Reference: none |
| | 1030 | |
| | 1031 | if nargin<6; |
| | 1032 | update_whole=1; |
| | 1033 | else |
| | 1034 | update_whole=0; |
| | 1035 | end; |
| | 1036 | |
| | 1037 | mzero = 1e-32; |
| | 1038 | |
| | 1039 | if Dr<mzero; |
| | 1040 | Dr=0; |
| | 1041 | end; |
| | 1042 | |
| | 1043 | r0 = r(R); |
| | 1044 | kD = Df; |
| | 1045 | kr = r0 * Dr; |
| | 1046 | Dfout = kD + r0 * kr; |
| | 1047 | |
| | 1048 | if Dfout > mzero; |
| | 1049 | kD = kD / Dfout; |
| | 1050 | kr = kr / Dfout; |
| | 1051 | else; |
| | 1052 | kD = 1; |
| | 1053 | kr = 0; |
| | 1054 | end; |
| | 1055 | |
| | 1056 | Drout = Dr * kD; |
| | 1057 | |
| | 1058 | % Try to uncomment marked stuff (*) if in numerical problems, but I don't |
| | 1059 | % think it can make any difference for normal healthy floating-point unit |
| | 1060 | if update_whole; |
| | 1061 | rout = r - r0*f; |
| | 1062 | % rout(R) = 0; % * could be needed for some nonsense cases(or numeric reasons?), normally not |
| | 1063 | fout = f + kr*rout; |
| | 1064 | % fout(R) = 1; % * could be needed for some nonsense cases(or numeric reasons?), normally not |
| | 1065 | else; |
| | 1066 | rout = r; |
| | 1067 | fout = f; |
| | 1068 | rout(jl:jh) = r(jl:jh) - r0 * f(jl:jh); |
| | 1069 | rout(R) = 0; |
| | 1070 | fout(jl:jh) = f(jl:jh) + kr * rout(jl:jh); |
| | 1071 | end;*/ |
| | 1072 | |
| | 1073 | |
| | 1074 | |
| | 1075 | #endif |
| | 1076 | |
| | 1077 | |
| | 1078 | } |
| | 1079 | |