Fix build warnings
authorAndrey Kamaev <andrey.kamaev@itseez.com>
Sun, 19 Aug 2012 15:36:43 +0000 (19:36 +0400)
committerAndrey Kamaev <andrey.kamaev@itseez.com>
Sun, 19 Aug 2012 15:36:43 +0000 (19:36 +0400)
modules/calib3d/src/triangulate.cpp
modules/gpu/src/graphcuts.cpp
modules/gpu/test/test_imgproc.cpp
modules/imgproc/perf/perf_warp.cpp
modules/ml/src/em.cpp
modules/nonfree/test/test_rotation_and_scale_invariance.cpp
modules/objdetect/src/hog.cpp
modules/stitching/include/opencv2/stitching/detail/seam_finders.hpp
modules/stitching/src/seam_finders.cpp
modules/video/src/bgfg_gmg.cpp

index c86a783..5d6037a 100644 (file)
@@ -416,10 +416,10 @@ void cv::triangulatePoints( InputArray _projMatr1, InputArray _projMatr2,
     Mat points1 = _projPoints1.getMat(), points2 = _projPoints2.getMat();
 
     if((points1.rows == 1 || points1.cols == 1) && points1.channels() == 2)
-        points1 = points1.reshape(1, points1.total()).t();
+        points1 = points1.reshape(1, static_cast<int>(points1.total())).t();
 
     if((points2.rows == 1 || points2.cols == 1) && points2.channels() == 2)
-        points2 = points2.reshape(1, points2.total()).t();
+        points2 = points2.reshape(1, static_cast<int>(points2.total())).t();
 
     CvMat cvMatr1 = matr1, cvMatr2 = matr2;
     CvMat cvPoints1 = points1, cvPoints2 = points2;
index 58fcde8..fc3ac1e 100644 (file)
@@ -48,7 +48,7 @@ void cv::gpu::graphcut(GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, Gpu
 void cv::gpu::graphcut(GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, GpuMat&, Stream&) { throw_nogpu(); }
 
 void cv::gpu::connectivityMask(const GpuMat&, GpuMat&, const cv::Scalar&, const cv::Scalar&, Stream&) { throw_nogpu(); }
-void cv::gpu::labelComponents(const GpuMat& mask, GpuMat& components, int, Stream& stream) { throw_nogpu(); }
+void cv::gpu::labelComponents(const GpuMat&, GpuMat&, int, Stream&) { throw_nogpu(); }
 
 #else /* !defined (HAVE_CUDA) */
 
index 4d67de5..b3c9dfd 100644 (file)
@@ -1154,7 +1154,7 @@ TEST_P(HoughLines, Accuracy)
     const std::string fileName = GET_PARAM(1);\r
 \r
     const float rho = 1.0f;\r
-    const float theta = CV_PI / 180.0f;\r
+    const float theta = static_cast<float>(CV_PI / 180);\r
     const int threshold = 50;\r
 \r
     cv::Mat img = readImage(fileName, cv::IMREAD_GRAYSCALE);\r
index 823ff53..8f309a2 100644 (file)
@@ -125,8 +125,8 @@ void update_map(const Mat& src, Mat& map_x, Mat& map_y, const int remapMode )
             case HALF_SIZE:
                 if( i > src.cols*0.25 && i < src.cols*0.75 && j > src.rows*0.25 && j < src.rows*0.75 )
                 {
-                    map_x.at<float>(j,i) = 2*( i - src.cols*0.25 ) + 0.5 ;
-                    map_y.at<float>(j,i) = 2*( j - src.rows*0.25 ) + 0.5 ;
+                    map_x.at<float>(j,i) = 2*( i - src.cols*0.25f ) + 0.5f ;
+                    map_y.at<float>(j,i) = 2*( j - src.rows*0.25f ) + 0.5f ;
                 }
                 else
                 {
@@ -135,16 +135,16 @@ void update_map(const Mat& src, Mat& map_x, Mat& map_y, const int remapMode )
                 }
                 break;
             case UPSIDE_DOWN:
-                map_x.at<float>(j,i) = i ;
-                map_y.at<float>(j,i) = src.rows - j ;
+                map_x.at<float>(j,i) = static_cast<float>(i) ;
+                map_y.at<float>(j,i) = static_cast<float>(src.rows - j) ;
                 break;
             case REFLECTION_X:
-                map_x.at<float>(j,i) = src.cols - i ;
-                map_y.at<float>(j,i) = j ;
+                map_x.at<float>(j,i) = static_cast<float>(src.cols - i) ;
+                map_y.at<float>(j,i) = static_cast<float>(j) ;
                 break;
             case REFLECTION_BOTH:
-                map_x.at<float>(j,i) = src.cols - i ;
-                map_y.at<float>(j,i) = src.rows - j ;
+                map_x.at<float>(j,i) = static_cast<float>(src.cols - i) ;
+                map_y.at<float>(j,i) = static_cast<float>(src.rows - j) ;
                 break;
             } // end of switch
         }
