high              311 3rdparty/libtiff/tif_aux.c     int32 low, high;
high              325 3rdparty/libtiff/tif_aux.c     if (i.part.high >= 0) {
high              341 3rdparty/libtiff/tif_aux.c     if (i.part.high >= 0) {
high              165 modules/calib3d/src/dls.h         int high = nn - 1;
high              174 modules/calib3d/src/dls.h             if (i < low || i > high) {
high              262 modules/calib3d/src/dls.h                     for (int i = low; i <= high; i++) {
high              418 modules/calib3d/src/dls.h                         for (int i = low; i <= high; i++) {
high              572 modules/calib3d/src/dls.h             if (i < low || i > high) {
high              582 modules/calib3d/src/dls.h             for (int i = low; i <= high; i++) {
high              584 modules/calib3d/src/dls.h                 for (int k = low; k <= std::min(j, high); k++) {
high              599 modules/calib3d/src/dls.h         int high = n - 1;
high              601 modules/calib3d/src/dls.h         for (int m = low + 1; m <= high - 1; m++) {
high              606 modules/calib3d/src/dls.h             for (int i = m; i <= high; i++) {
high              614 modules/calib3d/src/dls.h                 for (int i = high; i >= m; i--) {
high              630 modules/calib3d/src/dls.h                     for (int i = high; i >= m; i--) {
high              634 modules/calib3d/src/dls.h                     for (int i = m; i <= high; i++) {
high              639 modules/calib3d/src/dls.h                 for (int i = 0; i <= high; i++) {
high              641 modules/calib3d/src/dls.h                     for (int j = high; j >= m; j--) {
high              645 modules/calib3d/src/dls.h                     for (int j = m; j <= high; j++) {
high              662 modules/calib3d/src/dls.h         for (int m = high - 1; m >= low + 1; m--) {
high              664 modules/calib3d/src/dls.h                 for (int i = m + 1; i <= high; i++) {
high              667 modules/calib3d/src/dls.h                 for (int j = m; j <= high; j++) {
high              669 modules/calib3d/src/dls.h                     for (int i = m; i <= high; i++) {
high              674 modules/calib3d/src/dls.h                     for (int i = m; i <= high; i++) {
high             1527 modules/calib3d/test/test_fundam.cpp     CvScalar low = cvScalarAll(0), high = cvScalarAll(10);
high             1532 modules/calib3d/test/test_fundam.cpp     cvtest::randUni( rng, temp, low, high );
high             2141 modules/core/include/opencv2/core.hpp CV_EXPORTS_W void randu(InputOutputArray dst, InputArray low, InputArray high);
high             5304 modules/core/src/arithm.cpp             uint8x16_t high = vld1q_u8(src3 + x);
high             5306 modules/core/src/arithm.cpp             vst1q_u8(dst + x, vandq_u8(vcgeq_u8(values, low), vcgeq_u8(high, values)));
high             5324 modules/core/src/arithm.cpp             int8x16_t high = vld1q_s8(src3 + x);
high             5326 modules/core/src/arithm.cpp             vst1q_u8(dst + x, vandq_u8(vcgeq_s8(values, low), vcgeq_s8(high, values)));
high             5344 modules/core/src/arithm.cpp             uint16x8_t high = vld1q_u16((const uint16_t*)(src3 + x));
high             5345 modules/core/src/arithm.cpp             uint8x8_t  r1 = vmovn_u16(vandq_u16(vcgeq_u16(values, low), vcgeq_u16(high, values)));
high             5349 modules/core/src/arithm.cpp             high = vld1q_u16((const uint16_t*)(src3 + x + 8));
high             5350 modules/core/src/arithm.cpp             uint8x8_t  r2 = vmovn_u16(vandq_u16(vcgeq_u16(values, low), vcgeq_u16(high, values)));
high             5370 modules/core/src/arithm.cpp             int16x8_t high = vld1q_s16((const int16_t*)(src3 + x));
high             5371 modules/core/src/arithm.cpp             uint8x8_t r1 = vmovn_u16(vandq_u16(vcgeq_s16(values, low), vcgeq_s16(high, values)));
high             5375 modules/core/src/arithm.cpp             high = vld1q_s16((const int16_t*)(src3 + x + 8));
high             5376 modules/core/src/arithm.cpp             uint8x8_t r2 = vmovn_u16(vandq_u16(vcgeq_s16(values, low), vcgeq_s16(high, values)));
high             5396 modules/core/src/arithm.cpp             int32x4_t high = vld1q_s32((const int32_t*)(src3 + x));
high             5398 modules/core/src/arithm.cpp             uint16x4_t r1 = vmovn_u32(vandq_u32(vcgeq_s32(values, low), vcgeq_s32(high, values)));
high             5402 modules/core/src/arithm.cpp             high = vld1q_s32((const int32_t*)(src3 + x + 4));
high             5404 modules/core/src/arithm.cpp             uint16x4_t r2 = vmovn_u32(vandq_u32(vcgeq_s32(values, low), vcgeq_s32(high, values)));
high             5426 modules/core/src/arithm.cpp             float32x4_t high = vld1q_f32((const float32_t*)(src3 + x));
high             5428 modules/core/src/arithm.cpp             uint16x4_t r1 = vmovn_u32(vandq_u32(vcgeq_f32(values, low), vcgeq_f32(high, values)));
high             5432 modules/core/src/arithm.cpp             high = vld1q_f32((const float32_t*)(src3 + x + 4));
high             5434 modules/core/src/arithm.cpp             uint16x4_t r2 = vmovn_u32(vandq_u32(vcgeq_f32(values, low), vcgeq_f32(high, values)));
high              327 modules/core/src/lda.cpp         int high = nn - 1;
high              336 modules/core/src/lda.cpp             if (i < low || i > high) {
high              424 modules/core/src/lda.cpp                     for (int i = low; i <= high; i++) {
high              580 modules/core/src/lda.cpp                         for (int i = low; i <= high; i++) {
high              734 modules/core/src/lda.cpp             if (i < low || i > high) {
high              744 modules/core/src/lda.cpp             for (int i = low; i <= high; i++) {
high              746 modules/core/src/lda.cpp                 for (int k = low; k <= std::min(j, high); k++) {
high              761 modules/core/src/lda.cpp         int high = n - 1;
high              763 modules/core/src/lda.cpp         for (int m = low + 1; m <= high - 1; m++) {
high              768 modules/core/src/lda.cpp             for (int i = m; i <= high; i++) {
high              776 modules/core/src/lda.cpp                 for (int i = high; i >= m; i--) {
high              792 modules/core/src/lda.cpp                     for (int i = high; i >= m; i--) {
high              796 modules/core/src/lda.cpp                     for (int i = m; i <= high; i++) {
high              801 modules/core/src/lda.cpp                 for (int i = 0; i <= high; i++) {
high              803 modules/core/src/lda.cpp                     for (int j = high; j >= m; j--) {
high              807 modules/core/src/lda.cpp                     for (int j = m; j <= high; j++) {
high              824 modules/core/src/lda.cpp         for (int m = high - 1; m >= low + 1; m--) {
high              826 modules/core/src/lda.cpp                 for (int i = m + 1; i <= high; i++) {
high              829 modules/core/src/lda.cpp                 for (int j = m; j <= high; j++) {
high              831 modules/core/src/lda.cpp                     for (int i = m; i <= high; i++) {
high              836 modules/core/src/lda.cpp                     for (int i = m; i <= high; i++) {
high              737 modules/core/src/rand.cpp void cv::randu(InputOutputArray dst, InputArray low, InputArray high)
high              739 modules/core/src/rand.cpp     theRNG().fill(dst, RNG::UNIFORM, low, high);
high               82 modules/core/test/test_math.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high              137 modules/core/test/test_math.cpp void Core_PowTest::get_minmax_bounds( int /*i*/, int /*j*/, int type, Scalar& low, Scalar& high )
high              149 modules/core/test/test_math.cpp     high = Scalar::all(u);
high              606 modules/core/test/test_math.cpp     void get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high );
high              686 modules/core/test/test_math.cpp void Core_GEMMTest::get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high )
high              689 modules/core/test/test_math.cpp     high = Scalar::all(10.);
high              716 modules/core/test/test_math.cpp     void get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high );
high              767 modules/core/test/test_math.cpp void Core_MulTransposedTest::get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high )
high              770 modules/core/test/test_math.cpp     high = cvScalarAll(10.);
high             1338 modules/core/test/test_math.cpp     void get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high );
high             1363 modules/core/test/test_math.cpp void Core_DetTest::get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high )
high             1366 modules/core/test/test_math.cpp     high = cvScalarAll(2.);
high             1496 modules/core/test/test_math.cpp     void get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high );
high             1573 modules/core/test/test_math.cpp void Core_InvertTest::get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high )
high             1576 modules/core/test/test_math.cpp     high = cvScalarAll(1.);
high             1652 modules/core/test/test_math.cpp     void get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high );
high             1724 modules/core/test/test_math.cpp void Core_SolveTest::get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high )
high             1727 modules/core/test/test_math.cpp     high = cvScalarAll(1.);
high             1792 modules/core/test/test_math.cpp     void get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high );
high             1910 modules/core/test/test_math.cpp void Core_SVDTest::get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high )
high             1913 modules/core/test/test_math.cpp     high = cvScalarAll(2.);
high             2022 modules/core/test/test_math.cpp     void get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high );
high             2125 modules/core/test/test_math.cpp void Core_SVBkSbTest::get_minmax_bounds( int /*i*/, int /*j*/, int /*type*/, Scalar& low, Scalar& high )
high             2128 modules/core/test/test_math.cpp     high = cvScalarAll(2.);
high              278 modules/flann/include/opencv2/flann/kdtree_single_index.h         DistanceType low, high;
high              319 modules/flann/include/opencv2/flann/kdtree_single_index.h             bbox[i].high = (DistanceType)dataset_[0][i];
high              324 modules/flann/include/opencv2/flann/kdtree_single_index.h                 if (dataset_[k][i]>bbox[i].high) bbox[i].high = (DistanceType)dataset_[k][i];
high              352 modules/flann/include/opencv2/flann/kdtree_single_index.h                 bbox[i].high = (DistanceType)dataset_[vind_[left]][i];
high              357 modules/flann/include/opencv2/flann/kdtree_single_index.h                     if (bbox[i].high<dataset_[vind_[k]][i]) bbox[i].high=(DistanceType)dataset_[vind_[k]][i];
high              370 modules/flann/include/opencv2/flann/kdtree_single_index.h             left_bbox[cutfeat].high = cutval;
high              377 modules/flann/include/opencv2/flann/kdtree_single_index.h             node->divlow = left_bbox[cutfeat].high;
high              382 modules/flann/include/opencv2/flann/kdtree_single_index.h                 bbox[i].high = std::max(left_bbox[i].high, right_bbox[i].high);
high              403 modules/flann/include/opencv2/flann/kdtree_single_index.h         ElementType max_span = bbox[0].high-bbox[0].low;
high              405 modules/flann/include/opencv2/flann/kdtree_single_index.h         cutval = (bbox[0].high+bbox[0].low)/2;
high              407 modules/flann/include/opencv2/flann/kdtree_single_index.h             ElementType span = bbox[i].high-bbox[i].low;
high              411 modules/flann/include/opencv2/flann/kdtree_single_index.h                 cutval = (bbox[i].high+bbox[i].low)/2;
high              425 modules/flann/include/opencv2/flann/kdtree_single_index.h             ElementType span = bbox[i].high-bbox[i].low;
high              448 modules/flann/include/opencv2/flann/kdtree_single_index.h         DistanceType max_span = bbox[0].high-bbox[0].low;
high              450 modules/flann/include/opencv2/flann/kdtree_single_index.h             DistanceType span = bbox[i].high-bbox[i].low;
high              458 modules/flann/include/opencv2/flann/kdtree_single_index.h             DistanceType span = bbox[i].high-bbox[i].low;
high              470 modules/flann/include/opencv2/flann/kdtree_single_index.h         DistanceType split_val = (bbox[cutfeat].low+bbox[cutfeat].high)/2;
high              530 modules/flann/include/opencv2/flann/kdtree_single_index.h             if (vec[i] > root_bbox_[i].high) {
high              531 modules/flann/include/opencv2/flann/kdtree_single_index.h                 dists[i] = distance_.accum_dist(vec[i], root_bbox_[i].high, (int)i);
high               61 modules/flann/include/opencv2/flann/random.h inline double rand_double(double high = 1.0, double low = 0)
high               63 modules/flann/include/opencv2/flann/random.h     return low + ((high-low) * (std::rand() / (RAND_MAX + 1.0)));
high               72 modules/flann/include/opencv2/flann/random.h inline int rand_int(int high = RAND_MAX, int low = 0)
high               74 modules/flann/include/opencv2/flann/random.h     return low + (int) ( double(high-low) * (std::rand() / (RAND_MAX + 1.0)));
high              584 modules/hal/include/opencv2/hal/intrin_cpp.hpp                         v_reg<_Tp, n>& low, v_reg<_Tp, n>& high)
high              590 modules/hal/include/opencv2/hal/intrin_cpp.hpp         high.s[i] = a.s[i+(n/2)];
high              591 modules/hal/include/opencv2/hal/intrin_cpp.hpp         high.s[i+(n/2)] = b.s[i+(n/2)];
high               58 modules/imgproc/src/canny.cpp static bool ippCanny(const Mat& _src, Mat& _dst, float low,  float high)
high               90 modules/imgproc/src/canny.cpp                               _dst.ptr(), (int)_dst.step, roi, low, high, buffer) < 0 )
high              129 modules/imgproc/src/canny.cpp     int low = cvFloor(low_thresh), high = cvFloor(high_thresh);
high              155 modules/imgproc/src/canny.cpp                         (float) low, (float) high);
high              184 modules/imgproc/src/canny.cpp                            low, high);
high              243 modules/imgproc/src/canny.cpp         : boundaries(_boundaries), src(_src), map(_map), low(_low), high(_high),
high              513 modules/imgproc/src/canny.cpp                     if (!prev_flag && m > high && (i <= boundaries.start+1 || _map[j-mapstep] != 2) )
high              571 modules/imgproc/src/canny.cpp     int high;
high              639 modules/imgproc/src/canny.cpp int high = cvFloor(high_thresh);
high              666 modules/imgproc/src/canny.cpp         g.run(tbbCanny(Range(i * grainSize, (i + 1) * grainSize), src, map, low, high, aperture_size, L2gradient));
high              668 modules/imgproc/src/canny.cpp         g.run(tbbCanny(Range(i * grainSize, src.rows), src, map, low, high, aperture_size, L2gradient));
high              706 modules/imgproc/src/canny.cpp     int high = cvFloor(high_thresh);
high              910 modules/imgproc/src/canny.cpp             if (!prev_flag && m > high && _map[j-mapstep] != 2)
high               87 modules/imgproc/src/colormap.cpp         int high = X.rows - 1;
high               90 modules/imgproc/src/colormap.cpp             high = 1;
high               91 modules/imgproc/src/colormap.cpp         if(XI.at<_Tp>(i,0) > X.at<_Tp>(high, 0))
high               92 modules/imgproc/src/colormap.cpp             low = high - 1;
high               94 modules/imgproc/src/colormap.cpp         while((high-low)>1) {
high               95 modules/imgproc/src/colormap.cpp             const int c = low + ((high - low) >> 1);
high               99 modules/imgproc/src/colormap.cpp                 high = c;
high              105 modules/imgproc/src/colormap.cpp         * (Y.at<_Tp>(high,0) - Y.at<_Tp>(low,0))
high              106 modules/imgproc/src/colormap.cpp         / (X.at<_Tp>(high,0) - X.at<_Tp>(low,0));
high               57 modules/imgproc/src/histogram.cpp     const int low = 0, high = 256;
high               59 modules/imgproc/src/histogram.cpp     _tab.resize((high-low)*dims);
high               71 modules/imgproc/src/histogram.cpp             for( j = low; j < high; j++ )
high               80 modules/imgproc/src/histogram.cpp                 tab[i*(high - low) + j - low] = written_idx;
high               88 modules/imgproc/src/histogram.cpp             int limit = std::min(cvCeil(ranges[i][0]), high);
high               96 modules/imgproc/src/histogram.cpp                     tab[i*(high - low) + j - low] = written_idx;
high              100 modules/imgproc/src/histogram.cpp                     limit = std::min(cvCeil(ranges[i][idx+1]), high);
high              105 modules/imgproc/src/histogram.cpp                     for( ; j < high; j++ )
high              106 modules/imgproc/src/histogram.cpp                         tab[i*(high - low) + j - low] = OUT_OF_RANGE;
high              191 modules/imgproc/src/histogram.cpp             double low = ranges[i][0], high = ranges[i][1];
high              192 modules/imgproc/src/histogram.cpp             double t = histSize[i]/(high - low);
high             1185 modules/imgproc/src/histogram.cpp         ParallelLoopBody(), src(&_src), hist(&_hist), levels(&_levels), histSize(_histSize), low(_low), high(_high), ok(_ok)
high             1196 modules/imgproc/src/histogram.cpp             phist.ptr<Ipp32s>(), (Ipp32s *)*levels, histSize, low, high);
high             1213 modules/imgproc/src/histogram.cpp     Ipp32s histSize, low, high;
high               58 modules/imgproc/test/test_color.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high              107 modules/imgproc/test/test_color.cpp void CV_ColorCvtBaseTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high              109 modules/imgproc/test/test_color.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high              114 modules/imgproc/test/test_color.cpp         high = Scalar::all( depth == CV_8U ? 256 : depth == CV_16U ? 65536 : 1. );
high              211 modules/imgproc/test/test_convhull.cpp     CvScalar low, high;
high              226 modules/imgproc/test/test_convhull.cpp     low = high = cvScalarAll(0);
high              283 modules/imgproc/test/test_convhull.cpp         a[k] = high.val[k] - low.val[k];
high              370 modules/imgproc/test/test_convhull.cpp         high.val[i] = (cvtest::randReal(rng)-0.5)*low_high_range*2;
high              371 modules/imgproc/test/test_convhull.cpp         if( low.val[i] > high.val[i] )
high              374 modules/imgproc/test/test_convhull.cpp             CV_SWAP( low.val[i], high.val[i], t );
high              376 modules/imgproc/test/test_convhull.cpp         if( high.val[i] < low.val[i] + 1 )
high              377 modules/imgproc/test/test_convhull.cpp             high.val[i] += 1;
high             1165 modules/imgproc/test/test_convhull.cpp     box0.center.x = (float)((low.val[0] + high.val[0])*0.5);
high             1166 modules/imgproc/test/test_convhull.cpp     box0.center.y = (float)((low.val[1] + high.val[1])*0.5);
high             1167 modules/imgproc/test/test_convhull.cpp     box0.size.width = (float)(MAX(high.val[0] - low.val[0], min_ellipse_size)*2);
high             1168 modules/imgproc/test/test_convhull.cpp     box0.size.height = (float)(MAX(high.val[1] - low.val[1], min_ellipse_size)*2);
high             1378 modules/imgproc/test/test_convhull.cpp     int height = (int)(MAX(high.val[0] - low.val[0], min_ellipse_size));
high             1379 modules/imgproc/test/test_convhull.cpp     int width = (int)(MAX(high.val[1] - low.val[1], min_ellipse_size));
high             1458 modules/imgproc/test/test_convhull.cpp         line0[k+n] = (float)((low.val[k] + high.val[k])*0.5);
high             1459 modules/imgproc/test/test_convhull.cpp         line0[k] = (float)(high.val[k] - low.val[k]);
high               58 modules/imgproc/test/test_distancetransform.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high              117 modules/imgproc/test/test_distancetransform.cpp void CV_DisTransTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high              119 modules/imgproc/test/test_distancetransform.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high              123 modules/imgproc/test/test_distancetransform.cpp         high = Scalar::all(10);
high               56 modules/imgproc/test/test_filter.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high               93 modules/imgproc/test/test_filter.cpp void CV_FilterBaseTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high               95 modules/imgproc/test/test_filter.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high              105 modules/imgproc/test/test_filter.cpp                 high = Scalar::all(val);
high              110 modules/imgproc/test/test_filter.cpp                 high = Scalar::all(2);
high              116 modules/imgproc/test/test_filter.cpp             high = Scalar::all(40000.);
high              121 modules/imgproc/test/test_filter.cpp             high = Scalar::all(10.);
high             1209 modules/imgproc/test/test_filter.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high             1253 modules/imgproc/test/test_filter.cpp void CV_FeatureSelBaseTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high             1255 modules/imgproc/test/test_filter.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high             1259 modules/imgproc/test/test_filter.cpp         high = Scalar::all(10.);
high             1569 modules/imgproc/test/test_filter.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high             1591 modules/imgproc/test/test_filter.cpp void CV_IntegralTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high             1593 modules/imgproc/test/test_filter.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high             1598 modules/imgproc/test/test_filter.cpp         high = Scalar::all(10.);
high               80 modules/imgproc/test/test_histograms.cpp     double low, high, range_delta;
high              166 modules/imgproc/test/test_histograms.cpp         high = cvtest::getMaxVal(img_type);
high              170 modules/imgproc/test/test_histograms.cpp         high = 1000;
high              171 modules/imgproc/test/test_histograms.cpp         low = -high;
high              174 modules/imgproc/test/test_histograms.cpp     range_delta = (cvtest::randInt(rng) % 2)*(high-low)*0.05;
high              180 modules/imgproc/test/test_histograms.cpp     double _low = low + range_delta, _high = high - range_delta;
high             1189 modules/imgproc/test/test_histograms.cpp                 cvtest::randUni( rng, images_i, Scalar::all(low), Scalar::all(high) );
high             1400 modules/imgproc/test/test_histograms.cpp                 cvtest::randUni( rng, images_i, Scalar::all(low), Scalar::all(high) );
high             1426 modules/imgproc/test/test_histograms.cpp                 double val = cvtest::randReal(rng)*(high - low) + low;
high             1632 modules/imgproc/test/test_histograms.cpp                 cvtest::randUni( rng, images_i, Scalar::all(low), Scalar::all(high) );
high             1654 modules/imgproc/test/test_histograms.cpp                 double val = cvtest::randReal(rng)*(high - low) + low;
high               56 modules/imgproc/test/test_imgwarp.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high               87 modules/imgproc/test/test_imgwarp.cpp void CV_ImgWarpBaseTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high               89 modules/imgproc/test/test_imgwarp.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high               93 modules/imgproc/test/test_imgwarp.cpp         high = Scalar::all(10);
high               65 modules/imgproc/test/test_moments.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high               86 modules/imgproc/test/test_moments.cpp void CV_MomentsTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high               88 modules/imgproc/test/test_moments.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high               94 modules/imgproc/test/test_moments.cpp         high = Scalar::all(1000);
high               99 modules/imgproc/test/test_moments.cpp         high = Scalar::all(1000);
high              104 modules/imgproc/test/test_moments.cpp         high = Scalar::all(1);
high              342 modules/imgproc/test/test_moments.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high              356 modules/imgproc/test/test_moments.cpp void CV_HuMomentsTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high              358 modules/imgproc/test/test_moments.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high              360 modules/imgproc/test/test_moments.cpp     high = Scalar::all(10000);
high               55 modules/imgproc/test/test_templmatch.cpp     void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high               92 modules/imgproc/test/test_templmatch.cpp void CV_TemplMatchTest::get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high )
high               94 modules/imgproc/test/test_templmatch.cpp     cvtest::ArrayTest::get_minmax_bounds( i, j, type, low, high );
high               99 modules/imgproc/test/test_templmatch.cpp         high = Scalar::all(10.);
high              455 modules/ts/include/opencv2/ts.hpp     virtual void get_minmax_bounds( int i, int j, int type, Scalar& low, Scalar& high );
high              228 modules/ts/src/ts_arrtest.cpp void ArrayTest::get_minmax_bounds( int i, int /*j*/, int type, Scalar& low, Scalar& high )
high              250 modules/ts/src/ts_arrtest.cpp     high = Scalar::all(u);
high              260 modules/ts/src/ts_arrtest.cpp         Scalar low, high;
high              262 modules/ts/src/ts_arrtest.cpp         get_minmax_bounds( i, j, arr.type(), low, high );
high              263 modules/ts/src/ts_arrtest.cpp         randUni( ts->get_rng(), arr, low, high );
high              134 samples/gpu/performance/performance.cpp void gen(Mat& mat, int rows, int cols, int type, Scalar low, Scalar high)
high              138 samples/gpu/performance/performance.cpp     rng.fill(mat, RNG::UNIFORM, low, high);
high              183 samples/gpu/performance/performance.h          cv::Scalar high);