Lines Matching refs:i

96 +      "control" means (i) the power, direct or indirect, to cause the
298 + int i;
300 + for (i = 0; i < MAX_FRAMES; i++) {
301 + sprintf(filename, "%s_%03d.ppm", basename, i + 1);
304 + yvuFrames[i] = ImageUtils::allocateImage(width, height,
306 + ImageUtils::rgb2yvu(yvuFrames[i], rgbFrame, width, height);
309 + return i;
349 + for (int i = 0; i < totalFrames; i++) {
350 + mosaic.addFrame(yvuFrames[i]);
568 +# treat a multi-line C++ special comment block (i.e. a block of //! or ///
639 +# If you use STL classes (i.e. std::string, std::vector, etc.) but do not want
1008 +# *.c *.cc *.cxx *.cpp *.c++ *.java *.ii *.ixx *.ipp *.i++ *.inl *.h *.hh *.hxx
1021 + *.i++ \
1124 +# files to browse (i.e. when SOURCE_BROWSER is set to YES).
1397 +# JavaScript, DHTML, CSS and frames is required (i.e. any modern browser).
1545 +# config file, i.e. a series of assignments. You only have to provide
1768 +# interpreter (i.e. the result of `which perl').
1943 +# a graph (i.e. they become hard to read).
1948 +# files in one run (i.e. multiple -o and -T options on the command line). This
2892 + int i, j, k;
2905 + for (i = cropping_rect.left; i <= cropping_rect.right; i++)
2907 + yimg[k] = yimg[j*imgMos.Y.width+i];
2913 + for (i = cropping_rect.left; i <= cropping_rect.right; i++)
2915 + yimg[k] = vimg[j*imgMos.Y.width+i];
2921 + for (i = cropping_rect.left; i <= cropping_rect.right; i++)
2923 + yimg[k] = uimg[j*imgMos.Y.width+i];
2945 + // invalid (i.e. in the gray border).
2954 + int i, j;
2966 + for (i = 0; i<imgMos.Y.width; i++)
2987 + b[j][i] = false;
2996 + b[j][i] = true;
3013 + for (i = cropping_rect.left; i < cropping_rect.right; i++)
3015 + if (b[j][i])
3021 + if (i == cropping_rect.right) //no gray pixel in this row!
3031 + for (i = cropping_rect.left; i < cropping_rect.right; i++)
3033 + if (b[j][i])
3039 + if (i == cropping_rect.right) //no gray pixel in this row!
3049 + for (i = 0; i < imgMos.Y.width; i++)
3053 + if (b[j][i])
3061 + cropping_rect.left = i;
3067 + for (i = imgMos.Y.width-1; i >= 0; i--)
3071 + if (b[j][i])
3079 + cropping_rect.right = i;
3143 + for (int i = l; i <= r; i++)
3145 + int ii = i;
3226 + for (int i = l; i <= r; i++)
3228 + int ii = (i << dscale);
3297 + dptr->ptr[j][i] = (short) (wt0 * dptr->ptr[j][i] + .5 +
3301 + duptr->ptr[j][i] = (short) (wt0 * duptr->ptr[j][i] + .5 +
3303 + dvptr->ptr[j][i] = (short) (wt0 * dvptr->ptr[j][i] + .5 +
3318 + dptr->ptr[j][i] = (short) (y1val + yfrac * (y2val - y1val));
3327 + duptr->ptr[j][i] = (short) (y1val + yfrac * (y2val - y1val));
3334 + dvptr->ptr[j][i] = (short) (y1val + yfrac * (y2val - y1val));
3343 + dptr->ptr[j][i] = (short) (wt0 * dptr->ptr[j][i] + 0.5 +
3347 + dvptr->ptr[j][i] = (short) (wt0 * dvptr->ptr[j][i] +
3349 + duptr->ptr[j][i] = (short) (wt0 * duptr->ptr[j][i] +
3479 + int i;
3481 + for (i = width; i--;)
3484 + FrameToMosaic(trs, (double) i, 0.0, xpos, ypos);
3486 + FrameToMosaic(trs, (double) i, lasty, xpos, ypos);
3489 + for (i = height; i--;)
3491 + FrameToMosaic(trs, 0.0, (double) i, xpos, ypos);
3493 + FrameToMosaic(trs, lastx, (double) i, xpos, ypos);
3515 + for (int i = 0; i < frames_size - 1; i++)
3517 + mb = frames[i];
3572 + for (int i = 0; i < frames_size; i++)
3574 + mb = frames[i];
3597 + // Stretch this to end at the proper alignment i.e. the width of the
3958 + int i, rows;
3964 + for ( i=0 ; i < size ; i++ ) {
3965 + sp[i] = (SitePointer) i;
4149 + int i,j;
4160 + for (i=0,j=3; i<4; i++,j=rot(j)) {
4161 + onext(e+i) = onext(nextEdge+i);
4162 + onext(rot(onext(e+i))) = (EdgePointer) (e+j);
4172 +int CDelaunay::xcmpsp(int i, int j)
4174 + double d = sa[(i>=0)?sp[i]:sp1].X() - sa[(j>=0)?sp[j]:sp1].X();
4181 + d = sa[(i>=0)?sp[i]:sp1].Y() - sa[(j>=0)?sp[j]:sp1].Y();
4191 +int CDelaunay::ycmpsp(int i, int j)
4193 + double d = sa[(i>=0)?sp[i]:sp1].Y() - sa[(j>=0)?sp[j]:sp1].Y();
4200 + d = sa[(i>=0)?sp[i]:sp1].X() - sa[(j>=0)?sp[j]:sp1].X();
4210 +int CDelaunay::cmpev(int i, int j)
4212 + return (ev[i].first - ev[j].first);
4215 +void CDelaunay::swapsp(int i, int j)
4218 + t = (i>=0) ? sp[i] : sp1;
4220 + if (i>=0) {
4221 + sp[i] = (j>=0)?sp[j]:sp1;
4233 +void CDelaunay::swapev(int i, int j)
4237 + temp = ev[i];
4238 + ev[i] = ev[j];
4242 +void CDelaunay::copysp(int i, int j)
4245 + sp[j] = (i>=0)?sp[i]:sp1;
4247 + sp1 = (i>=0)?sp[i]:sp1;
4251 +void CDelaunay::copyev(int i, int j)
4253 + ev[j] = ev[i];
4492 + int c, i;
4510 + for (i = c; i--; currv++) {
4524 + int i;
4526 + for (i = 0; i < nsite; i++) {
4527 + sa[i].setNeighbor(edge);
4528 + sa[i].setNumNeighbors(0);
4529 + for (; edge->first == i && nedge; edge++, nedge--) {
4530 + sa[i].incrNumNeighbors();
4619 + int cmpev(int i, int j);
4620 + int xcmpsp(int i, int j);
4621 + int ycmpsp(int i, int j);
4623 + void swapsp(int i, int j);
4624 + void swapev(int i, int j);
4626 + void copysp(int i, int j);
4627 + void copyev(int i, int j);
5052 + int i;
5058 + for (i=0;i<m_h;i++) {
5059 + m_rows[i] = &in[(m_w)*i];
5072 + for (int i = 0; i < height; i++) {
5117 + for (int i = 0; i < height; i++) {
5273 + int i;
5274 + for (i = 0; i < img->Y.height; i++, position += img->Y.width)
5275 + img->Y.ptr[i] = position;
5276 + for (i = 0; i < img->V.height; i++, position += img->V.width)
5277 + img->V.ptr[i] = position;
5278 + for (i = 0; i < img->U.height; i++, position += img->U.width)
5279 + img->U.ptr[i] = position;
5769 + for (int i = 0; i < frames_size; i++)
5771 + if (frames[i])
5772 + delete frames[i];
5811 + for(int i=0; i<nframes; i++)
5813 + frames[i] = new MosaicFrame(this->width,this->height,false); // Do no allocate memory …
5818 + for(int i=0; i<max_frames; i++)
5820 + frames[i] = NULL;
5969 + for (int i = 0; i < frames_size; i++) sineAngle += frames[i]->trs[0][1];
5979 + for (int i = 0; i < frames_size; i++) {
5980 + memcpy(tmp, frames[i]->trs, sizeof(tmp));
5981 + mult33d(frames[i]->trs, m, tmp);
6534 + int i,j;
6541 + for (i = -scr->border; i < limit; i++) {
6542 + int t1 = in->ptr[j][i];
6543 + int t2 = in->ptr[j+1][i];
6544 + scr->ptr[j2][i] = (short)
6545 + ((6 * t1 + (in->ptr[j-1][i] + t2) + 4) >> 3);
6546 + scr->ptr[j2+1][i] = (short)((t1 + t2 + 1) >> 1);
6555 + for (i = -off; i < scr->width + off; i++) {
6556 + int i2 = i * 2;
6557 + int t1 = scr->ptr[j][i];
6558 + int t2 = scr->ptr[j][i+1];
6561 + scr->ptr[j][i-1] + t2 + 4) >> 3)));
7373 + for(int i=0; i<16; i++)
7375 + mViewportMatrix[i] = 0.0f;
7388 + for(int i=0; i<16; i++)
7390 + mScalingMatrix[i] = 0.0f;
7611 + for(int i=0; i<16; i++)
7613 + mViewportMatrix[i] = 0.0f;
7626 + for(int i=0; i<16; i++)
7628 + mScalingMatrix[i] = 0.0f;
8153 + for (int i = 0; i < input_w; i += H2L_FACTOR)
8155 + *outp++ = *(imp + i);
8165 + for (int i = 0; i < input_w; i += H2L_FACTOR)
8167 + *outp++ = *(imp + i);
8177 + for (int i = 0; i < input_w; i += H2L_FACTOR)
8179 + *outp++ = *(imp + i);
8240 + for (int i = 0; i < width; i++, yp++)
8246 + if ((i & 1) == 0)
8278 + for (int i = 0; i < width; i += 2)
8304 + for(int i=0; i<MAX_FRAMES; i++)
8306 + tImage[LR][i] = ImageUtils::allocateImage(tWidth[LR], tHeight[LR],
8308 + tImage[HR][i] = ImageUtils::allocateImage(tWidth[HR], tHeight[HR],
8318 + for(int i = 0; i < MAX_FRAMES; i++)
8320 + ImageUtils::freeImage(tImage[LR][i]);
8321 + ImageUtils::freeImage(tImage[HR][i]);
8338 + for (int i = 0; i < width; i++, yp++, vp++, up++)
8356 + int p = j*width*3+i*3;
8374 + for (int i = 0; i < planeSize; i++)
8652 + for(int i=0; i<mosaicWidth; i+=2)
8654 + V[j*mosaicWidth+i] = V[(2*j)*mosaicWidth+i]; // V
8655 + V[j*mosaicWidth+i+1] = U[(2*j)*mosaicWidth+i]; // U
8734 + int i;
8738 + for(i=0;i<n;i++) d[i]=JtJ[i][i]*opl;
8804 + int i,n,aw;
8823 + for(i=0;i<h;i++)
8825 + img[i]=aim+aw*i+1;
8837 +/*Compute derivatives Ix,Iy for a subrow of img with upper left (i,j) and width chunk_width
8839 +inline void db_IxIyRow_f(float *Ix,float *Iy,const float * const *img,int i,int j,int chunk_width)
8845 + Ix[c]=img[i][j+c-1]-img[i][j+c+1];
8846 + Iy[c]=img[i-1][j+c]-img[i+1][j+c];
8850 +/*Compute derivatives Ix,Iy for a subrow of img with upper left (i,j) and width 128
8852 +inline void db_IxIyRow_u(int *dxx,const unsigned char * const *img,int i,int j,int nc)
8857 + r1=img[i-1]+j; r2=img[i]+j; r3=img[i+1]+j;
8974 + Ix=(img[i][j+c-1]-img[i][j+c+1])>>1;
8975 + Iy=(img[i-1][j+c]-img[i+1][j+c])>>1;
9130 +/*Filter horizontally the three rows gxx,gxy,gyy into the strength subrow starting at i,j
9132 +and starting at (i,j-2)*/
9133 +inline void db_HarrisStrength_row_f(float **s,float *gxx,float *gxy,float *gyy,int i,int j,int chu…
9146 + s[i][j+c]=det-0.06f*trc*trc;
9260 +of length 124. gxx,gxy and gyy are assumed to be starting at (i,j-2) if s[i][j] is sought.
9391 + int i,chunk_width,chunk_width_p4;
9398 + for(i=0;i<5;i++)
9400 + Ix[i]=gyy+chunk_width_p4+(2*i*chunk_width_p4);
9401 + Iy[i]=Ix[i]+chunk_width_p4;
9405 + for(i=top-2;i<top+2;i++) db_IxIyRow_f(Ix[i%5],Iy[i%5],img,i,left-2,chunk_width_p4);
9408 + for(i=top;i<=bottom;i++)
9411 + db_IxIyRow_f(Ix[(i+2)%5],Iy[(i+2)%5],img,(i+2),left-2,chunk_width_p4);
9415 + Ix[(i-2)%5],Ix[(i-1)%5],Ix[i%5],Ix[(i+1)%5],Ix[(i+2)%5],
9416 + Iy[(i-2)%5],Iy[(i-1)%5],Iy[i%5],Iy[(i+1)%5],Iy[(i+2)%5]);
9419 + db_HarrisStrength_row_f(s,gxx,gxy,gyy,i,left,chunk_width);
9434 + int i;
9439 + for(i=0;i<5;i++)
9441 + Ixx[i]=gyy+(3*i+1)*128;
9442 + Ixy[i]=gyy+(3*i+2)*128;
9443 + Iyy[i]=gyy+(3*i+3)*128;
9447 + for(i=top-2;i<top+2;i++) db_IxIyRow_u(Ixx[i%5],img,i,left-2,nc);
9450 + for(i=top;i<=bottom;i++)
9453 + db_IxIyRow_u(Ixx[(i+2)%5],img,(i+2),left-2,nc);
9456 + db_gxx_gxy_gyy_row_s(gxx,Ixx[(i-2)%5],Ixx[(i-1)%5],Ixx[i%5],Ixx[(i+1)%5],Ixx[(i+2)%5],nc);
9459 + db_HarrisStrength_row_s(s[i]+left,gxx,gxy,gyy,nc);
9491 +s[i][3] should by 16 byte aligned for any i*/
9827 + int i,stop_i;
9834 + for(i=top;i<stop_i;i++)
9836 + val=db_Max_Aligned16_f(img[i]+left,w);
9958 + int i;
9960 + for(i=0;i<128;i++)
9962 + a=v1[i];
9963 + b=v2[i];
9964 + if(a>=b) m[i]=a;
9965 + else m[i]=b;
10084 + int i;
10086 + for(i=0;i<128;i++)
10088 + a=v1[i];
10089 + b=v2[i];
10090 + if(a>=b) m[i]=a;
10091 + else m[i]=b;
10099 +s[i][left-2] and sf[i][left-2] should be 16 byte aligned. Top must be at least 3*/
10106 + int i,lm2;
10115 + for(i=0;i<4;i++)
10117 + two[i]=five+(i+1)*132;
10122 + for(i=129;i<132;i++)
10124 + four[i]=0.0;
10125 + five[i]=0.0;
10129 + for(i=top-3;i<top;i++) db_MaxVector_128_Aligned16_f(two[i&3],s[i+1]+lm2,s[i+2]+lm2);
10132 + for(;i<=bottom;i++)
10135 + db_MaxVector_128_Aligned16_f(two[i&3],s[i+1]+lm2,s[i+2]+lm2);
10137 + db_MaxVector_128_Aligned16_f(four,two[i&3],two[(i-3)&3]);
10139 + db_MaxVector_128_Aligned16_f(five,four,two[(i-1)&3]);
10145 + db_MaxVector_128_SecondSourceDestAligned16_f(sf[i]+lm2,four+2,five);
10149 + int i,j,right;
10153 + for(i=top;i<=bottom;i++) for(j=left;j<right;j++)
10155 + sv=s[i][j];
10157 + if( sv>s[i-2][j-2] && sv>s[i-2][j-1] && sv>s[i-2][j] && sv>s[i-2][j+1] && sv>s[i-2][j+2] &&
10158 + sv>s[i-1][j-2] && sv>s[i-1][j-1] && sv>s[i-1][j] && sv>s[i-1][j+1] && sv>s[i-1][j+2] &&
10159 + sv>s[ i][j-2] && sv>s[ i][j-1] && sv>s[ i][j+1] && sv>s[ i][j+2] &&
10160 + sv>s[i+1][j-2] && sv>s[i+1][j-1] && sv>s[i+1][j] && sv>s[i+1][j+1] && sv>s[i+1][j+2] &&
10161 + sv>s[i+2][j-2] && sv>s[i+2][j-1] && sv>s[i+2][j] && sv>s[i+2][j+1] && sv>s[i+2][j+2])
10163 + sf[i][j-2]=0.0;
10165 + else sf[i][j-2]=sv;
10172 +outside the specified region. s[i][left-2] and sf[i][left-2] should be 16 byte aligned.
10194 + int i,j,nr;
10198 + for(i=top;i<=bottom;i++) for(j=left;j<=right;j++)
10200 + s=strength[i][j];
10203 + s>strength[i-2][j-2] && s>strength[i-2][j-1] && s>strength[i-2][j] && s>strength[i-2][…
10204 + s>strength[i-1][j-2] && s>strength[i-1][j-1] && s>strength[i-1][j] && s>strength[i-1][…
10205 + s>strength[ i][j-2] && s>strength[ i][j-1] && s>strength[ i][…
10206 + s>strength[i+1][j-2] && s>strength[i+1][j-1] && s>strength[i+1][j] && s>strength[i+1][…
10207 + s>strength[i+2][j-2] && s>strength[i+2][j-1] && s>strength[i+2][j] && s>strength[i+2][…
10210 + y_temp[nr]=(double) i;
10274 + int nr,nr_points,i,stop;
10312 + for(i=0;(i<nr)&&(nr_points<stop);i++)
10314 + if(s_temp[i]>=loc_thresh)
10317 + db_SubPixel(strength, x_temp[i], y_temp[i], x_coord[nr_points], y_c…
10319 + x_coord[nr_points]=x_temp[i];
10320 + y_coord[nr_points]=y_temp[i];
10518 + for ( int i = 0; i < *nr_corners; ++i)
10520 + int cor_x = db_roundi(*(x_coord+i));
10521 + int cor_y = db_roundi(*(y_coord+i));
10524 + x_coord[nr_corners_mask] = x_coord[i];
10525 + y_coord[nr_corners_mask] = y_coord[i];
11376 + for(int i=442; i<512; i++)
13351 + int i,j;
13357 + for(i= -1;i<=nr_v;i++)
13359 + bp[i]=b+1+(nr_h+2)*(i+1);
13362 + bp[i][j].ptr=new db_PointInfo_f [bd];
13371 + int i,j;
13377 + for(i= -1;i<=nr_v;i++)
13379 + bp[i]=b+1+(nr_h+2)*(i+1);
13382 + bp[i][j].ptr=new db_PointInfo_u [bd];
13391 + int i,j;
13393 + for(i= -1;i<=nr_v;i++) for(j= -1;j<=nr_h;j++)
13395 + delete [] bp[i][j].ptr;
13403 + int i,j;
13405 + for(i= -1;i<=nr_v;i++) for(j= -1;j<=nr_h;j++)
13407 + delete [] bp[i][j].ptr;
13415 + int i,j;
13416 + for(i= -1;i<=nr_v;i++) for(j= -1;j<=nr_h;j++) bp[i][j].nr=0;
13421 + int i,j;
13422 + for(i= -1;i<=nr_v;i++) for(j= -1;j<=nr_h;j++) bp[i][j].nr=0;
13427 + int i,xi,yi,xpos,ypos,nr;
13432 + for(i=0;i<nr_corners;i++)
13434 + xi=(int) x[i];
13435 + yi=(int) y[i];
13447 + pir->id=i;
13462 + int i,xi,yi,xpos,ypos,nr;
13467 + for(i=0;i<nr_corners;i++)
13469 + xi=(int)db_roundi(x[i]);
13470 + yi=(int)db_roundi(y[i]);
13482 + pir->id=i;
13515 + int i,xi,yi,xpos,ypos,nr,wxi,wyi;
13521 + for(i=0;i<nr_corners;i++)
13523 + xd[0]=x[i];
13524 + xd[1]=y[i];
13542 + pir->id=i;
13559 + int i,xi,yi,xpos,ypos,nr,wxi,wyi;
13565 + for(i=0;i<nr_corners;i++)
13567 + xd[0]=x[i];
13568 + xd[1]=y[i];
13586 + pir->id=i;
13606 + int i,xi,yi,xpos,ypos,nr,wxi,wyi;
13612 + for(i=0;i<nr_corners;i++)
13614 + xd[0]=x[i];
13615 + xd[1]=y[i];
13638 + pir->id=i;
13779 + int i,j,k,a,b,br_nr;
13784 + for(i=0;i<nr_v;i++) for(j=0;j<nr_h;j++)
13786 + br=&bp_l[i][j];
13792 + for(a=i-1;a<=i+1;a++)
13806 + int i,j,k,a,b,br_nr;
13811 + for(i=0;i<nr_v;i++) for(j=0;j<nr_h;j++)
13813 + br=&bp_l[i][j];
13819 + for(a=i-1;a<=i+1;a++)
13832 + int i,j,k,br_nr;
13839 + for(i=0;i<nr_v;i++) for(j=0;j<nr_h;j++)
13841 + br=&bp_l[i][j];
13869 + int i,j,k,br_nr;
13876 + for(i=0;i<nr_v;i++) for(j=0;j<nr_h;j++)
13878 + br=&bp_l[i][j];
14269 + * Interpretaqtion of results: if id_l[i] = m and id_r[i] = n,
14359 + * Interpretaqtion of results: if id_l[i] = m and id_r[i] = n,
14494 + int i;
14512 + for(i=0;i<nr_points;i++)
14623 +(left to right according to Horn), i.e. for the homogenous equivalents
14805 + int nr_roots,i,j;
14849 + for(j=0,i=0;i<nr_roots;i++)
14851 + if(roots[i]>0)
14853 + if((!signed_disambiguation) || (db_PolyEval1(p1,roots[i])*db_PolyEval1(p4,roots[i])>0))
14855 + fsol[j++]=db_SafeSqrtReciprocal(roots[i]);
14865 + int nr_sols,i,best_sol,done;
14876 + for(i=0;i<nr_sols;i++)
14878 + ft=fsol[i];
14893 + hyp_point=hyp+9*i;
14905 + best_sol=i;
14925 + int i;
14943 + for(i=0;i<nr_points;i++)
15115 +Solve for a homography H generated by a rotation R with a common unknown focal length f, i.e.
15129 +i.e. for the homogenous equivalents
15263 + i.e. when it is square-summed it gives the robust
15389 + The output Jacobian is minus their product, i.e.
15480 + The output Jacobian is minus their product, i.e.
15702 + int c,i;
15706 + for(i=0,c=0;c<point_count;c++)
15708 + i+=(db_SquaredInhomogenousHomographyError(xp_i+(c<<1),H,x_i+(c<<1))*one_over_scale2<=t2)?1…
15710 + frac=((double)i)/((double)(db_maxi(point_count,1)));
15720 + stat->nr_inliers=i;
15741 + int i;
15745 + for(back=0.0,i=0;i<point_count;i++)
15749 + db_DerivativeCauchyInhomHomographyReprojection(Jf_dx,f,xp_i+(i<<1),H,x_i+(i<<1),one_over_s…
15822 + int i,j;
15826 + for(back=0.0,i=0;i<point_count;i++)
15830 + j=(i<<1);
15855 + int i,update,stop;
15860 + for(update=1,stop=0,i=0;(stop<2) && (i<max_iterations);i++)
15895 + std::cout << "Step" << i << "Imp,Lambda=" << lambda << "Cost:" << current_cost << std::end…
15909 + int i,j,t;
15912 + for(i=0;i<n;i++)
15914 + t=fetch_vector[i];
15915 + min_Jtf[i]=min_Jtf_temp[t];
15916 + t1=JtJ_ref[i];
15918 + for(j=i;j<n;j++)
16046 + int i,j,fetch_vector[8],n;
16120 + for(j=0,i=0;i<9;i++) if(i!=(*frozen_coord))
16122 + fetch_vector[j]=i;
16196 + int i,update,stop,n;
16203 + for(update=1,stop=0,i=0;(stop<2) && (i<max_iterations);i++)
16238 + std::cout << "Step" << i << "Imp,Lambda=" << lambda << "Cost:" << current_cost << std::end…
16300 + int i,j,c,point_count,hyp_count;
16377 + for(i=0;i<nr_points;i++) point_perm[i]=i;
16379 + for(last_point=nr_points-1,i=0;i<point_count;i++,last_point--)
16388 + j=3*i;
16399 + c=(i<<1);
16486 + if(point_count>=sample_size) for(i=0;i<nr_samples;i++)
16502 + if(point_count>=2) for(i=0;i<nr_samples;i++)
16513 + if(point_count>=3) for(i=0;i<nr_samples;i++)
16523 + if(point_count>=3) for(i=0;i<nr_samples;i++)
16533 + if(point_count>=3) for(i=0;i<nr_samples;i++)
16545 + if(point_count>=4) for(i=0;i<nr_samples;i++)
16560 + for(i=0;i<hyp_count;i++)
16562 + hyp_perm[i]=i;
16563 + hyp_cost_array[i]=0.0;
16565 + for(i=0,last_hyp=hyp_count-1;(last_hyp>0) && (i<point_count);i+=chunk_size)
16568 + last_corr=db_mini(i+chunk_size-1,point_count-1);
16572 + for(c=i;c<=last_corr;)
16960 + int i;
16964 + for(i=0;i<h;i++)
16966 + img[i]=im+w*i;
16973 + int i;
16979 + for(i=0;i<h;i++)
16981 + img[i]=im+w*i;
17026 + int i;
17028 + for (i=0;i<h;i++)
17030 + memcpy(d[i],s[i],w*sizeof(unsigned char));
17043 + for ( int i = 0; i < w; ++i )
17046 + //xd = static_cast<unsigned int>(lut_x[j][i]);
17047 + //yd = static_cast<unsigned int>(lut_y[j][i]);
17048 + xd = (unsigned int)(lut_x[j][i]);
17049 + yd = (unsigned int)(lut_y[j][i]);
17052 + dst[j][i] = 0;
17054 + dst[j][i] = src[yd][xd];
17064 + for ( int i = 0; i < w; ++i )
17067 + xd = static_cast<double>(lut_x[j][i]);
17068 + yd = static_cast<double>(lut_y[j][i]);
17071 + dst[j][i] = 0;
17073 + dst[j][i] = db_BilinearInterpolation(yd, xd, src);
17098 + for(long i=0;i<size;i++) printf("%lf ",a[i]);
17105 + for(long i=0;i<rows;i++)
17107 + for(long j=0;j<cols;j++) printf("%lf ",a[i*cols+j]);
18098 + int i,j;
18100 + for(j=0,i=0;i<9;i++)
18102 + if(i!=frozen_coord)
18104 + H_p_dx[i]=H[i]+dx[j];
18107 + else H_p_dx[i]=H[i];
18382 + int i;
18386 + for(i=0;i<nr_points;i++)
18402 + int i;
18407 + for(i=0;i<nr_points;i++)
18426 + int i;
18430 + for(i=0;i<nr_points;i++)
18448 + int i;
18453 + for(i=0;i<nr_points;i++)
18506 + long i;
18507 + for(i=0;i<nr;i++) d[i]=0.0;
18639 + long i;
18640 + for(i=0;i<rows;i++) ar[i]=&a[i*cols];
18645 + int i,j;
18646 + for(i=1;i<rows;i++) for(j=0;j<i;j++) A[i][j]=A[j][i];
18651 + int i,j;
18654 + for(i=0;i<arows;i++)
18657 + for(j=0;j<acols;j++) acc+=At[j][i]*b[j];
18658 + c[i]=acc;
18664 + int i,j,k;
18667 + for(i=0;i<arows;i++) for(j=0;j<bcols;j++)
18670 + for(k=0;k<acols;k++) acc+=A[i][k]*B[k][j];
18671 + C[i][j]=acc;
18677 + int i,j,k;
18680 + for(i=0;i<arows;i++) for(j=i;j<bcols;j++)
18683 + for(k=0;k<acols;k++) acc+=At[k][i]*B[k][j];
18684 + Cu[i][j]=acc;
18914 + /*i=0*/
18923 + /*i=1*/
18931 + /*i=2*/
18938 + /*i=3*/
18944 + /*i=4*/
18949 + /*i=5*/
18960 + int i,j,k;
18964 + for(i=0;i<n;i++) for(j=i;j<n;j++)
18966 + if(i==j) s=d[i];
18967 + else s=A[i][j];
18968 + for(k=i-1;k>=0;k--) s-=A[i][k]*A[j][k];
18969 + if(i==j)
18971 + d[i]=((s>0.0)?sqrt(s):1.0);
18972 + temp=db_SafeReciprocal(d[i]);
18974 + else A[j][i]=s*temp;
18982 + int i,k;
18985 + for(i=0;i<n;i++)
18987 + for(s=b[i],k=i-1;k>=0;k--) s-=A[i][k]*x[k];
18988 + x[i]=db_SafeDivision(s,d[i]);
18990 + for(i=n-1;i>=0;i--)
18992 + for(s=x[i],k=i+1;k<n;k++) s-=A[k][i]*x[k];
18993 + x[i]=db_SafeDivision(s,d[i]);
19005 + /*i=0*/
19011 + /*i=1*/
19016 + /*i=2*/
19056 + int i;
19074 + i=db_MaxIndex5(ss+1);
19075 + db_OrthogonalizationSwap7(A+7,i,ss+1);
19082 + i=db_MaxIndex4(ss+2);
19083 + db_OrthogonalizationSwap7(A+14,i,ss+2);
19089 + i=db_MaxIndex3(ss+3);
19090 + db_OrthogonalizationSwap7(A+21,i,ss+3);
19095 + i=db_MaxIndex2(ss+4);
19096 + db_OrthogonalizationSwap7(A+28,i,ss+4);
19113 + int i;
19135 + i=db_MaxIndex7(ss+1);
19136 + db_OrthogonalizationSwap9(A+9,i,ss+1);
19145 + i=db_MaxIndex6(ss+2);
19146 + db_OrthogonalizationSwap9(A+18,i,ss+2);
19154 + i=db_MaxIndex5(ss+3);
19155 + db_OrthogonalizationSwap9(A+27,i,ss+3);
19162 + i=db_MaxIndex4(ss+4);
19163 + db_OrthogonalizationSwap9(A+36,i,ss+4);
19169 + i=db_MaxIndex3(ss+5);
19170 + db_OrthogonalizationSwap9(A+45,i,ss+5);
19175 + i=db_MaxIndex2(ss+6);
19176 + db_OrthogonalizationSwap9(A+54,i,ss+6);
19195 + int i;
19208 + i=db_MinIndex7(omss);
19211 + B=A+i;
19218 + x[i]+=1.0;
19219 + db_MultiplyScalar7(x,db_SafeSqrtReciprocal(1.0-omss[i]));
19224 + int i;
19239 + i=db_MinIndex9(omss);
19242 + B=A+i;
19251 + x[i]+=1.0;
19252 + db_MultiplyScalar9(x,db_SafeSqrtReciprocal(1.0-omss[i]));
19472 +inline void db_OrthogonalizationSwap7(double *A,int i,double *ss)
19476 + db_Swap7(A,A+7*i);
19477 + temp=ss[0]; ss[0]=ss[i]; ss[i]=temp;
19482 +inline void db_OrthogonalizationSwap9(double *A,int i,double *ss)
19486 + db_Swap9(A,A+9*i);
19487 + temp=ss[0]; ss[0]=ss[i]; ss[i]=temp;
19522 + for(int i=1; i<=512; i++)
20775 + int temp,temp2,i,j;
20777 + for(i=0;i<sample_size;i++)
20779 + temp=db_RandomInt(r_seed,pool_size-1-i);
20781 + for(j=0;j<i;j++)
20792 + s[i]=temp;
21037 +# treat a multi-line C++ special comment block (i.e. a block of //! or ///
21108 +# If you use STL classes (i.e. std::string, std::vector, etc.) but do not want
21477 +# *.c *.cc *.cxx *.cpp *.c++ *.java *.ii *.ixx *.ipp *.i++ *.inl *.h *.hh *.hxx
21490 + *.i++ \
21593 +# files to browse (i.e. when SOURCE_BROWSER is set to YES).
21866 +# JavaScript, DHTML, CSS and frames is required (i.e. any modern browser).
22014 +# config file, i.e. a series of assignments. You only have to provide
22237 +# interpreter (i.e. the result of `which perl').
22412 +# a graph (i.e. they become hard to read).
22417 +# files in one run (i.e. multiple -o and -T options on the command line). This
22859 + for ( int i = 0; i < m_nr_matches; ++i )
22861 + int offset = 3*i;
22862 + m_corners_ref[offset ] = m_x_corners_ref[m_match_index_ref[i]];
22863 + m_corners_ref[offset+1] = m_y_corners_ref[m_match_index_ref[i]];
22866 + m_corners_ins[offset ] = m_x_corners_ins[m_match_index_ins[i]];
22867 + m_corners_ins[offset+1] = m_y_corners_ins[m_match_index_ins[i]];
22979 + for (int i=0;i<num_inlier_indices;i++)
22981 + int j = 3*inlier_indices[i];
23087 + for ( int i = 0; i < m_nr_bins; ++i )
23088 + std::cout << m_cost_histogram[i] << " ";
23097 + int i = 0, last=0;
23098 + for (; i < m_nr_bins-1; ++i )
23100 + if ( last > m_cost_histogram[i] )
23102 + last = m_cost_histogram[i];
23105 + //std::cout << "I " << i << std::endl;
23107 + int max = m_cost_histogram[i];
23109 + for (; i < m_nr_bins-1; ++i )
23111 + if ( m_cost_histogram[i] < (int)(0.1*max) )
23112 + //if ( last < m_cost_histogram[i] )
23114 + last = m_cost_histogram[i];
23116 + //std::cout << "J " << i << std::endl;
23118 + m_outlier_t2 = db_sqr(i*m_max_cost_pix/m_nr_bins);
23193 + for (int i = 2; i < input_w-2; i += 2)
23196 + 6*in_row_ptr[i] +
23197 + ((in_row_ptr[i-1]+in_row_ptr[i+1])<<2) +
23198 + in_row_ptr[i-2]+in_row_ptr[i+2]
23216 + for (int i = 1; i < m_im_width-1; i++)
23219 + 6*in_row_ptr[i] +
23220 + ((in_row_ptr[i-m_im_width]+in_row_ptr[i+m_im_width]) << 2)+
23221 + in_row_ptr[i-2*m_im_width]+in_row_ptr[i+2*m_im_width]
23287 + frames and register them with respect to a so-called <i>reference</i> frame. The reference frame…
23373 …ese parameters have been set to the values used for the android implementation (i.e. the demo APK).
23483 + * \param num_inlier_indices number of inliers i.e. the length of the array passed as the f…
23687 + for ( int i = 0; i < w; ++i )
23690 + x[0] = double(i);
23696 + lut_x[j][i] = float(xb[0]);
23697 + lut_y[j][i] = float(xb[1]);
23724 + for ( int i = 0; i < w; ++i )
23727 + xd = static_cast<unsigned int>(lut_x[j][i]);
23728 + yd = static_cast<unsigned int>(lut_y[j][i]);
23732 + dst[j][3*i ] = 0;
23733 + dst[j][3*i+1] = 0;
23734 + dst[j][3*i+2] = 0;
23738 + dst[j][3*i ] = src[yd][3*xd ];
23739 + dst[j][3*i+1] = src[yd][3*xd+1];
23740 + dst[j][3*i+2] = src[yd][3*xd+2];
23770 + for ( int i = 0; i < w; ++i )
23773 + xd = static_cast<double>(lut_x[j][i]);
23774 + yd = static_cast<double>(lut_y[j][i]);
23778 + dst[j][3*i ] = 0;
23779 + dst[j][3*i+1] = 0;
23780 + dst[j][3*i+2] = 0;
23784 + dst[j][3*i ] = db_BilinearInterpolationRGB(yd,xd,src,0);
23785 + dst[j][3*i+1] = db_BilinearInterpolationRGB(yd,xd,src,1);
23786 + dst[j][3*i+2] = db_BilinearInterpolationRGB(yd,xd,src,2);
23870 + for( int i = 0; i < MOTION_ARRAY-1; i++) {
23871 + VP_MOTION_ID(f_hist_mot_speed[i]);
23872 + VP_MOTION_ID(f_hist_mot[i]);
23873 + VP_MOTION_ID(f_hist_diff_mot[i]);
23966 + // TmpMotion, or Qsi where s is the smoothed display reference and i is the
24434 + method is O(N^4), i.e. unnecessarily slow, and not numerically accurate.
24439 + int i, j, k, l, m, n,ntemp;
24447 + for(k=0,i=0;i<4;i++)
24449 + inmat[i][j]=(double)in->par[k];
24454 + for (i=0;i<4;i++) {
24458 + if (i != k) {
24470 + ntemp = (i +j ) %2;
24473 + outmat[j][i] = temp * Det3(mat)/indet;
24477 + for(k=0,i=0;i<4;i++)
24479 + out->par[k]=(VP_PAR)outmat[i][j]; /*lint !e771*/
25219 + int i;
25225 + for(i=0;i<m_h;i++)
25227 + m_rows[i]=&m_data[m_w*i];
25231 + for(i=0;i<m_h;i++)
25233 + m_rows[i]=&m_data[(m_w*3)*i];
25244 + for ( int i = 0; i < m_w*m_h; ++i )
25245 + m_data[i] = (unsigned char)(0.3*m_data[3*i]+0.59*m_data[3*i+1]+0.11*m_data[3*i+2]);
25432 + " -q : quarter the image resolution (i.e. half of each dimension) (default on)",
25647 + for (int i = 0; i < reg.GetNrMatches(); i++)
25649 … match_file << ref_corners[3*i] << " " << ref_corners[3*i+1] << " " << ins_corners[3*i] << " …
25660 + for(int i=0; i<num_inlier_indices; i++)
25662 + int k = inlier_indices[i];
26088 + for(int j = 0, i = 0;
26092 + ptr[i++] = 0;
26093 + ptr[i++] = 0;
26094 + ptr[i++] = 0;
26095 + ptr[i++] = 255;
26170 + for(int i = 0; i < 9; i++)
26172 + gThisH1t[i] = trs[i];
26193 + for(int i = 0; i < 9; i++)
26195 + gLastH1t[i] = gThisH1t[i];
26199 + // i.e. H = inv(T) * H
26639 + for(int i=0; i<16; i++)
26641 + g_dAffinetransGL[i] = g_dAffinetrans[i];
26642 + g_dAffinetransPanGL[i] = g_dAffinetransPan[i];
26643 + g_dTranslationToFBOCenterGL[i] = g_dTranslationToFBOCenter[i];