index 39b58e0..20f365e 100644 (file)
@@ -386,7 +386,7 @@ void EM::computeLogWeightDivDet()
     for(int clusterIndex = 0; clusterIndex < nclusters; clusterIndex++)
     {
         double logDetCov = 0.;
-        const int evalCount = covsEigenValues[clusterIndex].total();
+        const int evalCount = static_cast<int>(covsEigenValues[clusterIndex].total());
         for(int di = 0; di < evalCount; di++)
             logDetCov += std::log(covsEigenValues[clusterIndex].at<double>(covMatType != EM::COV_MAT_SPHERICAL ? di : 0));
 
index 9c099f8..b5cb62b 100644 (file)
@@ -54,7 +54,7 @@ static
 Mat generateHomography(float angle)
 {
     // angle - rotation around Oz in degrees
-    float angleRadian = angle * CV_PI / 180.;
+    float angleRadian = static_cast<float>(angle * CV_PI / 180);
     Mat H = Mat::eye(3, 3, CV_32FC1);
     H.at<float>(0,0) = H.at<float>(1,1) = std::cos(angleRadian);
     H.at<float>(0,1) = -std::sin(angleRadian);
@@ -69,8 +69,8 @@ Mat rotateImage(const Mat& srcImage, float angle, Mat& dstImage, Mat& dstMask)
     // angle - rotation around Oz in degrees
     float diag = std::sqrt(static_cast<float>(srcImage.cols * srcImage.cols + srcImage.rows * srcImage.rows));
     Mat LUShift = Mat::eye(3, 3, CV_32FC1); // left up
-    LUShift.at<float>(0,2) = -srcImage.cols/2;
-    LUShift.at<float>(1,2) = -srcImage.rows/2;
+    LUShift.at<float>(0,2) = static_cast<float>(-srcImage.cols/2);
+    LUShift.at<float>(1,2) = static_cast<float>(-srcImage.rows/2);
     Mat RDShift = Mat::eye(3, 3, CV_32FC1); // right down
     RDShift.at<float>(0,2) = diag/2;
     RDShift.at<float>(1,2) = diag/2;
@@ -114,7 +114,7 @@ void scaleKeyPoints(const vector<KeyPoint>& src, vector<KeyPoint>& dst, float sc
 static
 float calcCirclesIntersectArea(const Point2f& p0, float r0, const Point2f& p1, float r1)
 {
-    float c = norm(p0 - p1), sqr_c = c * c;
+    float c = static_cast<float>(norm(p0 - p1)), sqr_c = c * c;
 
     float sqr_r0 = r0 * r0;
     float sqr_r1 = r1 * r1;
@@ -125,7 +125,7 @@ float calcCirclesIntersectArea(const Point2f& p0, float r0, const Point2f& p1, f
     float minR = std::min(r0, r1);
     float maxR = std::max(r0, r1);
     if(c + minR <= maxR)
-        return CV_PI * minR * minR;
+        return static_cast<float>(CV_PI * minR * minR);
 
     float cos_halfA0 = (sqr_r0 + sqr_c - sqr_r1) / (2 * r0 * c);
     float cos_halfA1 = (sqr_r1 + sqr_c - sqr_r0) / (2 * r1 * c);
@@ -133,15 +133,15 @@ float calcCirclesIntersectArea(const Point2f& p0, float r0, const Point2f& p1, f
     float A0 = 2 * acos(cos_halfA0);
     float A1 = 2 * acos(cos_halfA1);
 
-    return  0.5 * sqr_r0 * (A0 - sin(A0)) +
-            0.5 * sqr_r1 * (A1 - sin(A1));
+    return  0.5f * sqr_r0 * (A0 - sin(A0)) +
+            0.5f * sqr_r1 * (A1 - sin(A1));
 }
 
 static
 float calcIntersectRatio(const Point2f& p0, float r0, const Point2f& p1, float r1)
 {
     float intersectArea = calcCirclesIntersectArea(p0, r0, p1, r1);
-    float unionArea = CV_PI * (r0 * r0 + r1 * r1) - intersectArea;
+    float unionArea = static_cast<float>(CV_PI) * (r0 * r0 + r1 * r1) - intersectArea;
     return intersectArea / unionArea;
 }
 
@@ -160,7 +160,7 @@ void matchKeyPoints(const vector<KeyPoint>& keypoints0, const Mat& H,
 
     matches.clear();
     vector<uchar> usedMask(keypoints1.size(), 0);
-    for(size_t i0 = 0; i0 < keypoints0.size(); i0++)
+    for(int i0 = 0; i0 < static_cast<int>(keypoints0.size()); i0++)
     {
         int nearestPointIndex = -1;
         float maxIntersectRatio = 0.f;
@@ -176,7 +176,7 @@ void matchKeyPoints(const vector<KeyPoint>& keypoints0, const Mat& H,
             if(intersectRatio > maxIntersectRatio)
             {
                 maxIntersectRatio = intersectRatio;
-                nearestPointIndex = i1;
+                nearestPointIndex = static_cast<int>(i1);
             }
         }
 
@@ -222,7 +222,7 @@ protected:
         const int maxAngle = 360, angleStep = 15;
         for(int angle = 0; angle < maxAngle; angle += angleStep)
         {
-            Mat H = rotateImage(image0, angle, image1, mask1);
+            Mat H = rotateImage(image0, static_cast<float>(angle), image1, mask1);
 
             vector<KeyPoint> keypoints1;
             featureDetector->detect(image1, keypoints1, mask1);
@@ -339,10 +339,10 @@ protected:
         const int maxAngle = 360, angleStep = 15;
         for(int angle = 0; angle < maxAngle; angle += angleStep)
         {
-            Mat H = rotateImage(image0, angle, image1, mask1);
+            Mat H = rotateImage(image0, static_cast<float>(angle), image1, mask1);
 
             vector<KeyPoint> keypoints1;
-            rotateKeyPoints(keypoints0, H, angle, keypoints1);
+            rotateKeyPoints(keypoints0, H, static_cast<float>(angle), keypoints1);
             Mat descriptors1;
             descriptorExtractor->compute(image1, keypoints1, descriptors1);
 
@@ -457,7 +457,7 @@ protected:
                 keyPointMatchesCount++;
 
                 // Check does this inlier have consistent sizes
-                const float maxSizeDiff = 0.8;//0.9f; // grad
+                const float maxSizeDiff = 0.8f;//0.9f; // grad
                 float size0 = keypoints0[matches[m].trainIdx].size;
                 float size1 = osiKeypoints1[matches[m].queryIdx].size;
                 CV_Assert(size0 > 0 && size1 > 0);
@@ -545,7 +545,7 @@ protected:
             resize(image0, image1, Size(), 1./scale, 1./scale);
 
             vector<KeyPoint> keypoints1;
-            scaleKeyPoints(keypoints0, keypoints1, 1./scale);
+            scaleKeyPoints(keypoints0, keypoints1, 1.0f/scale);
             Mat descriptors1;
             descriptorExtractor->compute(image1, keypoints1, descriptors1);
 
index 485334c..19decfb 100644 (file)
@@ -2563,7 +2563,7 @@ void HOGDescriptor::readALTModel(std::string modelfile)
        throw Exception();
    }
    int kernel_type;
-   int nread;
+   size_t nread;
    nread=fread(&(kernel_type),sizeof(int),1,modelfl);
 
    {// ignore these
index c700a16..fc1fcc7 100644 (file)
@@ -120,7 +120,7 @@ private:
         ImagePairLess(const std::vector<Mat> &images, const std::vector<Point> &corners)\r
             : src_(&images[0]), corners_(&corners[0]) {}\r
 \r
-        bool operator() (const std::pair<int, int> &l, const std::pair<int, int> &r) const\r
+        bool operator() (const std::pair<size_t, size_t> &l, const std::pair<size_t, size_t> &r) const\r
         {\r
             Point c1 = corners_[l.first] + Point(src_[l.first].cols / 2, src_[l.first].rows / 2);\r
             Point c2 = corners_[l.second] + Point(src_[l.second].cols / 2, src_[l.second].rows / 2);\r
index 723a087..3e10398 100644 (file)
@@ -166,7 +166,7 @@ void DpSeamFinder::find(const vector<Mat> &src, const vector<Point> &corners, ve
     if (src.size() == 0)\r
         return;\r
 \r
-    vector<pair<int, int> > pairs;\r
+    vector<pair<size_t, size_t> > pairs;\r
 \r
     for (size_t i = 0; i+1 < src.size(); ++i)\r
         for (size_t j = i+1; j < src.size(); ++j)\r
@@ -177,7 +177,7 @@ void DpSeamFinder::find(const vector<Mat> &src, const vector<Point> &corners, ve
 \r
     for (size_t i = 0; i < pairs.size(); ++i)\r
     {\r
-        int i0 = pairs[i].first, i1 = pairs[i].second;\r
+        size_t i0 = pairs[i].first, i1 = pairs[i].second;\r
         process(src[i0], src[i1], corners[i0], corners[i1], masks[i0], masks[i1]);\r
     }\r
 \r
@@ -393,7 +393,7 @@ void DpSeamFinder::resolveConflicts(
     bool hasConflict = true;\r
     while (hasConflict)\r
     {\r
-        int c1, c2;\r
+        int c1 = 0, c2 = 0;\r
         hasConflict = false;\r
 \r
         for (set<pair<int, int> >::iterator itr = edges_.begin(); itr != edges_.end(); ++itr)\r
@@ -635,7 +635,7 @@ bool DpSeamFinder::getSeamTips(int comp1, int comp2, Point &p1, Point &p2)
         double cx = cvRound(sum[idx[i]].x / size);\r
         double cy = cvRound(sum[idx[i]].y / size);\r
 \r
-        int closest = -1;\r
+        size_t closest = points[idx[i]].size();\r
         double minDist = numeric_limits<double>::max();\r
 \r
         for (size_t j = 0; j < points[idx[i]].size(); ++j)\r
index f2e52b5..056da38 100644 (file)
@@ -290,7 +290,7 @@ namespace
                         normalizeHistogram(weights, nfeatures);
                 }
 
-                fgmask_row[x] = (uchar)(-isForeground);
+                fgmask_row[x] = (uchar)(-(schar)isForeground);
             }
         }
     }