N                 677 3rdparty/include/opencl/1.2/CL/cl.hpp template <typename T, unsigned int N = __MAX_DEFAULT_VECTOR_SIZE>
N                 681 3rdparty/include/opencl/1.2/CL/cl.hpp     T data_[N];
N                 720 3rdparty/include/opencl/1.2/CL/cl.hpp         if (size() < N) {    
N                 746 3rdparty/include/opencl/1.2/CL/cl.hpp     vector(const vector<T, N>& vec) : 
N                 775 3rdparty/include/opencl/1.2/CL/cl.hpp     vector<T, N>& operator=(const vector<T, N>& rhs)
N                 794 3rdparty/include/opencl/1.2/CL/cl.hpp     bool operator==(vector<T,N> &vec)
N                 823 3rdparty/include/opencl/1.2/CL/cl.hpp         return N;
N                 829 3rdparty/include/opencl/1.2/CL/cl.hpp         return N;
N                 879 3rdparty/include/opencl/1.2/CL/cl.hpp         const vector<T,N> *vec_;
N                 887 3rdparty/include/opencl/1.2/CL/cl.hpp         iterator (const vector<T,N> &vec, int index) :
N                 912 3rdparty/include/opencl/1.2/CL/cl.hpp         static iterator begin(const cl::vector<T,N> &vec)
N                 919 3rdparty/include/opencl/1.2/CL/cl.hpp         static iterator end(const cl::vector<T,N> &vec)
N                1048 3rdparty/include/opencl/1.2/CL/cl.hpp template <int N>
N                1052 3rdparty/include/opencl/1.2/CL/cl.hpp     ::size_t data_[N];
N                1058 3rdparty/include/opencl/1.2/CL/cl.hpp         for( int i = 0; i < N; ++i ) {
N                1182 3rdparty/include/opencl/1.2/CL/cl.hpp template <typename Func, ::size_t N>
N                1183 3rdparty/include/opencl/1.2/CL/cl.hpp inline cl_int getInfoHelper(Func f, cl_uint name, size_t<N>* param, long)
N                1197 3rdparty/include/opencl/1.2/CL/cl.hpp     for(int i = 0; i < N; ++i) {
N                 259 3rdparty/libwebp/dsp/dec_sse2.c #define SIGNED_SHIFT_N(a, N) {                                                 \
N                 262 3rdparty/libwebp/dsp/dec_sse2.c   t = _mm_srai_epi16(t, N);                                                    \
N                 265 3rdparty/libwebp/dsp/dec_sse2.c   a = _mm_srai_epi16(a, N + 8);                                                \
N                  96 3rdparty/libwebp/dsp/upsampling_neon.c #define CONVERT8(FMT, XSTEP, N, src_y, src_uv, out, cur_x) {            \
N                  98 3rdparty/libwebp/dsp/upsampling_neon.c   for (i = 0; i < N; i += 8) {                                          \
N                 179 3rdparty/libwebp/dsp/upsampling_neon.c #define CONVERT1(FMT, XSTEP, N, src_y, src_uv, rgb, cur_x) {            \
N                 181 3rdparty/libwebp/dsp/upsampling_neon.c   for (i = 0; i < N; i++) {                                             \
N                 145 3rdparty/libwebp/dsp/yuv.h static WEBP_INLINE uint8_t VP8ClipN(int v, int N) {  // clip to N bits
N                 146 3rdparty/libwebp/dsp/yuv.h   return ((v & ~YUV_MASK) == 0) ? (uint8_t)(v >> (YUV_FIX + (8 - N)))
N                 147 3rdparty/libwebp/dsp/yuv.h                                 : (v < 0) ? 0u : (255u >> (8 - N));
N                 199 3rdparty/libwebp/enc/token.c     const int N = (p->next_ == NULL) ? b->left_ : 0;
N                 201 3rdparty/libwebp/enc/token.c     while (n-- > N) {
N                 223 3rdparty/libwebp/enc/token.c     const int N = (next == NULL) ? b->left_ : 0;
N                 225 3rdparty/libwebp/enc/token.c     while (n-- > N) {
N                  50 3rdparty/openexr/IlmImf/ImfChannelListAttribute.cpp template <size_t N>
N                  51 3rdparty/openexr/IlmImf/ImfChannelListAttribute.cpp void checkIsNullTerminated (const char (&str)[N], const char *what)
N                  53 3rdparty/openexr/IlmImf/ImfChannelListAttribute.cpp     for (int i = 0; i < N; ++i) {
N                  58 3rdparty/openexr/IlmImf/ImfChannelListAttribute.cpp     s << "Invalid " << what << ": it is more than " << (N - 1)
N                 149 3rdparty/openexr/IlmImf/ImfHeader.cpp template <size_t N>
N                 150 3rdparty/openexr/IlmImf/ImfHeader.cpp void checkIsNullTerminated (const char (&str)[N], const char *what)
N                 152 3rdparty/openexr/IlmImf/ImfHeader.cpp     for (int i = 0; i < N; ++i) {
N                 157 3rdparty/openexr/IlmImf/ImfHeader.cpp     s << "Invalid " << what << ": it is more than " << (N - 1)
N                 227 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     Rgba *		_buf[N];
N                 264 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _bufBase = new Rgba[(_width + pad) * N];
N                 266 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     for (int i = 0; i < N; ++i)
N                 269 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _tmpBuf = new Rgba[_width + N - 1];
N                 439 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp         decimateChromaHoriz (_width, _tmpBuf, _buf[N - 1]);
N                 519 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     for (int i = 0; i < N - 1; ++i)
N                 522 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _buf[N - 1] = tmp;
N                 530 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     memcpy (_buf[N - 1], _buf[N - 2], _width * sizeof (Rgba));
N                 538 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     memcpy (_buf[N - 1], _buf[N - 3], _width * sizeof (Rgba));
N                 839 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     Rgba *		_buf1[N + 2];
N                 862 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _currentScanLine = dw.min.y - N - 2;
N                 868 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _bufBase = new Rgba[(_width + pad) * (N + 2 + 3)];
N                 870 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     for (int i = 0; i < N + 2; ++i)
N                 874 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _buf2[i] = _bufBase + ((i + N + 2) * (_width + pad));
N                 876 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _tmpBuf = new Rgba[_width + N - 1];
N                1009 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     if (abs (dy) < N + 2)
N                1018 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp         int n = min (-dy, N + 2);
N                1045 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp         int n = min (dy, N + 2);
N                1049 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp         readYCAScanLine (yMax - i, _buf1[N + 1 - i]);
N                1082 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     d = modp (d, N + 2);
N                1084 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     Rgba *tmp[N + 2];
N                1086 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     for (int i = 0; i < N + 2; ++i)
N                1089 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     for (int i = 0; i < N + 2; ++i)
N                1090 3rdparty/openexr/IlmImf/ImfRgbaFile.cpp     _buf1[i] = tmp[(i + d) % (N + 2)];
N                 188 3rdparty/openexr/IlmImf/ImfRgbaYca.cpp             const Rgba * const ycaIn[N],
N                 315 3rdparty/openexr/IlmImf/ImfRgbaYca.cpp                const Rgba * const ycaIn[N],
N                 128 3rdparty/openexr/IlmImf/ImfRgbaYca.h static const int N = 27;
N                 129 3rdparty/openexr/IlmImf/ImfRgbaYca.h static const int N2 = N / 2;
N                 178 3rdparty/openexr/IlmImf/ImfRgbaYca.h              const Rgba * const ycaIn[N],
N                 209 3rdparty/openexr/IlmImf/ImfRgbaYca.h                 const Rgba * const ycaIn[N],
N                 492 3rdparty/openexr/Imath/ImathEuler.h     Matrix44<T> N;
N                 493 3rdparty/openexr/Imath/ImathEuler.h     N.rotate (r);
N                 495 3rdparty/openexr/Imath/ImathEuler.h     N = N * Matrix44<T> (M[0][0], M[0][1], M[0][2], 0,
N                 503 3rdparty/openexr/Imath/ImathEuler.h     T sy = Math<T>::sqrt (N[j][i]*N[j][i] + N[k][i]*N[k][i]);
N                 504 3rdparty/openexr/Imath/ImathEuler.h     y = Math<T>::atan2 (sy, N[i][i]);
N                 505 3rdparty/openexr/Imath/ImathEuler.h     z = Math<T>::atan2 (N[j][k], N[j][j]);
N                 524 3rdparty/openexr/Imath/ImathEuler.h     Matrix44<T> N;
N                 525 3rdparty/openexr/Imath/ImathEuler.h     N.rotate (r);
N                 527 3rdparty/openexr/Imath/ImathEuler.h     N = N * Matrix44<T> (M[0][0], M[0][1], M[0][2], 0,
N                 535 3rdparty/openexr/Imath/ImathEuler.h     T cy = Math<T>::sqrt (N[i][i]*N[i][i] + N[i][j]*N[i][j]);
N                 536 3rdparty/openexr/Imath/ImathEuler.h     y = Math<T>::atan2 (-N[i][k], cy);
N                 537 3rdparty/openexr/Imath/ImathEuler.h     z = Math<T>::atan2 (-N[j][i], N[j][j]);
N                 574 3rdparty/openexr/Imath/ImathEuler.h     Matrix44<T> N;
N                 575 3rdparty/openexr/Imath/ImathEuler.h     N.rotate (r);
N                 576 3rdparty/openexr/Imath/ImathEuler.h     N = N * M;
N                 582 3rdparty/openexr/Imath/ImathEuler.h     T sy = Math<T>::sqrt (N[j][i]*N[j][i] + N[k][i]*N[k][i]);
N                 583 3rdparty/openexr/Imath/ImathEuler.h     y = Math<T>::atan2 (sy, N[i][i]);
N                 584 3rdparty/openexr/Imath/ImathEuler.h     z = Math<T>::atan2 (N[j][k], N[j][j]);
N                 603 3rdparty/openexr/Imath/ImathEuler.h     Matrix44<T> N;
N                 604 3rdparty/openexr/Imath/ImathEuler.h     N.rotate (r);
N                 605 3rdparty/openexr/Imath/ImathEuler.h     N = N * M;
N                 611 3rdparty/openexr/Imath/ImathEuler.h     T cy = Math<T>::sqrt (N[i][i]*N[i][i] + N[i][j]*N[i][j]);
N                 612 3rdparty/openexr/Imath/ImathEuler.h     y = Math<T>::atan2 (-N[i][k], cy);
N                 613 3rdparty/openexr/Imath/ImathEuler.h     z = Math<T>::atan2 (-N[j][i], N[j][j]);
N                 623 3rdparty/openexr/Imath/ImathMatrixAlgo.h     Matrix44<T> N;
N                 624 3rdparty/openexr/Imath/ImathMatrixAlgo.h     N.rotate (Vec3<T> (-rot.x, 0, 0));
N                 625 3rdparty/openexr/Imath/ImathMatrixAlgo.h     N = N * M;
N                 631 3rdparty/openexr/Imath/ImathMatrixAlgo.h     T cy = Math<T>::sqrt (N[0][0]*N[0][0] + N[0][1]*N[0][1]);
N                 632 3rdparty/openexr/Imath/ImathMatrixAlgo.h     rot.y = Math<T>::atan2 (-N[0][2], cy);
N                 633 3rdparty/openexr/Imath/ImathMatrixAlgo.h     rot.z = Math<T>::atan2 (-N[1][0], N[1][1]);
N                 670 3rdparty/openexr/Imath/ImathMatrixAlgo.h     Matrix44<T> N;
N                 671 3rdparty/openexr/Imath/ImathMatrixAlgo.h     N.rotate (Vec3<T> (0, 0, -rot.x));
N                 672 3rdparty/openexr/Imath/ImathMatrixAlgo.h     N = N * M;
N                 678 3rdparty/openexr/Imath/ImathMatrixAlgo.h     T cy = Math<T>::sqrt (N[2][2]*N[2][2] + N[2][1]*N[2][1]);
N                 679 3rdparty/openexr/Imath/ImathMatrixAlgo.h     rot.y = -Math<T>::atan2 (-N[2][0], cy);
N                 680 3rdparty/openexr/Imath/ImathMatrixAlgo.h     rot.z = -Math<T>::atan2 (-N[1][2], N[1][1]);
N                  63 modules/calib3d/src/calibration.cpp     int i, j, M, N, L;
N                  73 modules/calib3d/src/calibration.cpp     N = B->cols;
N                  90 modules/calib3d/src/calibration.cpp         for( i = 0; i < M*N; i++ )
N                  92 modules/calib3d/src/calibration.cpp             int i1 = i / N,  i2 = i % N;
N                 110 modules/calib3d/src/calibration.cpp                 for( j = 0; j < L*N; j++ )
N                 113 modules/calib3d/src/calibration.cpp                     dcdb[j*N + i2] = a[j];
N                 119 modules/calib3d/src/calibration.cpp         for( i = 0; i < M*N; i++ )
N                 121 modules/calib3d/src/calibration.cpp             int i1 = i / N,  i2 = i % N;
N                 139 modules/calib3d/src/calibration.cpp                 for( j = 0; j < L*N; j++ )
N                 142 modules/calib3d/src/calibration.cpp                     dcdb[j*N + i2] = a[j];
N                2101 modules/calib3d/src/calibration.cpp     const int N = 9;
N                2103 modules/calib3d/src/calibration.cpp     cv::Ptr<CvMat> _pts(cvCreateMat(1, N*N, CV_32FC2));
N                2106 modules/calib3d/src/calibration.cpp     for( y = k = 0; y < N; y++ )
N                2107 modules/calib3d/src/calibration.cpp         for( x = 0; x < N; x++ )
N                2108 modules/calib3d/src/calibration.cpp             pts[k++] = cvPoint2D32f((float)x*imgSize.width/(N-1),
N                2109 modules/calib3d/src/calibration.cpp                                     (float)y*imgSize.height/(N-1));
N                2117 modules/calib3d/src/calibration.cpp     for( y = k = 0; y < N; y++ )
N                2118 modules/calib3d/src/calibration.cpp         for( x = 0; x < N; x++ )
N                2128 modules/calib3d/src/calibration.cpp             if( x == N-1 )
N                2132 modules/calib3d/src/calibration.cpp             if( y == N-1 )
N                  20 modules/calib3d/src/dls.cpp     N =  std::max(opoints.checkVector(3, CV_32F), opoints.checkVector(3, CV_64F));
N                  21 modules/calib3d/src/dls.cpp     p = cv::Mat(3, N, CV_64F);
N                  22 modules/calib3d/src/dls.cpp     z = cv::Mat(3, N, CV_64F);
N                 173 modules/calib3d/src/dls.cpp         for (int i = 0; i < N; ++i)
N                 220 modules/calib3d/src/dls.cpp     for (int i = 0; i < N; ++i)
N                 226 modules/calib3d/src/dls.cpp     H = eye.mul(N) - z * z.t();
N                 233 modules/calib3d/src/dls.cpp     for (int i = 0; i < N; ++i)
N                  25 modules/calib3d/src/dls.h         for(int i = 0; i < N; i++)
N                  46 modules/calib3d/src/dls.h         mn.at<double>(0) /= (double)N;
N                  47 modules/calib3d/src/dls.h         mn.at<double>(1) /= (double)N;
N                  48 modules/calib3d/src/dls.h         mn.at<double>(2) /= (double)N;
N                  75 modules/calib3d/src/dls.h     int N;                // number of input points
N                 191 modules/calib3d/src/epnp.cpp   int N = 1;
N                 192 modules/calib3d/src/epnp.cpp   if (rep_errors[2] < rep_errors[1]) N = 2;
N                 193 modules/calib3d/src/epnp.cpp   if (rep_errors[3] < rep_errors[N]) N = 3;
N                 195 modules/calib3d/src/epnp.cpp   Mat(3, 1, CV_64F, ts[N]).copyTo(t);
N                 196 modules/calib3d/src/epnp.cpp   Mat(3, 3, CV_64F, Rs[N]).copyTo(R);
N                 528 modules/calib3d/src/fisheye.cpp     const int N = 10;
N                 529 modules/calib3d/src/fisheye.cpp     cv::Mat points(1, N * 4, CV_64FC2);
N                 533 modules/calib3d/src/fisheye.cpp         pptr[k++] = Vec2d(w/2,   0) - Vec2d(w/8,   0) + Vec2d(w/4/N*i,   0);
N                 534 modules/calib3d/src/fisheye.cpp         pptr[k++] = Vec2d(w/2, h-1) - Vec2d(w/8, h-1) + Vec2d(w/4/N*i, h-1);
N                 536 modules/calib3d/src/fisheye.cpp         pptr[k++] = Vec2d(0,   h/2) - Vec2d(0,   h/8) + Vec2d(0,   h/4/N*i);
N                 537 modules/calib3d/src/fisheye.cpp         pptr[k++] = Vec2d(w-1, h/2) - Vec2d(w-1, h/8) + Vec2d(w-1, h/4/N*i);
N                  47 modules/calib3d/src/posit.cpp     int N;
N                  67 modules/calib3d/src/posit.cpp     int N = numPoints - 1;
N                  68 modules/calib3d/src/posit.cpp     int inv_matr_size = N * 3 * sizeof( float );
N                  70 modules/calib3d/src/posit.cpp     int img_vec_size = N * 2 * sizeof( float );
N                  89 modules/calib3d/src/posit.cpp     pObject->N = N;
N                 100 modules/calib3d/src/posit.cpp         pObject->obj_vecs[N + i] = points[i + 1].y - points[0].y;
N                 101 modules/calib3d/src/posit.cpp         pObject->obj_vecs[2 * N + i] = points[i + 1].z - points[0].z;
N                 106 modules/calib3d/src/posit.cpp     icvPseudoInverse3D( pObject->obj_vecs, pObject->inv_matr, N, 0 );
N                 142 modules/calib3d/src/posit.cpp     int N = pObject->N;
N                 152 modules/calib3d/src/posit.cpp             for( i = 0; i < N; i++ )
N                 155 modules/calib3d/src/posit.cpp                 imgVectors[N + i] = imagePoints[i + 1].y - imagePoints[0].y;
N                 162 modules/calib3d/src/posit.cpp             for( i = 0; i < N; i++ )
N                 167 modules/calib3d/src/posit.cpp                     objectVectors[N + i] * rotation[7]     /*[2][1]*/ +
N                 168 modules/calib3d/src/posit.cpp                     objectVectors[2 * N + i] * rotation[8] /*[2][2]*/;
N                 178 modules/calib3d/src/posit.cpp                 old = imgVectors[N + i];
N                 179 modules/calib3d/src/posit.cpp                 imgVectors[N + i] = imagePoints[i + 1].y * tmp - imagePoints[0].y;
N                 181 modules/calib3d/src/posit.cpp                 diff = MAX( diff, (float) fabs( imgVectors[N + i] - old ));
N                 191 modules/calib3d/src/posit.cpp                 for( k = 0; k < N; k++ )
N                 193 modules/calib3d/src/posit.cpp                     rotation[3*i+j] /*[i][j]*/ += invMatrix[j * N + k] * imgVectors[i * N + k];
N                 410 modules/calib3d/src/ptsetreg.cpp         const int N = 12;
N                 411 modules/calib3d/src/ptsetreg.cpp         double buf[N*N + N + N];
N                 412 modules/calib3d/src/ptsetreg.cpp         Mat A(N, N, CV_64F, &buf[0]);
N                 413 modules/calib3d/src/ptsetreg.cpp         Mat B(N, 1, CV_64F, &buf[0] + N*N);
N                 414 modules/calib3d/src/ptsetreg.cpp         Mat X(N, 1, CV_64F, &buf[0] + N*N + N);
N                 419 modules/calib3d/src/ptsetreg.cpp         for( int i = 0; i < (N/3); i++ )
N                 425 modules/calib3d/src/ptsetreg.cpp             double *aptr = Adata + i*3*N;
N                 130 modules/calib3d/src/rho.cpp     virtual inline int    ensureCapacity(unsigned N, double beta){
N                 131 modules/calib3d/src/rho.cpp         (void)N;
N                 217 modules/calib3d/src/rho.cpp                                   unsigned       N,       /*  = src.length = dst.length = inl.length */
N                 254 modules/calib3d/src/rho.cpp         unsigned     N;
N                 342 modules/calib3d/src/rho.cpp     inline int    ensureCapacity(unsigned N, double beta);
N                 346 modules/calib3d/src/rho.cpp                           unsigned       N,       /*  = src.length = dst.length = inl.length */
N                 404 modules/calib3d/src/rho.cpp                                            unsigned  N,
N                 418 modules/calib3d/src/rho.cpp                                            unsigned     N,
N                 478 modules/calib3d/src/rho.cpp int  rhoEnsureCapacity(Ptr<RHO_HEST> p, unsigned N, double beta){
N                 479 modules/calib3d/src/rho.cpp     return p->ensureCapacity(N, beta);
N                 525 modules/calib3d/src/rho.cpp                  unsigned      N,       /*  = src.length = dst.length = inl.length */
N                 535 modules/calib3d/src/rho.cpp     return p->rhoHest(src, dst, inl, N, maxD, maxI, rConvg, cfd, minInl, beta,
N                 658 modules/calib3d/src/rho.cpp inline int    RHO_HEST_REFC::ensureCapacity(unsigned N, double beta){
N                 659 modules/calib3d/src/rho.cpp     if(N == 0){
N                 665 modules/calib3d/src/rho.cpp         nr.tbl.resize(N);
N                 667 modules/calib3d/src/rho.cpp         sacInitNonRand(nr.beta, 0, N, &nr.tbl[0]);
N                 668 modules/calib3d/src/rho.cpp         nr.size = N;
N                 669 modules/calib3d/src/rho.cpp     }else if(N > nr.size){
N                 671 modules/calib3d/src/rho.cpp         nr.tbl.resize(N);
N                 672 modules/calib3d/src/rho.cpp         sacInitNonRand(nr.beta, nr.size, N, &nr.tbl[nr.size]);
N                 673 modules/calib3d/src/rho.cpp         nr.size = N;
N                 712 modules/calib3d/src/rho.cpp                                 unsigned       N,       /*  = src.length = dst.length = inl.length */
N                 730 modules/calib3d/src/rho.cpp     arg.N       = N;
N                 841 modules/calib3d/src/rho.cpp     size_t best_inl_sz = arg.N;
N                 842 modules/calib3d/src/rho.cpp     size_t curr_inl_sz = arg.N;
N                 924 modules/calib3d/src/rho.cpp     if(arg.N < (unsigned)SMPL_SIZE){
N                 957 modules/calib3d/src/rho.cpp     if(isNREnabled() && !ensureCapacity(arg.N, arg.beta)){
N                 970 modules/calib3d/src/rho.cpp     memset(best.inl, 0, arg.N);
N                 971 modules/calib3d/src/rho.cpp     memset(curr.inl, 0, arg.N);
N                 983 modules/calib3d/src/rho.cpp     ctrl.phEndFpI     = sacInitPEndFpI(arg.rConvg, arg.N, SMPL_SIZE);
N                 984 modules/calib3d/src/rho.cpp     ctrl.phMax        = arg.N;
N                1418 modules/calib3d/src/rho.cpp     for(i=0;i<arg.N && eval.good;i++){
N                1468 modules/calib3d/src/rho.cpp             eval.epsilon = (double)curr.numInl/arg.N;
N                1627 modules/calib3d/src/rho.cpp                                     unsigned  N,
N                1632 modules/calib3d/src/rho.cpp     for(; n < N; n++){
N                1654 modules/calib3d/src/rho.cpp     unsigned best_n       = arg.N;
N                1691 modules/calib3d/src/rho.cpp                                 (double)best.numInl/arg.N,
N                1709 modules/calib3d/src/rho.cpp             memcpy(arg.inl, best.inl, arg.N);
N                1730 modules/calib3d/src/rho.cpp         memset(arg.inl,    0, arg.N);
N                2098 modules/calib3d/src/rho.cpp     sacCalcJacobianErrors(best.H, arg.src, arg.dst, best.inl, arg.N,
N                2130 modules/calib3d/src/rho.cpp         sacCalcJacobianErrors(newH, arg.src, arg.dst, best.inl, arg.N,
N                2158 modules/calib3d/src/rho.cpp             sacCalcJacobianErrors(best.H, arg.src, arg.dst, best.inl, arg.N,
N                2182 modules/calib3d/src/rho.cpp                                            unsigned     N,
N                2195 modules/calib3d/src/rho.cpp     for(i=0;i<N;i++){
N                2373 modules/calib3d/src/rho.cpp     const register int N = 8;
N                2378 modules/calib3d/src/rho.cpp     for(i=0;i<N;i++){/* Row */
N                 119 modules/calib3d/src/rho.h int  rhoEnsureCapacity(Ptr<RHO_HEST> p, unsigned N, double beta);
N                 248 modules/calib3d/src/rho.h                  unsigned      N,       /*  = src.length = dst.length = inl.length */
N                 910 modules/calib3d/src/stereobm.cpp         N = ndisp * 2;
N                 930 modules/calib3d/src/stereobm.cpp     size_t globalThreads[3] = {N, globalX, globalY};
N                 931 modules/calib3d/src/stereobm.cpp     size_t localThreads[3]  = {N, 1, 1};
N                 136 modules/calib3d/src/upnp.cpp   int N = 1;
N                 137 modules/calib3d/src/upnp.cpp   if (rep_errors[2] < rep_errors[1]) N = 2;
N                 139 modules/calib3d/src/upnp.cpp   Mat(3, 1, CV_64F, ts[N]).copyTo(t);
N                 140 modules/calib3d/src/upnp.cpp   Mat(3, 3, CV_64F, Rs[N]).copyTo(R);
N                 141 modules/calib3d/src/upnp.cpp   fu = fv = Efs[N][0];
N                 310 modules/calib3d/src/upnp.cpp     int N = 4;
N                 311 modules/calib3d/src/upnp.cpp     for(int i = 0; i < N; ++i) {
N                1333 modules/calib3d/test/test_cameracalibration.cpp     const int N = 21;
N                1338 modules/calib3d/test/test_cameracalibration.cpp     for( y = 0; y < N; y++ )
N                1339 modules/calib3d/test/test_cameracalibration.cpp         for( x = 0; x < N; x++ )
N                1340 modules/calib3d/test/test_cameracalibration.cpp             pts.push_back(Point2f((float)x*imgsize.width/(N-1), (float)y*imgsize.height/(N-1)));
N                1343 modules/calib3d/test/test_cameracalibration.cpp     for( k = 0; k < N*N; k++ )
N                  74 modules/calib3d/test/test_fisheye.cpp     const int N = 20;
N                  75 modules/calib3d/test/test_fisheye.cpp     cv::Mat distorted0(1, N*N, CV_64FC2), undist1, undist2, distorted1, distorted2;
N                  80 modules/calib3d/test/test_fisheye.cpp     for(int y = 0, k = 0; y < N; ++y)
N                  81 modules/calib3d/test/test_fisheye.cpp         for(int x = 0; x < N; ++x)
N                  83 modules/calib3d/test/test_fisheye.cpp             cv::Vec2d point(x*cols/(N-1.f), y*rows/(N-1.f));
N                  95 modules/calib3d/test/test_homography.cpp     void print_information_1(int j, int N, int method, const Mat& H);
N                  96 modules/calib3d/test/test_homography.cpp     void print_information_2(int j, int N, int method, const Mat& H, const Mat& H_res, int k, double diff);
N                  97 modules/calib3d/test/test_homography.cpp     void print_information_3(int method, int j, int N, const Mat& mask);
N                  98 modules/calib3d/test/test_homography.cpp     void print_information_4(int method, int j, int N, int k, int l, double diff);
N                  99 modules/calib3d/test/test_homography.cpp     void print_information_5(int method, int j, int N, int l, double diff);
N                 100 modules/calib3d/test/test_homography.cpp     void print_information_6(int method, int j, int N, int k, double diff, bool value);
N                 101 modules/calib3d/test/test_homography.cpp     void print_information_7(int method, int j, int N, int k, double diff, bool original_value, bool found_value);
N                 102 modules/calib3d/test/test_homography.cpp     void print_information_8(int method, int j, int N, int k, int l, double diff);
N                 141 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_1(int j, int N, int _method, const Mat& H)
N                 146 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << endl; cout << endl;
N                 153 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_2(int j, int N, int _method, const Mat& H, const Mat& H_res, int k, double diff)
N                 158 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << endl; cout << endl;
N                 169 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_3(int _method, int j, int N, const Mat& mask)
N                 174 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << endl; cout << endl;
N                 181 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_4(int _method, int j, int N, int k, int l, double diff)
N                 188 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << endl;
N                 195 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_5(int _method, int j, int N, int l, double diff)
N                 202 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << endl;
N                 208 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_6(int _method, int j, int N, int k, double diff, bool value)
N                 214 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << "   " << endl;
N                 221 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_7(int _method, int j, int N, int k, double diff, bool original_value, bool found_value)
N                 227 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << "   " << endl;
N                 234 modules/calib3d/test/test_homography.cpp void CV_HomographyTest::print_information_8(int _method, int j, int N, int k, int l, double diff)
N                 241 modules/calib3d/test/test_homography.cpp     cout << "Count of points: " << N << "   " << endl;
N                 250 modules/calib3d/test/test_homography.cpp     for (int N = 4; N <= MAX_COUNT_OF_POINTS; ++N)
N                 254 modules/calib3d/test/test_homography.cpp         float *src_data = new float [2*N];
N                 256 modules/calib3d/test/test_homography.cpp         for (int i = 0; i < N; ++i)
N                 262 modules/calib3d/test/test_homography.cpp         cv::Mat src_mat_2f(1, N, CV_32FC2, src_data),
N                 263 modules/calib3d/test/test_homography.cpp         src_mat_2d(2, N, CV_32F, src_data),
N                 264 modules/calib3d/test/test_homography.cpp         src_mat_3d(3, N, CV_32F);
N                 269 modules/calib3d/test/test_homography.cpp         for (int i = 0; i < N; ++i)
N                 294 modules/calib3d/test/test_homography.cpp         dst_mat_2d.create(2, N, CV_32F); dst_mat_2f.create(1, N, CV_32FC2);
N                 296 modules/calib3d/test/test_homography.cpp         for (int i = 0; i < N; ++i)
N                 324 modules/calib3d/test/test_homography.cpp                             print_information_1(j, N, method, H_res_64[j]);
N                 334 modules/calib3d/test/test_homography.cpp                             print_information_2(j, N, method, H_64, H_res_64[j], k, diff);
N                 357 modules/calib3d/test/test_homography.cpp                             print_information_1(j, N, method, H_res_64[j]);
N                 365 modules/calib3d/test/test_homography.cpp                             print_information_2(j, N, method, H_64, H_res_64[j], k, diff);
N                 374 modules/calib3d/test/test_homography.cpp                             print_information_3(method, j, N, mask[j]);
N                 397 modules/calib3d/test/test_homography.cpp         Mat noise_2f(1, N, CV_32FC2);
N                 400 modules/calib3d/test/test_homography.cpp         cv::Mat mask(N, 1, CV_8UC1);
N                 402 modules/calib3d/test/test_homography.cpp         for (int i = 0; i < N; ++i)
N                 427 modules/calib3d/test/test_homography.cpp                             print_information_1(j, N, method, H_res_64[j]);
N                 434 modules/calib3d/test/test_homography.cpp                         cv::Mat dst_res_3d(3, N, CV_32F), noise_2d(2, N, CV_32F);
N                 436 modules/calib3d/test/test_homography.cpp                         for (int k = 0; k < N; ++k)
N                 451 modules/calib3d/test/test_homography.cpp                                 print_information_4(method, j, N, k, l, cv::norm(tmp_mat_3d, dst_mat_3d.col(k), NORM_TYPE[l]) - cv::norm(noise_2d.col(k), NORM_TYPE[l]));
N                 461 modules/calib3d/test/test_homography.cpp                             print_information_5(method, j, N, l, cv::norm(dst_res_3d, dst_mat_3d, NORM_TYPE[l]) - cv::norm(noise_2d, NORM_TYPE[l]));
N                 484 modules/calib3d/test/test_homography.cpp                             print_information_1(j, N, method, H_res_64[j]);
N                 493 modules/calib3d/test/test_homography.cpp                             print_information_3(method, j, N, mask_res[j]);
N                 510 modules/calib3d/test/test_homography.cpp                         for (int k = 0; k < N; ++k)
N                 525 modules/calib3d/test/test_homography.cpp                                 print_information_6(method, j, N, k, diff, mask_res[j].at<bool>(k, 0));
N                 532 modules/calib3d/test/test_homography.cpp                                 print_information_7(method, j, N, k, diff, mask.at<bool>(k, 0), mask_res[j].at<bool>(k, 0));
N                 552 modules/calib3d/test/test_homography.cpp                                         print_information_8(method, j, N, k, l, diff - cv::norm(noise_2d, NORM_TYPE[l]));
N                2658 modules/core/include/opencv2/core.hpp     unsigned operator ()(unsigned N);
N                2770 modules/core/include/opencv2/core.hpp     unsigned operator ()(unsigned N);
N                2788 modules/core/include/opencv2/core.hpp     unsigned state[N];
N                  70 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         template <unsigned int I, unsigned int N>
N                  78 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 For<I + 1, N>::loadToSmem(smem, val, tid);
N                  85 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 For<I + 1, N>::loadFromSmem(smem, val, tid);
N                  94 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 For<I + 1, N>::merge(smem, val, tid, delta, op);
N                 102 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 For<I + 1, N>::mergeShfl(val, delta, width, op);
N                 105 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         template <unsigned int N>
N                 106 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         struct For<N, N>
N                 187 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         template <unsigned int N> struct Generic
N                 193 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (N >= 32)
N                 196 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (N >= 2048)
N                 203 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (N >= 1024)
N                 210 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (N >= 512)
N                 217 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (N >= 256)
N                 224 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (N >= 128)
N                 231 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (N >= 64)
N                 251 modules/core/include/opencv2/core/cuda/detail/reduce.hpp             static __device__ void loopShfl(Reference val, Op op, unsigned int N)
N                 253 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 mergeShfl(val, I, N, op);
N                 254 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 Unroll<I / 2, Pointer, Reference, Op>::loopShfl(val, op, N);
N                 273 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         template <unsigned int N> struct WarpOptimized
N                 282 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 Unroll<N / 2, Pointer, Reference, Op>::loopShfl(val, op, N);
N                 286 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 if (tid < N / 2)
N                 287 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                     Unroll<N / 2, Pointer, Reference, Op>::loop(smem, val, tid, op);
N                 292 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         template <unsigned int N> struct GenericOptimized32
N                 294 modules/core/include/opencv2/core/cuda/detail/reduce.hpp             enum { M = N / 32 };
N                 343 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         template <unsigned int N> struct IsPowerOf2
N                 345 modules/core/include/opencv2/core/cuda/detail/reduce.hpp             enum { value = ((N != 0) && !(N & (N - 1))) };
N                 348 modules/core/include/opencv2/core/cuda/detail/reduce.hpp         template <unsigned int N> struct Dispatcher
N                 351 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                 (N <= 32) && IsPowerOf2<N>::value,
N                 354 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                     (N <= 1024) && IsPowerOf2<N>::value,
N                 356 modules/core/include/opencv2/core/cuda/detail/reduce.hpp                     Generic<N>
N                  70 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         template <unsigned int I, unsigned int N>
N                  78 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 For<I + 1, N>::loadToSmem(smem, data, tid);
N                  85 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 For<I + 1, N>::loadFromSmem(smem, data, tid);
N                  93 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 For<I + 1, N>::copyShfl(val, delta, width);
N                 100 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 For<I + 1, N>::copy(svals, val, tid, delta);
N                 114 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 For<I + 1, N>::mergeShfl(key, val, cmp, delta, width);
N                 130 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 For<I + 1, N>::merge(skeys, key, svals, val, cmp, tid, delta);
N                 133 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         template <unsigned int N>
N                 134 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         struct For<N, N>
N                 312 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         template <unsigned int N> struct Generic
N                 319 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (N >= 32)
N                 322 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (N >= 2048)
N                 329 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (N >= 1024)
N                 336 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (N >= 512)
N                 343 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (N >= 256)
N                 350 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (N >= 128)
N                 357 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (N >= 64)
N                 377 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp             static __device__ void loopShfl(KR key, VR val, Cmp cmp, unsigned int N)
N                 379 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 mergeShfl(key, val, cmp, I, N);
N                 380 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 Unroll<I / 2, KP, KR, VP, VR, Cmp>::loopShfl(key, val, cmp, N);
N                 399 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         template <unsigned int N> struct WarpOptimized
N                 409 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 Unroll<N / 2, KP, KR, VP, VR, Cmp>::loopShfl(key, val, cmp, N);
N                 414 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 if (tid < N / 2)
N                 415 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                     Unroll<N / 2, KP, KR, VP, VR, Cmp>::loop(skeys, key, svals, val, tid, cmp);
N                 420 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         template <unsigned int N> struct GenericOptimized32
N                 422 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp             enum { M = N / 32 };
N                 480 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         template <unsigned int N> struct IsPowerOf2
N                 482 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp             enum { value = ((N != 0) && !(N & (N - 1))) };
N                 485 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp         template <unsigned int N> struct Dispatcher
N                 488 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                 (N <= 32) && IsPowerOf2<N>::value,
N                 491 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                     (N <= 1024) && IsPowerOf2<N>::value,
N                 493 modules/core/include/opencv2/core/cuda/detail/reduce_key_val.hpp                     Generic<N>
N                  54 modules/core/include/opencv2/core/cuda/detail/vec_distance_detail.hpp         template <int THREAD_DIM, int N> struct UnrollVecDiffCached
N                  68 modules/core/include/opencv2/core/cuda/detail/vec_distance_detail.hpp                     UnrollVecDiffCached<THREAD_DIM, N - 1>::calcCheck(vecCached, vecGlob, len, dist, ind + THREAD_DIM);
N                  83 modules/core/include/opencv2/core/cuda/detail/vec_distance_detail.hpp                 UnrollVecDiffCached<THREAD_DIM, N - 1>::calcWithoutCheck(vecCached, vecGlob, dist);
N                  58 modules/core/include/opencv2/core/cuda/reduce.hpp     template <int N, typename T, class Op>
N                  61 modules/core/include/opencv2/core/cuda/reduce.hpp         reduce_detail::Dispatcher<N>::reductor::template reduce<volatile T*, T&, const Op&>(smem, val, tid, op);
N                  63 modules/core/include/opencv2/core/cuda/reduce.hpp     template <int N,
N                  72 modules/core/include/opencv2/core/cuda/reduce.hpp         reduce_detail::Dispatcher<N>::reductor::template reduce<
N                  78 modules/core/include/opencv2/core/cuda/reduce.hpp     template <unsigned int N, typename K, typename V, class Cmp>
N                  81 modules/core/include/opencv2/core/cuda/reduce.hpp         reduce_key_val_detail::Dispatcher<N>::reductor::template reduce<volatile K*, K&, volatile V*, V&, const Cmp&>(skeys, key, svals, val, tid, cmp);
N                  83 modules/core/include/opencv2/core/cuda/reduce.hpp     template <unsigned int N,
N                  93 modules/core/include/opencv2/core/cuda/reduce.hpp         reduce_key_val_detail::Dispatcher<N>::reductor::template reduce<volatile K*, K&,
N                  98 modules/core/include/opencv2/core/cuda/reduce.hpp     template <unsigned int N,
N                 111 modules/core/include/opencv2/core/cuda/reduce.hpp         reduce_key_val_detail::Dispatcher<N>::reductor::template reduce<
N                  56 modules/core/include/opencv2/core/cuda/vec_traits.hpp     template<typename T, int N> struct TypeVec;
N                 547 modules/core/include/opencv2/core/opencl/runtime/autogenerated/opencl_clamdblas.hpp extern CL_RUNTIME_EXPORT clAmdBlasStatus (*clAmdBlasCgemmEx)(clAmdBlasOrder order, clAmdBlasTranspose transA, clAmdBlasTranspose transB, size_t M, size_t N, size_t K, FloatComplex alpha, const cl_mem A, size_t offA, size_t lda, const cl_mem B, size_t offB, size_t ldb, FloatComplex beta, cl_mem C, size_t offC, size_t ldc, cl_uint numCommandQueues, cl_command_queue* commandQueues, cl_uint numEventsInWaitList, const cl_event* eventWaitList, cl_event* events);
N                 588 modules/core/include/opencv2/core/opencl/runtime/autogenerated/opencl_clamdblas.hpp extern CL_RUNTIME_EXPORT clAmdBlasStatus (*clAmdBlasDgemmEx)(clAmdBlasOrder order, clAmdBlasTranspose transA, clAmdBlasTranspose transB, size_t M, size_t N, size_t K, cl_double alpha, const cl_mem A, size_t offA, size_t lda, const cl_mem B, size_t offB, size_t ldb, cl_double beta, cl_mem C, size_t offC, size_t ldc, cl_uint numCommandQueues, cl_command_queue* commandQueues, cl_uint numEventsInWaitList, const cl_event* eventWaitList, cl_event* events);
N                 635 modules/core/include/opencv2/core/opencl/runtime/autogenerated/opencl_clamdblas.hpp extern CL_RUNTIME_EXPORT clAmdBlasStatus (*clAmdBlasSgemmEx)(clAmdBlasOrder order, clAmdBlasTranspose transA, clAmdBlasTranspose transB, size_t M, size_t N, size_t K, cl_float alpha, const cl_mem A, size_t offA, size_t lda, const cl_mem B, size_t offB, size_t ldb, cl_float beta, cl_mem C, size_t offC, size_t ldc, cl_uint numCommandQueues, cl_command_queue* commandQueues, cl_uint numEventsInWaitList, const cl_event* eventWaitList, cl_event* events);
N                 678 modules/core/include/opencv2/core/opencl/runtime/autogenerated/opencl_clamdblas.hpp extern CL_RUNTIME_EXPORT clAmdBlasStatus (*clAmdBlasZgemmEx)(clAmdBlasOrder order, clAmdBlasTranspose transA, clAmdBlasTranspose transB, size_t M, size_t N, size_t K, DoubleComplex alpha, const cl_mem A, size_t offA, size_t lda, const cl_mem B, size_t offB, size_t ldb, DoubleComplex beta, cl_mem C, size_t offC, size_t ldc, cl_uint numCommandQueues, cl_command_queue* commandQueues, cl_uint numEventsInWaitList, const cl_event* eventWaitList, cl_event* events);
N                 345 modules/core/include/opencv2/core/operations.hpp inline unsigned RNG::operator ()(unsigned N) { return (unsigned)uniform(0,N); }
N                 442 modules/core/include/opencv2/core/operations.hpp     int i, j, N = (int)_vec.size();
N                 448 modules/core/include/opencv2/core/operations.hpp     std::vector<int> _nodes(N*2);
N                 452 modules/core/include/opencv2/core/operations.hpp     for(i = 0; i < N; i++)
N                 459 modules/core/include/opencv2/core/operations.hpp     for( i = 0; i < N; i++ )
N                 467 modules/core/include/opencv2/core/operations.hpp         for( j = 0; j < N; j++ )
N                 511 modules/core/include/opencv2/core/operations.hpp     labels.resize(N);
N                 514 modules/core/include/opencv2/core/operations.hpp     for( i = 0; i < N; i++ )
N                  38 modules/core/perf/perf_math.cpp     int i,  N = 0, N0 = 0, K = 0, dims = 0;
N                  40 modules/core/perf/perf_math.cpp     N = rng.uniform(1, MAX_POINTS+1);
N                  41 modules/core/perf/perf_math.cpp     N0 = rng.uniform(1, MAX(N/10, 2));
N                  42 modules/core/perf/perf_math.cpp     K = rng.uniform(1, N+1);
N                  47 modules/core/perf/perf_math.cpp     Mat data(N, dims, CV_32F);
N                  48 modules/core/perf/perf_math.cpp     for( i = 0; i < N; i++ )
N                 385 modules/core/src/dxt.cpp     int operator()(Complex<float>* dst, int N, int n0, int& _dw0, const Complex<float>* wave) const
N                 393 modules/core/src/dxt.cpp         for( ; n*4 <= N; )
N                 104 modules/core/src/kmeans.cpp     int i, j, k, dims = _data.cols, N = _data.rows;
N                 109 modules/core/src/kmeans.cpp     std::vector<float> _dist(N*3);
N                 110 modules/core/src/kmeans.cpp     float* dist = &_dist[0], *tdist = dist + N, *tdist2 = tdist + N;
N                 113 modules/core/src/kmeans.cpp     centers[0] = (unsigned)rng % N;
N                 115 modules/core/src/kmeans.cpp     for( i = 0; i < N; i++ )
N                 129 modules/core/src/kmeans.cpp             for( i = 0; i < N-1; i++ )
N                 134 modules/core/src/kmeans.cpp             parallel_for_(Range(0, N),
N                 136 modules/core/src/kmeans.cpp             for( i = 0; i < N; i++ )
N                 225 modules/core/src/kmeans.cpp     int N = !isrow ? data0.rows : data0.cols;
N                 231 modules/core/src/kmeans.cpp     CV_Assert( N >= K );
N                 233 modules/core/src/kmeans.cpp     Mat data(N, dims, CV_32F, data0.ptr(), isrow ? dims * sizeof(float) : static_cast<size_t>(data0.step));
N                 235 modules/core/src/kmeans.cpp     _bestLabels.create(N, 1, CV_32S, -1, true);
N                 241 modules/core/src/kmeans.cpp                   best_labels.cols*best_labels.rows == N &&
N                 249 modules/core/src/kmeans.cpp              best_labels.cols*best_labels.rows == N &&
N                 252 modules/core/src/kmeans.cpp             best_labels.create(N, 1, CV_32S);
N                 286 modules/core/src/kmeans.cpp     for( i = 1; i < N; i++ )
N                 318 modules/core/src/kmeans.cpp                     for( i = 0; i < N; i++ )
N                 327 modules/core/src/kmeans.cpp                 for( i = 0; i < N; i++ )
N                 382 modules/core/src/kmeans.cpp                     for( i = 0; i < N; i++ )
N                 435 modules/core/src/kmeans.cpp             Mat dists(1, N, CV_64F);
N                 437 modules/core/src/kmeans.cpp             parallel_for_(Range(0, N),
N                 440 modules/core/src/kmeans.cpp             for( i = 0; i < N; i++ )
N                1008 modules/core/src/lda.cpp     int N = data.rows;
N                1019 modules/core/src/lda.cpp     if (labels.size() != static_cast<size_t>(N)) {
N                1020 modules/core/src/lda.cpp         String error_message = format("The number of samples must equal the number of labels. Given %d labels, %d samples. ", labels.size(), N);
N                1024 modules/core/src/lda.cpp     if (N < D) {
N                1044 modules/core/src/lda.cpp     for (int i = 0; i < N; i++) {
N                1052 modules/core/src/lda.cpp     meanTotal.convertTo(meanTotal, meanTotal.type(), 1.0 / static_cast<double> (N));
N                1058 modules/core/src/lda.cpp     for (int i = 0; i < N; i++) {
N                  55 modules/core/src/lpsolver.cpp static void print_simplex_state(const Mat& c,const Mat& b,double v,const std::vector<int> N,const std::vector<int> B){
N                  64 modules/core/src/lpsolver.cpp     print(Mat(N));
N                  75 modules/core/src/lpsolver.cpp #define print_simplex_state(c,b,v,N,B)
N                  84 modules/core/src/lpsolver.cpp static int initialize_simplex(Mat_<double>& c, Mat_<double>& b,double& v,vector<int>& N,vector<int>& B,vector<unsigned int>& indexToRow);
N                  85 modules/core/src/lpsolver.cpp static inline void pivot(Mat_<double>& c,Mat_<double>& b,double& v,vector<int>& N,vector<int>& B,int leaving_index,
N                  89 modules/core/src/lpsolver.cpp static int inner_simplex(Mat_<double>& c, Mat_<double>& b,double& v,vector<int>& N,vector<int>& B,vector<unsigned int>& indexToRow);
N                 114 modules/core/src/lpsolver.cpp     vector<int> N,B;
N                 117 modules/core/src/lpsolver.cpp     if(initialize_simplex(bigC,bigB,v,N,B,indexToRow)==SOLVELP_UNFEASIBLE){
N                 124 modules/core/src/lpsolver.cpp     if((res=inner_simplex(c,b,v,N,B,indexToRow))==SOLVELP_UNBOUNDED){
N                 131 modules/core/src/lpsolver.cpp     unsigned int nsize = (unsigned int)N.size();
N                 143 modules/core/src/lpsolver.cpp static int initialize_simplex(Mat_<double>& c, Mat_<double>& b,double& v,vector<int>& N,vector<int>& B,vector<unsigned int>& indexToRow){
N                 144 modules/core/src/lpsolver.cpp     N.resize(c.cols);
N                 145 modules/core/src/lpsolver.cpp     N[0]=0;
N                 146 modules/core/src/lpsolver.cpp     for (std::vector<int>::iterator it = N.begin()+1 ; it != N.end(); ++it){
N                 150 modules/core/src/lpsolver.cpp     B[0]=(int)N.size();
N                 173 modules/core/src/lpsolver.cpp         N.erase(N.begin());
N                 187 modules/core/src/lpsolver.cpp     print_simplex_state(c,b,v,N,B);
N                 190 modules/core/src/lpsolver.cpp     pivot(c,b,v,N,B,k,0,indexToRow);
N                 192 modules/core/src/lpsolver.cpp     print_simplex_state(c,b,v,N,B);
N                 194 modules/core/src/lpsolver.cpp     inner_simplex(c,b,v,N,B,indexToRow);
N                 197 modules/core/src/lpsolver.cpp     print_simplex_state(c,b,v,N,B);
N                 199 modules/core/src/lpsolver.cpp     unsigned int nsize = (unsigned int)N.size();
N                 205 modules/core/src/lpsolver.cpp         pivot(c,b,v,N,B,iterator_offset,0,indexToRow);
N                 211 modules/core/src/lpsolver.cpp         iterator=N.begin()+iterator_offset;
N                 212 modules/core/src/lpsolver.cpp         std::iter_swap(iterator,N.begin());
N                 219 modules/core/src/lpsolver.cpp     print_simplex_state(c,b,v,N,B);
N                 240 modules/core/src/lpsolver.cpp     print_simplex_state(c,b,v,N,B);
N                 242 modules/core/src/lpsolver.cpp     N.erase(N.begin());
N                 249 modules/core/src/lpsolver.cpp static int inner_simplex(Mat_<double>& c, Mat_<double>& b,double& v,vector<int>& N,vector<int>& B,vector<unsigned int>& indexToRow){
N                 263 modules/core/src/lpsolver.cpp                 if(N[pos_ctr]<min_var){
N                 265 modules/core/src/lpsolver.cpp                     min_var=N[pos_ctr];
N                 302 modules/core/src/lpsolver.cpp         pivot(c,b,v,N,B,l,e,indexToRow);
N                 309 modules/core/src/lpsolver.cpp         print_matrix(Mat(N));
N                 315 modules/core/src/lpsolver.cpp static inline void pivot(Mat_<double>& c,Mat_<double>& b,double& v,vector<int>& N,vector<int>& B,
N                 351 modules/core/src/lpsolver.cpp     SWAP(int,N[entering_index],B[leaving_index]);
N                 352 modules/core/src/lpsolver.cpp     SWAP(int,indexToRow[N[entering_index]],indexToRow[B[leaving_index]]);
N                 443 modules/core/src/mathfuncs.cpp     const int N = 64;
N                 481 modules/core/src/mathfuncs.cpp     static const double k2 = (2*CV_PI)/N;
N                 493 modules/core/src/mathfuncs.cpp         k1 = N/(2*CV_PI);
N                 495 modules/core/src/mathfuncs.cpp         k1 = N/360.;
N                 502 modules/core/src/mathfuncs.cpp         __m128i v_N1 = _mm_set1_epi32(N - 1);
N                 503 modules/core/src/mathfuncs.cpp         __m128i v_N4 = _mm_set1_epi32(N >> 2);
N                 565 modules/core/src/mathfuncs.cpp         int sin_idx = it & (N - 1);
N                 566 modules/core/src/mathfuncs.cpp         int cos_idx = (N/4 - sin_idx) & (N - 1);
N                 739 modules/core/src/matmul.cpp     int M = sizeD.height, N = sizeD.width, K = sizeA.width;
N                 750 modules/core/src/matmul.cpp         status = clAmdBlasSgemmEx(order, transA, transB, M, N, K,
N                 756 modules/core/src/matmul.cpp         status = clAmdBlasDgemmEx(order, transA, transB, M, N, K,
N                 765 modules/core/src/matmul.cpp          status = clAmdBlasCgemmEx(order, transA, transB, M, N, K,
N                 775 modules/core/src/matmul.cpp         status = clAmdBlasZgemmEx(order, transA, transB, M, N, K,
N                4806 modules/core/src/matrix.cpp     size_t i, N = nzcount(), esz = elemSize();
N                4808 modules/core/src/matrix.cpp     for( i = 0; i < N; i++, ++from )
N                4824 modules/core/src/matrix.cpp     size_t i, N = nzcount(), esz = elemSize();
N                4826 modules/core/src/matrix.cpp     for( i = 0; i < N; i++, ++from )
N                4853 modules/core/src/matrix.cpp     size_t i, N = nzcount();
N                4858 modules/core/src/matrix.cpp         for( i = 0; i < N; i++, ++from )
N                4868 modules/core/src/matrix.cpp         for( i = 0; i < N; i++, ++from )
N                4890 modules/core/src/matrix.cpp     size_t i, N = nzcount();
N                4895 modules/core/src/matrix.cpp         for( i = 0; i < N; i++, ++from )
N                4905 modules/core/src/matrix.cpp         for( i = 0; i < N; i++, ++from )
N                5219 modules/core/src/matrix.cpp     size_t i, N = src.nzcount();
N                5229 modules/core/src/matrix.cpp             for( i = 0; i < N; i++, ++it )
N                5232 modules/core/src/matrix.cpp             for( i = 0; i < N; i++, ++it )
N                5235 modules/core/src/matrix.cpp             for( i = 0; i < N; i++, ++it )
N                5244 modules/core/src/matrix.cpp             for( i = 0; i < N; i++, ++it )
N                5247 modules/core/src/matrix.cpp             for( i = 0; i < N; i++, ++it )
N                5250 modules/core/src/matrix.cpp             for( i = 0; i < N; i++, ++it )
N                5267 modules/core/src/matrix.cpp     size_t i, N = src.nzcount(), d = src.hdr ? src.hdr->dims : 0;
N                5274 modules/core/src/matrix.cpp         for( i = 0; i < N; i++, ++it )
N                5296 modules/core/src/matrix.cpp         for( i = 0; i < N; i++, ++it )
N                5424 modules/core/src/matrix.cpp     size_t i, N = sm.nzcount(), esz = sm.elemSize();
N                5426 modules/core/src/matrix.cpp     for( i = 0; i < N; i++, ++from )
N                 889 modules/core/src/rand.cpp     for (mti = 1; mti < N; mti++)
N                 905 modules/core/src/rand.cpp     if (mti >= N)
N                 909 modules/core/src/rand.cpp         for (; kk < N - M; ++kk)
N                 915 modules/core/src/rand.cpp         for (; kk < N - 1; ++kk)
N                 918 modules/core/src/rand.cpp             state[kk] = state[kk + (M - N)] ^ (y >> 1) ^ mag01[y & 0x1U];
N                 921 modules/core/src/rand.cpp         unsigned y = (state[N - 1] & UPPER_MASK) | (state[0] & LOWER_MASK);
N                 922 modules/core/src/rand.cpp         state[N - 1] = state[M - 1] ^ (y >> 1) ^ mag01[y & 0x1U];
N                 187 modules/core/test/test_countnonzero.cpp     const size_t N = 1500;
N                 190 modules/core/test/test_countnonzero.cpp         for (size_t i = 0; i < N; ++i)
N                1395 modules/core/test/test_math.cpp     int i, j, k, N = a->rows, N1 = a->cols, Nm = MIN(N, N1), step = a->step/sizeof(double);
N                1410 modules/core/test/test_math.cpp         for( j = i+1; j < N; j++ )
N                1442 modules/core/test/test_math.cpp         for( j = i+1; j < N; j++, a2 += step, b2 += b_step )
N                1459 modules/core/test/test_math.cpp         for( i = N-1; i >= 0; i-- )
N                2646 modules/core/test/test_math.cpp         int i, iter = 0, N = 0, N0 = 0, K = 0, dims = 0;
N                2657 modules/core/test/test_math.cpp                 N = rng.uniform(1, MAX_POINTS+1);
N                2658 modules/core/test/test_math.cpp                 N0 = rng.uniform(1, MAX(N/10, 2));
N                2659 modules/core/test/test_math.cpp                 K = rng.uniform(1, N+1);
N                2668 modules/core/test/test_math.cpp                     std::vector<cv::Point2f> data(N);
N                2669 modules/core/test/test_math.cpp                     for( i = 0; i < N; i++ )
N                2685 modules/core/test/test_math.cpp                         data.create(N, dims, CV_32F);
N                2686 modules/core/test/test_math.cpp                         for( i = 0; i < N; i++ )
N                2691 modules/core/test/test_math.cpp                         data.create(N, 1, CV_32FC(dims));
N                2692 modules/core/test/test_math.cpp                         for( i = 0; i < N; i++ )
N                2697 modules/core/test/test_math.cpp                         data.create(1, N, CV_32FC(dims));
N                2698 modules/core/test/test_math.cpp                         for( i = 0; i < N; i++ )
N                2703 modules/core/test/test_math.cpp                         data.create(N, dims + 5, CV_32F);
N                2704 modules/core/test/test_math.cpp                         data = data(Range(0, N), Range(0, dims));
N                2705 modules/core/test/test_math.cpp                         for( i = 0; i < N; i++ )
N                2710 modules/core/test/test_math.cpp                         data.create(N, 3, CV_32FC(dims));
N                2712 modules/core/test/test_math.cpp                         for( i = 0; i < N; i++ )
N                2722 modules/core/test/test_math.cpp                 for( i = 0; i < N; i++ )
N                2736 modules/core/test/test_math.cpp                        iter, N, N0, K);
N                  92 modules/core/test/test_rand.cpp     const int N = 2000000;
N                 110 modules/core/test/test_rand.cpp         int i, k, SZ = N/cn;
N                  80 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp     template <int I, int N> struct For
N                  87 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             For<I + 1, N>::loadToSmem(smem, val, tid);
N                  95 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             For<I + 1, N>::loadFromSmem(smem, val, tid);
N                 104 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             For<I + 1, N>::merge(smem, val, tid, delta, op);
N                 114 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             For<I + 1, N>::mergeShfl(val, delta, width, op);
N                 119 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp     template <int N> struct For<N, N>
N                 219 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp     template <int N> struct Generic
N                 225 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (N >= 32)
N                 228 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (N >= 2048)
N                 235 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (N >= 1024)
N                 242 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (N >= 512)
N                 249 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (N >= 256)
N                 256 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (N >= 128)
N                 263 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (N >= 64)
N                 291 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp         __device__ static void loopShfl(Reference val, Op op, uint N)
N                 293 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             mergeShfl(val, I, N, op);
N                 294 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             Unroll<I / 2, Pointer, Reference, Op>::loopShfl(val, op, N);
N                 314 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp     template <int N> struct WarpOptimized
N                 323 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             Unroll<N / 2, Pointer, Reference, Op>::loopShfl(val, op, N);
N                 327 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             if (tid < N / 2)
N                 328 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp                 Unroll<N / 2, Pointer, Reference, Op>::loop(smem, val, tid, op);
N                 335 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp     template <int N> struct GenericOptimized32
N                 337 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp         enum { M = N / 32 };
N                 376 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp     template <int N> struct Dispatcher
N                 379 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp             (N <= 32) && IsPowerOf2<N>::value,
N                 382 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp                 (N <= 1024) && IsPowerOf2<N>::value,
N                 384 modules/cudev/include/opencv2/cudev/block/detail/reduce.hpp                 Generic<N>
N                  79 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp     template <int I, int N> struct For
N                  86 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             For<I + 1, N>::loadToSmem(smem, data, tid);
N                  94 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             For<I + 1, N>::loadFromSmem(smem, data, tid);
N                 102 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             For<I + 1, N>::copy(svals, val, tid, delta);
N                 119 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             For<I + 1, N>::merge(skeys, key, svals, val, cmp, tid, delta);
N                 123 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp     template <int N> struct For<N, N>
N                 247 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp     template <int N> struct Generic
N                 254 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (N >= 32)
N                 257 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (N >= 2048)
N                 264 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (N >= 1024)
N                 271 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (N >= 512)
N                 278 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (N >= 256)
N                 285 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (N >= 128)
N                 292 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (N >= 64)
N                 329 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp     template <int N> struct WarpOptimized
N                 337 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             if (tid < N / 2)
N                 338 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp                 Unroll<N / 2, KP, KR, VP, VR, Cmp>::loop(skeys, key, svals, val, tid, cmp);
N                 344 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp     template <uint N> struct GenericOptimized32
N                 346 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp         enum { M = N / 32 };
N                 378 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp     template <int N> struct Dispatcher
N                 381 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp             (N <= 32) && IsPowerOf2<N>::value,
N                 384 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp                 (N <= 1024) && IsPowerOf2<N>::value,
N                 386 modules/cudev/include/opencv2/cudev/block/detail/reduce_key_val.hpp                 Generic<N>
N                  62 modules/cudev/include/opencv2/cudev/block/reduce.hpp template <int N, typename T, class Op>
N                  65 modules/cudev/include/opencv2/cudev/block/reduce.hpp     block_reduce_detail::Dispatcher<N>::reductor::template reduce<volatile T*, T&, const Op&>(smem, val, tid, op);
N                  68 modules/cudev/include/opencv2/cudev/block/reduce.hpp template <int N,
N                  77 modules/cudev/include/opencv2/cudev/block/reduce.hpp     block_reduce_detail::Dispatcher<N>::reductor::template reduce<
N                  85 modules/cudev/include/opencv2/cudev/block/reduce.hpp template <int N, typename K, typename V, class Cmp>
N                  88 modules/cudev/include/opencv2/cudev/block/reduce.hpp     block_reduce_key_val_detail::Dispatcher<N>::reductor::template reduce<volatile K*, K&, volatile V*, V&, const Cmp&>(skeys, key, svals, val, tid, cmp);
N                  91 modules/cudev/include/opencv2/cudev/block/reduce.hpp template <int N,
N                 101 modules/cudev/include/opencv2/cudev/block/reduce.hpp     block_reduce_key_val_detail::Dispatcher<N>::reductor::template reduce<volatile K*, K&,
N                 107 modules/cudev/include/opencv2/cudev/block/reduce.hpp template <int N,
N                 120 modules/cudev/include/opencv2/cudev/block/reduce.hpp     block_reduce_key_val_detail::Dispatcher<N>::reductor::template reduce<
N                  78 modules/cudev/include/opencv2/cudev/util/type_traits.hpp template <int N, int CURRENT_VAL = N, int COUNT = 0> struct Log2
N                  80 modules/cudev/include/opencv2/cudev/util/type_traits.hpp     enum { value = Log2<N, (CURRENT_VAL >> 1), COUNT + 1>::VALUE };
N                  82 modules/cudev/include/opencv2/cudev/util/type_traits.hpp template <int N, int COUNT> struct Log2<N, 0, COUNT>
N                  84 modules/cudev/include/opencv2/cudev/util/type_traits.hpp     enum { value = (1 << (COUNT - 1) < N) ? COUNT : COUNT - 1 };
N                  89 modules/cudev/include/opencv2/cudev/util/type_traits.hpp template <int N> struct IsPowerOf2
N                  91 modules/cudev/include/opencv2/cudev/util/type_traits.hpp     enum { value = ((N != 0) && !(N & (N - 1))) };
N                  78 modules/cudev/include/opencv2/cudev/warp/detail/reduce.hpp     template <int I, int N> struct For
N                  85 modules/cudev/include/opencv2/cudev/warp/detail/reduce.hpp             For<I + 1, N>::loadToSmem(smem, val, tid);
N                  94 modules/cudev/include/opencv2/cudev/warp/detail/reduce.hpp             For<I + 1, N>::merge(smem, val, tid, delta, op);
N                 104 modules/cudev/include/opencv2/cudev/warp/detail/reduce.hpp             For<I + 1, N>::mergeShfl(val, delta, width, op);
N                 109 modules/cudev/include/opencv2/cudev/warp/detail/reduce.hpp     template <int N> struct For<N, N>
N                  77 modules/cudev/include/opencv2/cudev/warp/detail/reduce_key_val.hpp     template <int I, int N> struct For
N                  84 modules/cudev/include/opencv2/cudev/warp/detail/reduce_key_val.hpp             For<I + 1, N>::loadToSmem(smem, data, tid);
N                  92 modules/cudev/include/opencv2/cudev/warp/detail/reduce_key_val.hpp             For<I + 1, N>::copy(svals, val, tid, delta);
N                 109 modules/cudev/include/opencv2/cudev/warp/detail/reduce_key_val.hpp             For<I + 1, N>::merge(skeys, key, svals, val, cmp, tid, delta);
N                 113 modules/cudev/include/opencv2/cudev/warp/detail/reduce_key_val.hpp     template <int N> struct For<N, N>
N                 363 modules/features2d/src/evaluation.cpp                 int N = (int)floor((float)(maxx - minx) / dr);
N                 365 modules/features2d/src/evaluation.cpp                 parallel_reduce( BlockedRange(0, N+1), ac );
N                  59 modules/features2d/src/fast.cpp     const int K = patternSize/2, N = patternSize + K + 1;
N                 135 modules/features2d/src/fast.cpp                     for( k = 0; k < N; k++ )
N                 186 modules/features2d/src/fast.cpp                     for( k = 0; k < N; k++ )
N                 208 modules/features2d/src/fast.cpp                     for( k = 0; k < N; k++ )
N                  84 modules/features2d/src/fast_score.cpp static void testCorner(const uchar* ptr, const int pixel[], int K, int N, int threshold) {
N                  93 modules/features2d/src/fast_score.cpp         for( int k = 0; k < N; k++ )
N                 122 modules/features2d/src/fast_score.cpp     const int K = 8, N = K*3 + 1;
N                 124 modules/features2d/src/fast_score.cpp     short d[N];
N                 125 modules/features2d/src/fast_score.cpp     for( k = 0; k < N; k++ )
N                 204 modules/features2d/src/fast_score.cpp     testCorner(ptr, pixel, K, N, threshold);
N                 212 modules/features2d/src/fast_score.cpp     const int K = 6, N = K*3 + 1;
N                 214 modules/features2d/src/fast_score.cpp     short d[N + 4];
N                 215 modules/features2d/src/fast_score.cpp     for( k = 0; k < N; k++ )
N                 219 modules/features2d/src/fast_score.cpp         d[N+k] = d[k];
N                 288 modules/features2d/src/fast_score.cpp     testCorner(ptr, pixel, K, N, threshold);
N                 296 modules/features2d/src/fast_score.cpp     const int K = 4, N = K*3 + 1;
N                 298 modules/features2d/src/fast_score.cpp     short d[N];
N                 299 modules/features2d/src/fast_score.cpp     for( k = 0; k < N; k++ )
N                 354 modules/features2d/src/fast_score.cpp     testCorner(ptr, pixel, K, N, threshold);
N                1370 modules/highgui/src/ppltasks_winrt.h     template<typename _Type, size_t N = 0, bool bIsArray = std::is_array<_Type>::value>
N                1374 modules/highgui/src/ppltasks_winrt.h     template<typename _Type, size_t N>
N                1375 modules/highgui/src/ppltasks_winrt.h     struct _MarshalHelper<_Type, N, true>
N                1377 modules/highgui/src/ppltasks_winrt.h         static _Type* _Perform(_Type(&_ObjInCtx)[N], const _ContextCallback& _Ctx)
N                1391 modules/highgui/src/ppltasks_winrt.h                 IUnknown * _PUnk = winrt_array_type::create(_ObjInCtx, N);
N                 932 modules/imgproc/src/demosaicing.cpp     int N = size.width, N2 = N*2, N3 = N*3, N4 = N*4, N5 = N*5, N6 = N*6, N7 = N*7;
N                 955 modules/imgproc/src/demosaicing.cpp                 brow[N*i-1] = brow[(N-2) + N*i] = 0;
N                 963 modules/imgproc/src/demosaicing.cpp                 for( ; i <= N-9; i += 8, srow += 8, brow += 8 )
N                 990 modules/imgproc/src/demosaicing.cpp                     _mm_storeu_si128((__m128i*)(brow + N), b1);
N                1008 modules/imgproc/src/demosaicing.cpp             for( ; i < N-1; i++, srow++, brow++ )
N                1013 modules/imgproc/src/demosaicing.cpp                 brow[N] = (ushort)(std::abs(srow[-1-bstep] - srow[1-bstep]) +
N                1035 modules/imgproc/src/demosaicing.cpp         int limit = !haveSSE ? N-2 : greenCell ? std::min(3, N-2) : 2;
N                1037 modules/imgproc/src/demosaicing.cpp         int limit = N - 2;
N                1046 modules/imgproc/src/demosaicing.cpp                 int gradW = brow1[N-1] + brow1[N];
N                1047 modules/imgproc/src/demosaicing.cpp                 int gradE = brow1[N] + brow1[N+1];
N                1218 modules/imgproc/src/demosaicing.cpp             for( ; i <= N - 10; i += 8, srow += 8, brow0 += 8, brow1 += 8, brow2 += 8 )
N                1227 modules/imgproc/src/demosaicing.cpp                 __m128i gradW = _mm_adds_epi16(_mm_loadu_si128((__m128i*)(brow1+N-1)), _mm_loadu_si128((__m128i*)(brow1+N)));
N                1230 modules/imgproc/src/demosaicing.cpp                 __m128i gradE = _mm_adds_epi16(_mm_loadu_si128((__m128i*)(brow1+N+1)), _mm_loadu_si128((__m128i*)(brow1+N)));
N                1441 modules/imgproc/src/demosaicing.cpp             limit = N - 2;
N                1443 modules/imgproc/src/demosaicing.cpp         while( i < N - 2 );
N                1448 modules/imgproc/src/demosaicing.cpp             dst[dststep*y + (N - 2)*3 + i] = dst[dststep*y + (N - 3)*3 + i];
N                 189 modules/imgproc/src/filter.cpp             int n = (int)constBorderValue.size(), N;
N                 190 modules/imgproc/src/filter.cpp             N = (maxWidth + ksize.width - 1)*esz;
N                 193 modules/imgproc/src/filter.cpp             for( i = 0; i < N; i += n )
N                 195 modules/imgproc/src/filter.cpp                 n = std::min( n, N - i );
N                1431 modules/imgproc/src/histogram.cpp     size_t i, N;
N                1438 modules/imgproc/src/histogram.cpp         for( i = 0, N = hist.nzcount(); i < N; i++, ++it )
N                1468 modules/imgproc/src/histogram.cpp         for( i = 0, N = hist.nzcount(); i < N; i++, ++it )
N                1179 modules/imgproc/src/lsd.cpp     int N = _lines.checkVector(4);
N                1182 modules/imgproc/src/lsd.cpp     for(int i = 0; i < N; ++i)
N                1225 modules/imgproc/src/lsd.cpp     int N = countNonZero(Ixor);
N                1249 modules/imgproc/src/lsd.cpp     return N;
N                 273 modules/imgproc/src/opencl/filter2DSmall.cl #define LOOP(N, VAR, STMT) CAT(LOOP, N)((VAR), (STMT))
N                 193 modules/imgproc/src/opencl/filterSmall.cl #define LOOP(N, VAR, STMT) CAT(LOOP, N)((VAR), (STMT))
N                 508 modules/imgproc/src/phasecorr.cpp     int N = getOptimalDFTSize(src1.cols);
N                 512 modules/imgproc/src/phasecorr.cpp     if(M != src1.rows || N != src1.cols)
N                 514 modules/imgproc/src/phasecorr.cpp         copyMakeBorder(src1, padded1, 0, M - src1.rows, 0, N - src1.cols, BORDER_CONSTANT, Scalar::all(0));
N                 515 modules/imgproc/src/phasecorr.cpp         copyMakeBorder(src2, padded2, 0, M - src2.rows, 0, N - src2.cols, BORDER_CONSTANT, Scalar::all(0));
N                 519 modules/imgproc/src/phasecorr.cpp             copyMakeBorder(window, paddedWin, 0, M - window.rows, 0, N - window.cols, BORDER_CONSTANT, Scalar::all(0));
N                 563 modules/imgproc/src/phasecorr.cpp         *response /= M*N;
N                 305 modules/imgproc/src/shapedescr.cpp     const int N = 16;
N                 306 modules/imgproc/src/shapedescr.cpp     float buf[N];
N                 324 modules/imgproc/src/shapedescr.cpp         if( ++j == N || i == count-1 )
N                 955 modules/imgproc/src/shapedescr.cpp     const int N = 16;
N                 956 modules/imgproc/src/shapedescr.cpp     float buf[N];
N                 957 modules/imgproc/src/shapedescr.cpp     CvMat buffer = cvMat( 1, N, CV_32F, buf );
N                1022 modules/imgproc/src/shapedescr.cpp             if( ++j == N || i == count - 1 )
N                2029 modules/imgproc/src/smooth.cpp     int     zone0[4][N];
N                2030 modules/imgproc/src/smooth.cpp     int     zone1[4][N*N];
N                2102 modules/imgproc/src/smooth.cpp                 for( k *= N; ;k++ )
N                 937 modules/imgproc/src/thresh.cpp     const int N = 256;
N                 938 modules/imgproc/src/thresh.cpp     int i, j, h[N] = {0};
N                 957 modules/imgproc/src/thresh.cpp     for( i = 0; i < N; i++ )
N                 964 modules/imgproc/src/thresh.cpp     for( i = 0; i < N; i++ )
N                1001 modules/imgproc/src/thresh.cpp     const int N = 256;
N                1002 modules/imgproc/src/thresh.cpp     int i, j, h[N] = {0};
N                1024 modules/imgproc/src/thresh.cpp     for( i = 0; i < N; i++ )
N                1035 modules/imgproc/src/thresh.cpp     for( i = N-1; i > 0; i-- )
N                1043 modules/imgproc/src/thresh.cpp     if( right_bound < N-1 )
N                1046 modules/imgproc/src/thresh.cpp     for( i = 0; i < N; i++ )
N                1058 modules/imgproc/src/thresh.cpp         i = 0, j = N-1;
N                1064 modules/imgproc/src/thresh.cpp         left_bound = N-1-right_bound;
N                1065 modules/imgproc/src/thresh.cpp         max_ind = N-1-max_ind;
N                1088 modules/imgproc/src/thresh.cpp         thresh = N-1-thresh;
N                 509 modules/imgproc/src/undistort.cpp     int N = 9;
N                 523 modules/imgproc/src/undistort.cpp     for( int i = 0; i < N; i++ )
N                 524 modules/imgproc/src/undistort.cpp         for( int j = 0; j < N; j++ )
N                 526 modules/imgproc/src/undistort.cpp             Point2f p((float)j*imageSize.width/(N-1), (float)i*imageSize.height/(N-1));
N                  68 modules/imgproc/test/ocl/test_histogram.cpp     int depth, N;
N                  86 modules/imgproc/test/ocl/test_histogram.cpp         N = GET_PARAM(1);
N                  89 modules/imgproc/test/ocl/test_histogram.cpp         ASSERT_GE(2, N);
N                  91 modules/imgproc/test/ocl/test_histogram.cpp         images.resize(N);
N                  92 modules/imgproc/test/ocl/test_histogram.cpp         images_roi.resize(N);
N                  93 modules/imgproc/test/ocl/test_histogram.cpp         uimages.resize(N);
N                  94 modules/imgproc/test/ocl/test_histogram.cpp         uimages_roi.resize(N);
N                 106 modules/imgproc/test/ocl/test_histogram.cpp         for (int i = 0; i < N; ++i)
N                 121 modules/imgproc/test/ocl/test_histogram.cpp             std::vector<int> hist_size(N);
N                 122 modules/imgproc/test/ocl/test_histogram.cpp             for (int i = 0 ; i < N; ++i)
N                 136 modules/imgproc/test/ocl/test_histogram.cpp         for (int i = 0; i < N; ++i)
N                  98 modules/imgproc/test/test_boundingrect.cpp     const int N = 10000;
N                 100 modules/imgproc/test/test_boundingrect.cpp     for (int k = 0; k < N; ++k)
N                1674 modules/imgproc/test/test_imgwarp.cpp     const int N = 400;
N                1675 modules/imgproc/test/test_imgwarp.cpp     src.create(N, N, CV_8U);
N                1681 modules/imgproc/test/test_imgwarp.cpp     randu(map_x, 0., N+0.);
N                1682 modules/imgproc/test/test_imgwarp.cpp     randu(map_y, 0., N+0.);
N                 905 modules/objdetect/src/detection_based_tracker.cpp     int N=(int)lastPositions.size();
N                 906 modules/objdetect/src/detection_based_tracker.cpp     if (N<=0) {
N                 912 modules/objdetect/src/detection_based_tracker.cpp     int Nsize=std::min(N, (int)weightsSizesSmoothing.size());
N                 913 modules/objdetect/src/detection_based_tracker.cpp     int Ncenter= std::min(N, (int)weightsPositionsSmoothing.size());
N                 920 modules/objdetect/src/detection_based_tracker.cpp             int k=N-j-1;
N                 928 modules/objdetect/src/detection_based_tracker.cpp         w=lastPositions[N-1].width;
N                 929 modules/objdetect/src/detection_based_tracker.cpp         h=lastPositions[N-1].height;
N                 935 modules/objdetect/src/detection_based_tracker.cpp             int k=N-j-1;
N                 951 modules/objdetect/src/detection_based_tracker.cpp         int k=N-1;
N                  82 modules/stitching/src/exposure_compensate.cpp     Mat_<int> N(num_images, num_images); N.setTo(0);
N                 103 modules/stitching/src/exposure_compensate.cpp                 N(i, j) = N(j, i) = std::max(1, countNonZero(intersect));
N                 119 modules/stitching/src/exposure_compensate.cpp                 I(i, j) = Isum1 / N(i, j);
N                 120 modules/stitching/src/exposure_compensate.cpp                 I(j, i) = Isum2 / N(i, j);
N                 134 modules/stitching/src/exposure_compensate.cpp             b(i, 0) += beta * N(i, j);
N                 135 modules/stitching/src/exposure_compensate.cpp             A(i, i) += beta * N(i, j);
N                 137 modules/stitching/src/exposure_compensate.cpp             A(i, i) += 2 * alpha * I(i, j) * I(i, j) * N(i, j);
N                 138 modules/stitching/src/exposure_compensate.cpp             A(i, j) -= 2 * alpha * I(i, j) * I(j, i) * N(i, j);
N                7747 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, size_t N>
N                7748 modules/ts/include/opencv2/ts/ts_gtest.h struct RemoveConst<const T[N]> {
N                7756 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, size_t N>
N                7757 modules/ts/include/opencv2/ts/ts_gtest.h struct RemoveConst<T[N]> {
N                7913 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, typename U, size_t N>
N                7914 modules/ts/include/opencv2/ts/ts_gtest.h inline bool ArrayEq(const T(&lhs)[N], const U(&rhs)[N]) {
N                7915 modules/ts/include/opencv2/ts/ts_gtest.h   return internal::ArrayEq(lhs, N, rhs);
N                7953 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, typename U, size_t N>
N                7954 modules/ts/include/opencv2/ts/ts_gtest.h inline void CopyArray(const T(&from)[N], U(*to)[N]) {
N                7955 modules/ts/include/opencv2/ts/ts_gtest.h   internal::CopyArray(from, N, *to);
N                9893 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, size_t N>
N                9894 modules/ts/include/opencv2/ts/ts_gtest.h class UniversalPrinter<T[N]> {
N                9898 modules/ts/include/opencv2/ts/ts_gtest.h   static void Print(const T (&a)[N], ::std::ostream* os) {
N                9899 modules/ts/include/opencv2/ts/ts_gtest.h     UniversalPrintArray(a, N, os);
N                9946 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, size_t N>
N                9947 modules/ts/include/opencv2/ts/ts_gtest.h class UniversalTersePrinter<T[N]> {
N                9949 modules/ts/include/opencv2/ts/ts_gtest.h   static void Print(const T (&value)[N], ::std::ostream* os) {
N                9950 modules/ts/include/opencv2/ts/ts_gtest.h     UniversalPrinter<T[N]>::Print(value, os);
N                10022 modules/ts/include/opencv2/ts/ts_gtest.h template <size_t N>
N                10027 modules/ts/include/opencv2/ts/ts_gtest.h     TuplePrefixPrinter<N - 1>::PrintPrefixTo(t, os);
N                10029 modules/ts/include/opencv2/ts/ts_gtest.h     UniversalPrinter<typename ::std::tr1::tuple_element<N - 1, Tuple>::type>
N                10030 modules/ts/include/opencv2/ts/ts_gtest.h         ::Print(::std::tr1::get<N - 1>(t), os);
N                10037 modules/ts/include/opencv2/ts/ts_gtest.h     TuplePrefixPrinter<N - 1>::TersePrintPrefixToStrings(t, strings);
N                10039 modules/ts/include/opencv2/ts/ts_gtest.h     UniversalTersePrint(::std::tr1::get<N - 1>(t), &ss);
N                10743 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, size_t N>
N                10744 modules/ts/include/opencv2/ts/ts_gtest.h internal::ParamGenerator<T> ValuesIn(const T (&array)[N]);
N                15944 modules/ts/include/opencv2/ts/ts_gtest.h template <typename T, size_t N>
N                15945 modules/ts/include/opencv2/ts/ts_gtest.h internal::ParamGenerator<T> ValuesIn(const T (&array)[N]) {
N                15946 modules/ts/include/opencv2/ts/ts_gtest.h   return ValuesIn(array, array + N);
N                18840 modules/ts/include/opencv2/ts/ts_gtest.h template <typename ToPrint, size_t N, typename OtherOperand>
N                18841 modules/ts/include/opencv2/ts/ts_gtest.h class FormatForComparison<ToPrint[N], OtherOperand> {
N                  72 modules/videoio/src/cap_msmf.hpp     static IUnknown* create(_Type* _ObjInCtx, size_t N) {
N                  81 modules/videoio/src/cap_msmf.hpp             hr = winrt_array_type<_Type>::create(spPropVal.Get(), N, _ObjInCtx, _PObj.GetAddressOf());
N                 122 modules/videoio/src/cap_winrt/MFIncludes.hpp template <size_t N>
N                 123 modules/videoio/src/cap_winrt/MFIncludes.hpp HRESULT OriginateError(__in HRESULT hr, __in wchar_t const (&str)[N])
N                 127 modules/videoio/src/cap_winrt/MFIncludes.hpp         ::RoOriginateErrorW(hr, N - 1, str);
N                1370 modules/videoio/src/ppltasks_winrt.hpp     template<typename _Type, size_t N = 0, bool bIsArray = std::is_array<_Type>::value>
N                1374 modules/videoio/src/ppltasks_winrt.hpp     template<typename _Type, size_t N>
N                1375 modules/videoio/src/ppltasks_winrt.hpp     struct _MarshalHelper<_Type, N, true>
N                1377 modules/videoio/src/ppltasks_winrt.hpp         static _Type* _Perform(_Type(&_ObjInCtx)[N], const _ContextCallback& _Ctx)
N                1391 modules/videoio/src/ppltasks_winrt.hpp                 IUnknown * _PUnk = winrt_array_type::create(_ObjInCtx, N);
N                  91 modules/videoio/test/test_positioning.cpp     int N = (int)cvGetCaptureProperty(cap, CAP_PROP_FRAME_COUNT);
N                 102 modules/videoio/test/test_positioning.cpp             while (pos <= N);
N                 107 modules/videoio/test/test_positioning.cpp             RNG rng(N);
N                 109 modules/videoio/test/test_positioning.cpp             for( int i = 0; i < N-1; i++ )
N                 110 modules/videoio/test/test_positioning.cpp                 idx.push_back(rng.uniform(0, N));
N                 111 modules/videoio/test/test_positioning.cpp             idx.push_back(N-1);
N                 112 modules/videoio/test/test_positioning.cpp             std::swap(idx.at(rng.uniform(0, N-1)), idx.at(N-1));
N                 154 modules/videoio/test/test_positioning.cpp         int N = (int)idx.size(), failed_frames = 0, failed_positions = 0, failed_iterations = 0;
N                 156 modules/videoio/test/test_positioning.cpp         for (int j = 0; j < N; ++j)
N                 115 modules/videoio/test/test_video_pos.cpp             int N = (int)cap.get(CAP_PROP_FRAME_COUNT);
N                 122 modules/videoio/test/test_video_pos.cpp             if (N < n_frames || N > n_frames + allowed_extra_frames || N != N0)
N                 124 modules/videoio/test/test_video_pos.cpp                 ts->printf(ts->LOG, "\nError: returned frame count (N0=%d, N=%d) is different from the reference number %d\n", N0, N, n_frames);
N                  59 modules/videostab/src/global_motion.cpp             int compactPoints(int N, float *points0, float *points1, const uchar *mask);
N                 147 modules/videostab/src/motion_stabilizing.cpp     int N = size;
N                 154 modules/videostab/src/motion_stabilizing.cpp     int ncols = 4*N + 6*(N-1) + 6*(N-2) + 6*(N-3);
N                 155 modules/videostab/src/motion_stabilizing.cpp     int nrows = 8*N + 2*6*(N-1) + 2*6*(N-2) + 2*6*(N-3);
N                 164 modules/videostab/src/motion_stabilizing.cpp     int c = 4*N;
N                 167 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-1; ++t, c += 6)
N                 193 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-2; ++t, c += 6)
N                 219 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-3; ++t, c += 6)
N                 256 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N; ++t)
N                 273 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-1; ++t, r += 6)
N                 293 modules/videostab/src/motion_stabilizing.cpp         c = 4*N + 6*t;
N                 306 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-1; ++t, r += 6)
N                 326 modules/videostab/src/motion_stabilizing.cpp         c = 4*N + 6*t;
N                 339 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-2; ++t, r += 6)
N                 367 modules/videostab/src/motion_stabilizing.cpp         c = 4*N + 6*(N-1) + 6*t;
N                 380 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-2; ++t, r += 6)
N                 408 modules/videostab/src/motion_stabilizing.cpp         c = 4*N + 6*(N-1) + 6*t;
N                 421 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-3; ++t, r += 6)
N                 457 modules/videostab/src/motion_stabilizing.cpp         c = 4*N + 6*(N-1) + 6*(N-2) + 6*t;
N                 470 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N-3; ++t, r += 6)
N                 506 modules/videostab/src/motion_stabilizing.cpp         c = 4*N + 6*(N-1) + 6*(N-2) + 6*t;
N                 556 modules/videostab/src/motion_stabilizing.cpp     for (int t = 0; t < N; ++t, c += 4)
N                  68 samples/cpp/3calibration.cpp         int N = 0;
N                  73 samples/cpp/3calibration.cpp                 N += (int)imgpt0[i].size();
N                  99 samples/cpp/3calibration.cpp         printf("Camera %d calibration reprojection error = %g\n", c, sqrt(err/N));
N                 118 samples/cpp/3calibration.cpp         int N = 0;
N                 125 samples/cpp/3calibration.cpp                 N += (int)imgpt0[i].size();
N                 143 samples/cpp/3calibration.cpp         printf("Pair (1,%d) calibration reprojection error = %g\n", c, sqrt(err/(N*2)));
N                  39 samples/cpp/dft.cpp     int N = getOptimalDFTSize( img.cols );
N                  41 samples/cpp/dft.cpp     copyMakeBorder(img, padded, 0, M - img.rows, 0, N - img.cols, BORDER_CONSTANT, Scalar::all(0));
N                  10 samples/cpp/em.cpp     const int N = 4;
N                  11 samples/cpp/em.cpp     const int N1 = (int)sqrt((double)N);
N                  26 samples/cpp/em.cpp     for( i = 0; i < N; i++ )
N                  29 samples/cpp/em.cpp         Mat samples_part = samples.rowRange(i*nsamples/N, (i+1)*nsamples/N );
N                  40 samples/cpp/em.cpp     em_model->setClustersNumber(N);
N                  31 samples/cpp/squares.cpp int thresh = 50, N = 11;
N                  66 samples/cpp/squares.cpp         for( int l = 0; l < N; l++ )
N                  83 samples/cpp/squares.cpp                 gray = gray0 >= (l+1)*255/N;
N                  60 samples/cpp/tutorial_code/HighGUI/GDAL_IO/gdal-image.cpp template <typename DATATYPE, int N>
N                  61 samples/cpp/tutorial_code/HighGUI/GDAL_IO/gdal-image.cpp cv::Vec<DATATYPE,N> lerp( cv::Vec<DATATYPE,N> const& minColor,
N                  62 samples/cpp/tutorial_code/HighGUI/GDAL_IO/gdal-image.cpp                           cv::Vec<DATATYPE,N> const& maxColor,
N                  65 samples/cpp/tutorial_code/HighGUI/GDAL_IO/gdal-image.cpp     cv::Vec<DATATYPE,N> output;
N                  66 samples/cpp/tutorial_code/HighGUI/GDAL_IO/gdal-image.cpp     for( int i=0; i<N; i++ ){
N                  17 samples/tapi/squares.cpp int thresh = 50, N = 11;
N                  52 samples/tapi/squares.cpp         for( int l = 0; l < N; l++ )
N                  69 samples/tapi/squares.cpp                 cv::threshold(gray0, gray, (l+1)*255/N, 255, THRESH_BINARY);