"black box" representation of the file storage associated with a file on disk.
More...
|
CV_EXPORTS_W void | Rodrigues (InputArray src, OutputArray dst, OutputArray jacobian=noArray()) |
| Converts a rotation matrix to a rotation vector or vice versa. More...
|
|
CV_EXPORTS_W Mat | findHomography (InputArray srcPoints, InputArray dstPoints, int method=0, double ransacReprojThreshold=3, OutputArray mask=noArray(), const int maxIters=2000, const double confidence=0.995) |
| Finds a perspective transformation between two planes. More...
|
|
CV_EXPORTS Mat | findHomography (InputArray srcPoints, InputArray dstPoints, OutputArray mask, int method=0, double ransacReprojThreshold=3) |
|
CV_EXPORTS_W Mat | findHomography (InputArray srcPoints, InputArray dstPoints, OutputArray mask, const UsacParams ¶ms) |
|
CV_EXPORTS_W Vec3d | RQDecomp3x3 (InputArray src, OutputArray mtxR, OutputArray mtxQ, OutputArray Qx=noArray(), OutputArray Qy=noArray(), OutputArray Qz=noArray()) |
| Computes an RQ decomposition of 3x3 matrices. More...
|
|
CV_EXPORTS_W void | decomposeProjectionMatrix (InputArray projMatrix, OutputArray cameraMatrix, OutputArray rotMatrix, OutputArray transVect, OutputArray rotMatrixX=noArray(), OutputArray rotMatrixY=noArray(), OutputArray rotMatrixZ=noArray(), OutputArray eulerAngles=noArray()) |
| Decomposes a projection matrix into a rotation matrix and a camera intrinsic matrix. More...
|
|
CV_EXPORTS_W void | matMulDeriv (InputArray A, InputArray B, OutputArray dABdA, OutputArray dABdB) |
| Computes partial derivatives of the matrix product for each multiplied matrix. More...
|
|
CV_EXPORTS_W void | composeRT (InputArray rvec1, InputArray tvec1, InputArray rvec2, InputArray tvec2, OutputArray rvec3, OutputArray tvec3, OutputArray dr3dr1=noArray(), OutputArray dr3dt1=noArray(), OutputArray dr3dr2=noArray(), OutputArray dr3dt2=noArray(), OutputArray dt3dr1=noArray(), OutputArray dt3dt1=noArray(), OutputArray dt3dr2=noArray(), OutputArray dt3dt2=noArray()) |
| Combines two rotation-and-shift transformations. More...
|
|
CV_EXPORTS_W void | projectPoints (InputArray objectPoints, InputArray rvec, InputArray tvec, InputArray cameraMatrix, InputArray distCoeffs, OutputArray imagePoints, OutputArray jacobian=noArray(), double aspectRatio=0) |
| Projects 3D points to an image plane. More...
|
|
CV_EXPORTS_W bool | solvePnP (InputArray objectPoints, InputArray imagePoints, InputArray cameraMatrix, InputArray distCoeffs, OutputArray rvec, OutputArray tvec, bool useExtrinsicGuess=false, int flags=SOLVEPNP_ITERATIVE) |
| Finds an object pose from 3D-2D point correspondences. More...
|
|
CV_EXPORTS_W bool | solvePnPRansac (InputArray objectPoints, InputArray imagePoints, InputArray cameraMatrix, InputArray distCoeffs, OutputArray rvec, OutputArray tvec, bool useExtrinsicGuess=false, int iterationsCount=100, float reprojectionError=8.0, double confidence=0.99, OutputArray inliers=noArray(), int flags=SOLVEPNP_ITERATIVE) |
| Finds an object pose from 3D-2D point correspondences using the RANSAC scheme. More...
|
|
CV_EXPORTS_W bool | solvePnPRansac (InputArray objectPoints, InputArray imagePoints, InputOutputArray cameraMatrix, InputArray distCoeffs, OutputArray rvec, OutputArray tvec, OutputArray inliers, const UsacParams ¶ms=UsacParams()) |
|
CV_EXPORTS_W int | solveP3P (InputArray objectPoints, InputArray imagePoints, InputArray cameraMatrix, InputArray distCoeffs, OutputArrayOfArrays rvecs, OutputArrayOfArrays tvecs, int flags) |
| Finds an object pose from 3 3D-2D point correspondences. More...
|
|
CV_EXPORTS_W void | solvePnPRefineLM (InputArray objectPoints, InputArray imagePoints, InputArray cameraMatrix, InputArray distCoeffs, InputOutputArray rvec, InputOutputArray tvec, TermCriteria criteria=TermCriteria(TermCriteria::EPS+TermCriteria::COUNT, 20, FLT_EPSILON)) |
| Refine a pose (the translation and the rotation that transform a 3D point expressed in the object coordinate frame to the camera coordinate frame) from a 3D-2D point correspondences and starting from an initial solution. More...
|
|
CV_EXPORTS_W void | solvePnPRefineVVS (InputArray objectPoints, InputArray imagePoints, InputArray cameraMatrix, InputArray distCoeffs, InputOutputArray rvec, InputOutputArray tvec, TermCriteria criteria=TermCriteria(TermCriteria::EPS+TermCriteria::COUNT, 20, FLT_EPSILON), double VVSlambda=1) |
| Refine a pose (the translation and the rotation that transform a 3D point expressed in the object coordinate frame to the camera coordinate frame) from a 3D-2D point correspondences and starting from an initial solution. More...
|
|
CV_EXPORTS_W int | solvePnPGeneric (InputArray objectPoints, InputArray imagePoints, InputArray cameraMatrix, InputArray distCoeffs, OutputArrayOfArrays rvecs, OutputArrayOfArrays tvecs, bool useExtrinsicGuess=false, SolvePnPMethod flags=SOLVEPNP_ITERATIVE, InputArray rvec=noArray(), InputArray tvec=noArray(), OutputArray reprojectionError=noArray()) |
| Finds an object pose from 3D-2D point correspondences. More...
|
|
CV_EXPORTS_W Mat | initCameraMatrix2D (InputArrayOfArrays objectPoints, InputArrayOfArrays imagePoints, Size imageSize, double aspectRatio=1.0) |
| Finds an initial camera intrinsic matrix from 3D-2D point correspondences. More...
|
|
CV_EXPORTS_W bool | findChessboardCorners (InputArray image, Size patternSize, OutputArray corners, int flags=CALIB_CB_ADAPTIVE_THRESH+CALIB_CB_NORMALIZE_IMAGE) |
| Finds the positions of internal corners of the chessboard. More...
|
|
CV_EXPORTS_W bool | checkChessboard (InputArray img, Size size) |
|
bool | findChessboardCornersSB (InputArray image, Size patternSize, OutputArray corners, int flags, OutputArray meta) |
| Finds the positions of internal corners of the chessboard using a sector based approach. More...
|
|
CV_EXPORTS_W bool | findChessboardCornersSB (InputArray image, Size patternSize, OutputArray corners, int flags=0) |
|
CV_EXPORTS_W Scalar | estimateChessboardSharpness (InputArray image, Size patternSize, InputArray corners, float rise_distance=0.8F, bool vertical=false, OutputArray sharpness=noArray()) |
| Estimates the sharpness of a detected chessboard. More...
|
|
CV_EXPORTS_W bool | find4QuadCornerSubpix (InputArray img, InputOutputArray corners, Size region_size) |
| finds subpixel-accurate positions of the chessboard corners More...
|
|
CV_EXPORTS_W void | drawChessboardCorners (InputOutputArray image, Size patternSize, InputArray corners, bool patternWasFound) |
| Renders the detected chessboard corners. More...
|
|
CV_EXPORTS_W void | drawFrameAxes (InputOutputArray image, InputArray cameraMatrix, InputArray distCoeffs, InputArray rvec, InputArray tvec, float length, int thickness=3) |
| Draw axes of the world/object coordinate system from pose estimation. More...
|
|
CV_EXPORTS_W bool | findCirclesGrid (InputArray image, Size patternSize, OutputArray centers, int flags, const Ptr< FeatureDetector > &blobDetector, const CirclesGridFinderParameters ¶meters) |
| Finds centers in the grid of circles. More...
|
|
CV_EXPORTS_W bool | findCirclesGrid (InputArray image, Size patternSize, OutputArray centers, int flags=CALIB_CB_SYMMETRIC_GRID, const Ptr< FeatureDetector > &blobDetector=SimpleBlobDetector::create()) |
|
| CV_EXPORTS_AS (calibrateCameraExtended) double calibrateCamera(InputArrayOfArrays objectPoints |
| Finds the camera intrinsic and extrinsic parameters from several views of a calibration pattern. More...
|
|
CV_EXPORTS_W double | calibrateCamera (InputArrayOfArrays objectPoints, InputArrayOfArrays imagePoints, Size imageSize, InputOutputArray cameraMatrix, InputOutputArray distCoeffs, OutputArrayOfArrays rvecs, OutputArrayOfArrays tvecs, int flags=0, TermCriteria criteria=TermCriteria(TermCriteria::COUNT+TermCriteria::EPS, 30, DBL_EPSILON)) |
|
| CV_EXPORTS_AS (calibrateCameraROExtended) double calibrateCameraRO(InputArrayOfArrays objectPoints |
| Finds the camera intrinsic and extrinsic parameters from several views of a calibration pattern. More...
|
|
CV_EXPORTS_W double | calibrateCameraRO (InputArrayOfArrays objectPoints, InputArrayOfArrays imagePoints, Size imageSize, int iFixedPoint, InputOutputArray cameraMatrix, InputOutputArray distCoeffs, OutputArrayOfArrays rvecs, OutputArrayOfArrays tvecs, OutputArray newObjPoints, int flags=0, TermCriteria criteria=TermCriteria(TermCriteria::COUNT+TermCriteria::EPS, 30, DBL_EPSILON)) |
|
CV_EXPORTS_W void | calibrationMatrixValues (InputArray cameraMatrix, Size imageSize, double apertureWidth, double apertureHeight, CV_OUT double &fovx, CV_OUT double &fovy, CV_OUT double &focalLength, CV_OUT Point2d &principalPoint, CV_OUT double &aspectRatio) |
| Computes useful camera characteristics from the camera intrinsic matrix. More...
|
|
| CV_EXPORTS_AS (stereoCalibrateExtended) double stereoCalibrate(InputArrayOfArrays objectPoints |
| Calibrates a stereo camera set up. This function finds the intrinsic parameters for each of the two cameras and the extrinsic parameters between the two cameras. More...
|
|
CV_EXPORTS_W double | stereoCalibrate (InputArrayOfArrays objectPoints, InputArrayOfArrays imagePoints1, InputArrayOfArrays imagePoints2, InputOutputArray cameraMatrix1, InputOutputArray distCoeffs1, InputOutputArray cameraMatrix2, InputOutputArray distCoeffs2, Size imageSize, OutputArray R, OutputArray T, OutputArray E, OutputArray F, int flags=CALIB_FIX_INTRINSIC, TermCriteria criteria=TermCriteria(TermCriteria::COUNT+TermCriteria::EPS, 30, 1e-6)) |
| This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More...
|
|
CV_EXPORTS_W double | stereoCalibrate (InputArrayOfArrays objectPoints, InputArrayOfArrays imagePoints1, InputArrayOfArrays imagePoints2, InputOutputArray cameraMatrix1, InputOutputArray distCoeffs1, InputOutputArray cameraMatrix2, InputOutputArray distCoeffs2, Size imageSize, InputOutputArray R, InputOutputArray T, OutputArray E, OutputArray F, OutputArray perViewErrors, int flags=CALIB_FIX_INTRINSIC, TermCriteria criteria=TermCriteria(TermCriteria::COUNT+TermCriteria::EPS, 30, 1e-6)) |
| This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More...
|
|
CV_EXPORTS_W void | stereoRectify (InputArray cameraMatrix1, InputArray distCoeffs1, InputArray cameraMatrix2, InputArray distCoeffs2, Size imageSize, InputArray R, InputArray T, OutputArray R1, OutputArray R2, OutputArray P1, OutputArray P2, OutputArray Q, int flags=CALIB_ZERO_DISPARITY, double alpha=-1, Size newImageSize=Size(), CV_OUT Rect *validPixROI1=0, CV_OUT Rect *validPixROI2=0) |
| Computes rectification transforms for each head of a calibrated stereo camera. More...
|
|
CV_EXPORTS_W bool | stereoRectifyUncalibrated (InputArray points1, InputArray points2, InputArray F, Size imgSize, OutputArray H1, OutputArray H2, double threshold=5) |
| Computes a rectification transform for an uncalibrated stereo camera. More...
|
|
CV_EXPORTS_W float | rectify3Collinear (InputArray cameraMatrix1, InputArray distCoeffs1, InputArray cameraMatrix2, InputArray distCoeffs2, InputArray cameraMatrix3, InputArray distCoeffs3, InputArrayOfArrays imgpt1, InputArrayOfArrays imgpt3, Size imageSize, InputArray R12, InputArray T12, InputArray R13, InputArray T13, OutputArray R1, OutputArray R2, OutputArray R3, OutputArray P1, OutputArray P2, OutputArray P3, OutputArray Q, double alpha, Size newImgSize, CV_OUT Rect *roi1, CV_OUT Rect *roi2, int flags) |
| computes the rectification transformations for 3-head camera, where all the heads are on the same line. More...
|
|
CV_EXPORTS_W Mat | getOptimalNewCameraMatrix (InputArray cameraMatrix, InputArray distCoeffs, Size imageSize, double alpha, Size newImgSize=Size(), CV_OUT Rect *validPixROI=0, bool centerPrincipalPoint=false) |
| Returns the new camera intrinsic matrix based on the free scaling parameter. More...
|
|
CV_EXPORTS_W void | calibrateHandEye (InputArrayOfArrays R_gripper2base, InputArrayOfArrays t_gripper2base, InputArrayOfArrays R_target2cam, InputArrayOfArrays t_target2cam, OutputArray R_cam2gripper, OutputArray t_cam2gripper, HandEyeCalibrationMethod method=CALIB_HAND_EYE_TSAI) |
| Computes Hand-Eye calibration: . More...
|
|
CV_EXPORTS_W void | calibrateRobotWorldHandEye (InputArrayOfArrays R_world2cam, InputArrayOfArrays t_world2cam, InputArrayOfArrays R_base2gripper, InputArrayOfArrays t_base2gripper, OutputArray R_base2world, OutputArray t_base2world, OutputArray R_gripper2cam, OutputArray t_gripper2cam, RobotWorldHandEyeCalibrationMethod method=CALIB_ROBOT_WORLD_HAND_EYE_SHAH) |
| Computes Robot-World/Hand-Eye calibration: and . More...
|
|
CV_EXPORTS_W void | convertPointsToHomogeneous (InputArray src, OutputArray dst) |
| Converts points from Euclidean to homogeneous space. More...
|
|
CV_EXPORTS_W void | convertPointsFromHomogeneous (InputArray src, OutputArray dst) |
| Converts points from homogeneous to Euclidean space. More...
|
|
CV_EXPORTS void | convertPointsHomogeneous (InputArray src, OutputArray dst) |
| Converts points to/from homogeneous coordinates. More...
|
|
CV_EXPORTS_W Mat | findFundamentalMat (InputArray points1, InputArray points2, int method, double ransacReprojThreshold, double confidence, int maxIters, OutputArray mask=noArray()) |
| Calculates a fundamental matrix from the corresponding points in two images. More...
|
|
CV_EXPORTS_W Mat | findFundamentalMat (InputArray points1, InputArray points2, int method=FM_RANSAC, double ransacReprojThreshold=3., double confidence=0.99, OutputArray mask=noArray()) |
|
CV_EXPORTS Mat | findFundamentalMat (InputArray points1, InputArray points2, OutputArray mask, int method=FM_RANSAC, double ransacReprojThreshold=3., double confidence=0.99) |
|
CV_EXPORTS_W Mat | findFundamentalMat (InputArray points1, InputArray points2, OutputArray mask, const UsacParams ¶ms) |
|
CV_EXPORTS_W Mat | findEssentialMat (InputArray points1, InputArray points2, InputArray cameraMatrix, int method=RANSAC, double prob=0.999, double threshold=1.0, int maxIters=1000, OutputArray mask=noArray()) |
| Calculates an essential matrix from the corresponding points in two images. More...
|
|
CV_EXPORTS Mat | findEssentialMat (InputArray points1, InputArray points2, InputArray cameraMatrix, int method, double prob, double threshold, OutputArray mask) |
|
CV_EXPORTS_W Mat | findEssentialMat (InputArray points1, InputArray points2, double focal=1.0, Point2d pp=Point2d(0, 0), int method=RANSAC, double prob=0.999, double threshold=1.0, int maxIters=1000, OutputArray mask=noArray()) |
|
CV_EXPORTS Mat | findEssentialMat (InputArray points1, InputArray points2, double focal, Point2d pp, int method, double prob, double threshold, OutputArray mask) |
|
CV_EXPORTS_W Mat | findEssentialMat (InputArray points1, InputArray points2, InputArray cameraMatrix1, InputArray distCoeffs1, InputArray cameraMatrix2, InputArray distCoeffs2, int method=RANSAC, double prob=0.999, double threshold=1.0, OutputArray mask=noArray()) |
| Calculates an essential matrix from the corresponding points in two images from potentially two different cameras. More...
|
|
CV_EXPORTS_W Mat | findEssentialMat (InputArray points1, InputArray points2, InputArray cameraMatrix1, InputArray cameraMatrix2, InputArray dist_coeff1, InputArray dist_coeff2, OutputArray mask, const UsacParams ¶ms) |
|
CV_EXPORTS_W void | decomposeEssentialMat (InputArray E, OutputArray R1, OutputArray R2, OutputArray t) |
| Decompose an essential matrix to possible rotations and translation. More...
|
|
CV_EXPORTS_W int | recoverPose (InputArray points1, InputArray points2, InputArray cameraMatrix1, InputArray distCoeffs1, InputArray cameraMatrix2, InputArray distCoeffs2, OutputArray E, OutputArray R, OutputArray t, int method=cv::RANSAC, double prob=0.999, double threshold=1.0, InputOutputArray mask=noArray()) |
| Recovers the relative camera rotation and the translation from corresponding points in two images from two different cameras, using cheirality check. Returns the number of inliers that pass the check. More...
|
|
CV_EXPORTS_W int | recoverPose (InputArray E, InputArray points1, InputArray points2, InputArray cameraMatrix, OutputArray R, OutputArray t, InputOutputArray mask=noArray()) |
| Recovers the relative camera rotation and the translation from an estimated essential matrix and the corresponding points in two images, using chirality check. Returns the number of inliers that pass the check. More...
|
|
CV_EXPORTS_W int | recoverPose (InputArray E, InputArray points1, InputArray points2, OutputArray R, OutputArray t, double focal=1.0, Point2d pp=Point2d(0, 0), InputOutputArray mask=noArray()) |
|
CV_EXPORTS_W int | recoverPose (InputArray E, InputArray points1, InputArray points2, InputArray cameraMatrix, OutputArray R, OutputArray t, double distanceThresh, InputOutputArray mask=noArray(), OutputArray triangulatedPoints=noArray()) |
|
CV_EXPORTS_W void | computeCorrespondEpilines (InputArray points, int whichImage, InputArray F, OutputArray lines) |
| For points in an image of a stereo pair, computes the corresponding epilines in the other image. More...
|
|
CV_EXPORTS_W void | triangulatePoints (InputArray projMatr1, InputArray projMatr2, InputArray projPoints1, InputArray projPoints2, OutputArray points4D) |
| This function reconstructs 3-dimensional points (in homogeneous coordinates) by using their observations with a stereo camera. More...
|
|
CV_EXPORTS_W void | correctMatches (InputArray F, InputArray points1, InputArray points2, OutputArray newPoints1, OutputArray newPoints2) |
| Refines coordinates of corresponding points. More...
|
|
CV_EXPORTS_W void | filterSpeckles (InputOutputArray img, double newVal, int maxSpeckleSize, double maxDiff, InputOutputArray buf=noArray()) |
| Filters off small noise blobs (speckles) in the disparity map. More...
|
|
CV_EXPORTS_W Rect | getValidDisparityROI (Rect roi1, Rect roi2, int minDisparity, int numberOfDisparities, int blockSize) |
| computes valid disparity ROI from the valid ROIs of the rectified images (that are returned by stereoRectify) More...
|
|
CV_EXPORTS_W void | validateDisparity (InputOutputArray disparity, InputArray cost, int minDisparity, int numberOfDisparities, int disp12MaxDisp=1) |
| validates disparity using the left-right check. The matrix "cost" should be computed by the stereo correspondence algorithm More...
|
|
CV_EXPORTS_W void | reprojectImageTo3D (InputArray disparity, OutputArray _3dImage, InputArray Q, bool handleMissingValues=false, int ddepth=-1) |
| Reprojects a disparity image to 3D space. More...
|
|
CV_EXPORTS_W double | sampsonDistance (InputArray pt1, InputArray pt2, InputArray F) |
| Calculates the Sampson Distance between two points. More...
|
|
CV_EXPORTS_W int | estimateAffine3D (InputArray src, InputArray dst, OutputArray out, OutputArray inliers, double ransacThreshold=3, double confidence=0.99) |
| Computes an optimal affine transformation between two 3D point sets. More...
|
|
CV_EXPORTS_W cv::Mat | estimateAffine3D (InputArray src, InputArray dst, CV_OUT double *scale=nullptr, bool force_rotation=true) |
| Computes an optimal affine transformation between two 3D point sets. More...
|
|
CV_EXPORTS_W int | estimateTranslation3D (InputArray src, InputArray dst, OutputArray out, OutputArray inliers, double ransacThreshold=3, double confidence=0.99) |
| Computes an optimal translation between two 3D point sets. More...
|
|
CV_EXPORTS_W cv::Mat | estimateAffine2D (InputArray from, InputArray to, OutputArray inliers=noArray(), int method=RANSAC, double ransacReprojThreshold=3, size_t maxIters=2000, double confidence=0.99, size_t refineIters=10) |
| Computes an optimal affine transformation between two 2D point sets. More...
|
|
CV_EXPORTS_W cv::Mat | estimateAffine2D (InputArray pts1, InputArray pts2, OutputArray inliers, const UsacParams ¶ms) |
|
CV_EXPORTS_W cv::Mat | estimateAffinePartial2D (InputArray from, InputArray to, OutputArray inliers=noArray(), int method=RANSAC, double ransacReprojThreshold=3, size_t maxIters=2000, double confidence=0.99, size_t refineIters=10) |
| Computes an optimal limited affine transformation with 4 degrees of freedom between two 2D point sets. More...
|
|
CV_EXPORTS_W int | decomposeHomographyMat (InputArray H, InputArray K, OutputArrayOfArrays rotations, OutputArrayOfArrays translations, OutputArrayOfArrays normals) |
| Decompose a homography matrix to rotation(s), translation(s) and plane normal(s). More...
|
|
CV_EXPORTS_W void | filterHomographyDecompByVisibleRefpoints (InputArrayOfArrays rotations, InputArrayOfArrays normals, InputArray beforePoints, InputArray afterPoints, OutputArray possibleSolutions, InputArray pointsMask=noArray()) |
| Filters homography decompositions based on additional information. More...
|
|
CV_EXPORTS_W void | undistort (InputArray src, OutputArray dst, InputArray cameraMatrix, InputArray distCoeffs, InputArray newCameraMatrix=noArray()) |
| Transforms an image to compensate for lens distortion. More...
|
|
CV_EXPORTS_W void | initUndistortRectifyMap (InputArray cameraMatrix, InputArray distCoeffs, InputArray R, InputArray newCameraMatrix, Size size, int m1type, OutputArray map1, OutputArray map2) |
| Computes the undistortion and rectification transformation map. More...
|
|
CV_EXPORTS_W void | initInverseRectificationMap (InputArray cameraMatrix, InputArray distCoeffs, InputArray R, InputArray newCameraMatrix, const Size &size, int m1type, OutputArray map1, OutputArray map2) |
| Computes the projection and inverse-rectification transformation map. In essense, this is the inverse of initUndistortRectifyMap to accomodate stereo-rectification of projectors ('inverse-cameras') in projector-camera pairs. More...
|
|
CV_EXPORTS float | initWideAngleProjMap (InputArray cameraMatrix, InputArray distCoeffs, Size imageSize, int destImageWidth, int m1type, OutputArray map1, OutputArray map2, enum UndistortTypes projType=PROJ_SPHERICAL_EQRECT, double alpha=0) |
| initializes maps for remap for wide-angle More...
|
|
static float | initWideAngleProjMap (InputArray cameraMatrix, InputArray distCoeffs, Size imageSize, int destImageWidth, int m1type, OutputArray map1, OutputArray map2, int projType, double alpha=0) |
|
CV_EXPORTS_W Mat | getDefaultNewCameraMatrix (InputArray cameraMatrix, Size imgsize=Size(), bool centerPrincipalPoint=false) |
| Returns the default new camera matrix. More...
|
|
CV_EXPORTS_W void | undistortPoints (InputArray src, OutputArray dst, InputArray cameraMatrix, InputArray distCoeffs, InputArray R=noArray(), InputArray P=noArray()) |
| Computes the ideal point coordinates from the observed point coordinates. More...
|
|
void | undistortPoints (InputArray src, OutputArray dst, InputArray cameraMatrix, InputArray distCoeffs, InputArray R, InputArray P, TermCriteria criteria) |
|
CV_EXPORTS_W void | undistortImagePoints (InputArray src, OutputArray dst, InputArray cameraMatrix, InputArray distCoeffs, TermCriteria=TermCriteria(TermCriteria::MAX_ITER+TermCriteria::EPS, 5, 0.01)) |
| Compute undistorted image points position. More...
|
|
CV_EXPORTS CV_NORETURN void | error (int _code, const String &_err, const char *_func, const char *_file, int _line) |
| Signals an error and raises the exception. More...
|
|
template<typename _Tp > |
_Tp | cv_abs (_Tp x) |
|
int | cv_abs (uchar x) |
|
int | cv_abs (schar x) |
|
int | cv_abs (ushort x) |
|
int | cv_abs (short x) |
|
template<typename _Tp , typename _AccTp > |
static _AccTp | normL2Sqr (const _Tp *a, int n) |
|
template<typename _Tp , typename _AccTp > |
static _AccTp | normL1 (const _Tp *a, int n) |
|
template<typename _Tp , typename _AccTp > |
static _AccTp | normInf (const _Tp *a, int n) |
|
template<typename _Tp , typename _AccTp > |
static _AccTp | normL2Sqr (const _Tp *a, const _Tp *b, int n) |
|
static float | normL2Sqr (const float *a, const float *b, int n) |
|
template<typename _Tp , typename _AccTp > |
static _AccTp | normL1 (const _Tp *a, const _Tp *b, int n) |
|
float | normL1 (const float *a, const float *b, int n) |
|
int | normL1 (const uchar *a, const uchar *b, int n) |
|
template<typename _Tp , typename _AccTp > |
static _AccTp | normInf (const _Tp *a, const _Tp *b, int n) |
|
CV_EXPORTS_W float | cubeRoot (float val) |
| Computes the cube root of an argument. More...
|
|
static double | cubeRoot (double val) |
|
CV_EXPORTS_W float | fastAtan2 (float y, float x) |
| Calculates the angle of a 2D vector in degrees. More...
|
|
CV_EXPORTS int | LU (float *A, size_t astep, int m, float *b, size_t bstep, int n) |
|
CV_EXPORTS int | LU (double *A, size_t astep, int m, double *b, size_t bstep, int n) |
|
CV_EXPORTS bool | Cholesky (float *A, size_t astep, int m, float *b, size_t bstep, int n) |
|
CV_EXPORTS bool | Cholesky (double *A, size_t astep, int m, double *b, size_t bstep, int n) |
|
CV_EXPORTS const char * | depthToString (int depth) |
|
CV_EXPORTS String | typeToString (int type) |
|
static uchar | abs (uchar a) |
|
static ushort | abs (ushort a) |
|
static unsigned | abs (unsigned a) |
|
static uint64 | abs (uint64 a) |
|
CV_EXPORTS void * | fastMalloc (size_t bufSize) |
| Allocates an aligned memory buffer. More...
|
|
CV_EXPORTS void | fastFree (void *ptr) |
| Deallocates a memory buffer. More...
|
|
static std::string | toLowerCase (const std::string &str) |
|
static std::string | toUpperCase (const std::string &str) |
|
template<typename _Tp , typename ... A1> |
static Ptr< _Tp > | makePtr (const A1 &... a1) |
|
template<typename _Tp > |
std::ostream & | operator<< (std::ostream &, const DualQuat< _Tp > &) |
|
template<typename T > |
DualQuat< T > | conjugate (const DualQuat< T > &dq) |
|
template<typename T > |
DualQuat< T > | inv (const DualQuat< T > &dq, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
DualQuat< T > | operator+ (const T a, const DualQuat< T > &q) |
|
template<typename T > |
DualQuat< T > | operator+ (const DualQuat< T > &q, const T a) |
|
template<typename T > |
DualQuat< T > | operator- (const DualQuat< T > &q, const T a) |
|
template<typename T > |
DualQuat< T > | operator- (const T a, const DualQuat< T > &q) |
|
template<typename T > |
DualQuat< T > | operator* (const T a, const DualQuat< T > &q) |
|
template<typename T > |
DualQuat< T > | operator* (const DualQuat< T > &q, const T a) |
|
template<typename T > |
std::ostream & | operator<< (std::ostream &os, const DualQuat< T > &q) |
|
template<typename T > |
DualQuat< T > | exp (const DualQuat< T > &dq) |
|
template<typename T > |
DualQuat< T > | log (const DualQuat< T > &dq, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
DualQuat< T > | power (const DualQuat< T > &dq, const T t, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
DualQuat< T > | power (const DualQuat< T > &p, const DualQuat< T > &q, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename _Tp , int _rows, int _cols, int _options, int _maxRows, int _maxCols> |
static void | eigen2cv (const Eigen::Matrix< _Tp, _rows, _cols, _options, _maxRows, _maxCols > &src, OutputArray dst) |
|
template<typename _Tp , int _rows, int _cols, int _options, int _maxRows, int _maxCols> |
static void | eigen2cv (const Eigen::Matrix< _Tp, _rows, _cols, _options, _maxRows, _maxCols > &src, Matx< _Tp, _rows, _cols > &dst) |
|
template<typename _Tp , int _rows, int _cols, int _options, int _maxRows, int _maxCols> |
static void | cv2eigen (const Mat &src, Eigen::Matrix< _Tp, _rows, _cols, _options, _maxRows, _maxCols > &dst) |
|
template<typename _Tp , int _rows, int _cols, int _options, int _maxRows, int _maxCols> |
static void | cv2eigen (const Matx< _Tp, _rows, _cols > &src, Eigen::Matrix< _Tp, _rows, _cols, _options, _maxRows, _maxCols > &dst) |
|
template<typename _Tp > |
static void | cv2eigen (const Mat &src, Eigen::Matrix< _Tp, Eigen::Dynamic, Eigen::Dynamic > &dst) |
|
template<typename _Tp , int _rows, int _cols> |
static void | cv2eigen (const Matx< _Tp, _rows, _cols > &src, Eigen::Matrix< _Tp, Eigen::Dynamic, Eigen::Dynamic > &dst) |
|
template<typename _Tp > |
static void | cv2eigen (const Mat &src, Eigen::Matrix< _Tp, Eigen::Dynamic, 1 > &dst) |
|
template<typename _Tp , int _rows> |
static void | cv2eigen (const Matx< _Tp, _rows, 1 > &src, Eigen::Matrix< _Tp, Eigen::Dynamic, 1 > &dst) |
|
template<typename _Tp > |
static void | cv2eigen (const Mat &src, Eigen::Matrix< _Tp, 1, Eigen::Dynamic > &dst) |
|
template<typename _Tp , int _cols> |
static void | cv2eigen (const Matx< _Tp, 1, _cols > &src, Eigen::Matrix< _Tp, 1, Eigen::Dynamic > &dst) |
|
| CV_INTRIN_DEF_TYPE_TRAITS (uchar, schar, uchar, uchar, ushort, unsigned, unsigned) |
|
| CV_INTRIN_DEF_TYPE_TRAITS (schar, schar, uchar, uchar, short, int, int) |
|
| CV_INTRIN_DEF_TYPE_TRAITS (ushort, short, ushort, ushort, unsigned, uint64, unsigned) |
|
| CV_INTRIN_DEF_TYPE_TRAITS (short, short, ushort, ushort, int, int64, int) |
|
| CV_INTRIN_DEF_TYPE_TRAITS_NO_Q_TYPE (unsigned, int, unsigned, unsigned, uint64, unsigned) |
|
| CV_INTRIN_DEF_TYPE_TRAITS_NO_Q_TYPE (int, int, unsigned, unsigned, int64, int) |
|
| CV_INTRIN_DEF_TYPE_TRAITS_NO_Q_TYPE (float, int, unsigned, float, double, float) |
|
| CV_INTRIN_DEF_TYPE_TRAITS_NO_Q_TYPE (uint64, int64, uint64, uint64, void, uint64) |
|
| CV_INTRIN_DEF_TYPE_TRAITS_NO_Q_TYPE (int64, int64, uint64, uint64, void, int64) |
|
| CV_INTRIN_DEF_TYPE_TRAITS_NO_Q_TYPE (double, int64, uint64, double, void, double) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator+ (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Add values. More...
|
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > & | operator+= (v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator- (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Subtract values. More...
|
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > & | operator-= (v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator* (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Multiply values. More...
|
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > & | operator*= (v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator/ (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Divide values. More...
|
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > & | operator/= (v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator& (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Bitwise AND. More...
|
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > & | operator&= (v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator| (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Bitwise OR. More...
|
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > & | operator|= (v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator^ (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Bitwise XOR. More...
|
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > & | operator^= (v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
|
template<typename _Tp , int n> |
CV_INLINE v_reg< _Tp, n > | operator~ (const v_reg< _Tp, n > &a) |
| Bitwise NOT. More...
|
|
| OPENCV_HAL_IMPL_MATH_FUNC (v_abs,(typename V_TypeTraits< _Tp >::abs_type) std::abs, typename V_TypeTraits< _Tp >::abs_type) static const unsigned char popCountTable[] |
| Square root of elements. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::abs_type, n > | v_popcount (const v_reg< _Tp, n > &a) |
| Count the 1 bits in the vector lanes and return result as corresponding unsigned type. More...
|
|
template<int n> |
v_reg< float, n > | v_not_nan (const v_reg< float, n > &a) |
| Less-than comparison. More...
|
|
template<int n> |
v_reg< double, n > | v_not_nan (const v_reg< double, n > &a) |
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::abs_type, n > | v_absdiff (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Add values without saturation. More...
|
|
template<int n> |
v_reg< float, n > | v_absdiff (const v_reg< float, n > &a, const v_reg< float, n > &b) |
|
template<int n> |
v_reg< double, n > | v_absdiff (const v_reg< double, n > &a, const v_reg< double, n > &b) |
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_absdiffs (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Saturating absolute difference. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_invsqrt (const v_reg< _Tp, n > &a) |
| Inversed square root. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_magnitude (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Magnitude. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_sqr_magnitude (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Square of the magnitude. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_fma (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< _Tp, n > &c) |
| Multiply and add. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_muladd (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< _Tp, n > &c) |
| A synonym for v_fma. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > | v_dotprod (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Dot product of elements. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > | v_dotprod (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > &c) |
| Dot product of elements. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > | v_dotprod_fast (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Fast Dot product of elements. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > | v_dotprod_fast (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > &c) |
| Fast Dot product of elements. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::q_type, n/4 > | v_dotprod_expand (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Dot product of elements and expand. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::q_type, n/4 > | v_dotprod_expand (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< typename V_TypeTraits< _Tp >::q_type, n/4 > &c) |
| Dot product of elements. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::q_type, n/4 > | v_dotprod_expand_fast (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Fast Dot product of elements and expand. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::q_type, n/4 > | v_dotprod_expand_fast (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< typename V_TypeTraits< _Tp >::q_type, n/4 > &c) |
| Fast Dot product of elements. More...
|
|
template<typename _Tp , int n> |
void | v_mul_expand (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > &c, v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > &d) |
| Multiply and expand. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_mul_hi (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Multiply and extract high part. More...
|
|
template<typename _Tp , int n> |
V_TypeTraits< _Tp >::sum_type | v_reduce_sum (const v_reg< _Tp, n > &a) |
| Element shift left among vector. More...
|
|
template<int n> |
v_reg< float, n > | v_reduce_sum4 (const v_reg< float, n > &a, const v_reg< float, n > &b, const v_reg< float, n > &c, const v_reg< float, n > &d) |
| Sums all elements of each input vector, returns the vector of sums. More...
|
|
template<typename _Tp , int n> |
V_TypeTraits< typename V_TypeTraits< _Tp >::abs_type >::sum_type | v_reduce_sad (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Sum absolute differences of values. More...
|
|
template<typename _Tp , int n> |
int | v_signmask (const v_reg< _Tp, n > &a) |
| Get negative values mask. More...
|
|
template<typename _Tp , int n> |
int | v_scan_forward (const v_reg< _Tp, n > &a) |
| Get first negative lane index. More...
|
|
template<typename _Tp , int n> |
bool | v_check_all (const v_reg< _Tp, n > &a) |
| Check if all packed values are less than zero. More...
|
|
template<typename _Tp , int n> |
bool | v_check_any (const v_reg< _Tp, n > &a) |
| Check if any of packed values is less than zero. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_select (const v_reg< _Tp, n > &mask, const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Per-element select (blend operation) More...
|
|
template<typename _Tp , int n> |
void | v_expand (const v_reg< _Tp, n > &a, v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > &b0, v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > &b1) |
| Expand values to the wider pack type. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > | v_expand_low (const v_reg< _Tp, n > &a) |
| Expand lower values to the wider pack type. More...
|
|
template<typename _Tp , int n> |
v_reg< typename V_TypeTraits< _Tp >::w_type, n/2 > | v_expand_high (const v_reg< _Tp, n > &a) |
| Expand higher values to the wider pack type. More...
|
|
template<typename _Tp , int n> |
void | v_zip (const v_reg< _Tp, n > &a0, const v_reg< _Tp, n > &a1, v_reg< _Tp, n > &b0, v_reg< _Tp, n > &b1) |
| Interleave two vectors. More...
|
|
template<typename _Tp > |
v_reg< _Tp, simd128_width/sizeof(_Tp)> | v_load (const _Tp *ptr) |
| Load register contents from memory. More...
|
|
template<typename _Tp > |
v_reg< _Tp, simd128_width/sizeof(_Tp)> | v_load_aligned (const _Tp *ptr) |
| Load register contents from memory (aligned) More...
|
|
template<typename _Tp > |
v_reg< _Tp, simd128_width/sizeof(_Tp)> | v_load_low (const _Tp *ptr) |
| Load 64-bits of data to lower part (high part is undefined). More...
|
|
template<typename _Tp > |
v_reg< _Tp, simd128_width/sizeof(_Tp)> | v_load_halves (const _Tp *loptr, const _Tp *hiptr) |
| Load register contents from two memory blocks. More...
|
|
template<typename _Tp > |
v_reg< typename V_TypeTraits< _Tp >::w_type, simd128_width/sizeof(typename V_TypeTraits< _Tp >::w_type)> | v_load_expand (const _Tp *ptr) |
| Load register contents from memory with double expand. More...
|
|
template<typename _Tp > |
v_reg< typename V_TypeTraits< _Tp >::q_type, simd128_width/sizeof(typename V_TypeTraits< _Tp >::q_type)> | v_load_expand_q (const _Tp *ptr) |
| Load register contents from memory with quad expand. More...
|
|
template<typename _Tp , int n> |
void | v_load_deinterleave (const _Tp *ptr, v_reg< _Tp, n > &a, v_reg< _Tp, n > &b) |
| Load and deinterleave (2 channels) More...
|
|
template<typename _Tp , int n> |
void | v_load_deinterleave (const _Tp *ptr, v_reg< _Tp, n > &a, v_reg< _Tp, n > &b, v_reg< _Tp, n > &c) |
| Load and deinterleave (3 channels) More...
|
|
template<typename _Tp , int n> |
void | v_load_deinterleave (const _Tp *ptr, v_reg< _Tp, n > &a, v_reg< _Tp, n > &b, v_reg< _Tp, n > &c, v_reg< _Tp, n > &d) |
| Load and deinterleave (4 channels) More...
|
|
template<typename _Tp , int n> |
void | v_store_interleave (_Tp *ptr, const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, hal::StoreMode=hal::STORE_UNALIGNED) |
| Interleave and store (2 channels) More...
|
|
template<typename _Tp , int n> |
void | v_store_interleave (_Tp *ptr, const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< _Tp, n > &c, hal::StoreMode=hal::STORE_UNALIGNED) |
| Interleave and store (3 channels) More...
|
|
template<typename _Tp , int n> |
void | v_store_interleave (_Tp *ptr, const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, const v_reg< _Tp, n > &c, const v_reg< _Tp, n > &d, hal::StoreMode=hal::STORE_UNALIGNED) |
| Interleave and store (4 channels) More...
|
|
template<typename _Tp , int n> |
void | v_store (_Tp *ptr, const v_reg< _Tp, n > &a) |
| Store data to memory. More...
|
|
template<typename _Tp , int n> |
void | v_store (_Tp *ptr, const v_reg< _Tp, n > &a, hal::StoreMode) |
|
template<typename _Tp , int n> |
void | v_store_low (_Tp *ptr, const v_reg< _Tp, n > &a) |
| Store data to memory (lower half) More...
|
|
template<typename _Tp , int n> |
void | v_store_high (_Tp *ptr, const v_reg< _Tp, n > &a) |
| Store data to memory (higher half) More...
|
|
template<typename _Tp , int n> |
void | v_store_aligned (_Tp *ptr, const v_reg< _Tp, n > &a) |
| Store data to memory (aligned) More...
|
|
template<typename _Tp , int n> |
void | v_store_aligned_nocache (_Tp *ptr, const v_reg< _Tp, n > &a) |
|
template<typename _Tp , int n> |
void | v_store_aligned (_Tp *ptr, const v_reg< _Tp, n > &a, hal::StoreMode) |
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_combine_low (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Combine vector from first elements of two vectors. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_combine_high (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Combine vector from last elements of two vectors. More...
|
|
template<typename _Tp , int n> |
void | v_recombine (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b, v_reg< _Tp, n > &low, v_reg< _Tp, n > &high) |
| Combine two vectors from lower and higher parts of two other vectors. More...
|
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_reverse (const v_reg< _Tp, n > &a) |
| Vector reverse order. More...
|
|
template<int s, typename _Tp , int n> |
v_reg< _Tp, n > | v_extract (const v_reg< _Tp, n > &a, const v_reg< _Tp, n > &b) |
| Vector extract. More...
|
|
template<int s, typename _Tp , int n> |
_Tp | v_extract_n (const v_reg< _Tp, n > &v) |
| Vector extract. More...
|
|
template<int i, typename _Tp , int n> |
v_reg< _Tp, n > | v_broadcast_element (const v_reg< _Tp, n > &a) |
| Broadcast i-th element of vector. More...
|
|
template<int n> |
v_reg< int, n > | v_round (const v_reg< float, n > &a) |
| Round elements. More...
|
|
template<int n> |
v_reg< int, n *2 > | v_round (const v_reg< double, n > &a, const v_reg< double, n > &b) |
|
template<int n> |
v_reg< int, n > | v_floor (const v_reg< float, n > &a) |
| Floor elements. More...
|
|
template<int n> |
v_reg< int, n > | v_ceil (const v_reg< float, n > &a) |
| Ceil elements. More...
|
|
template<int n> |
v_reg< int, n > | v_trunc (const v_reg< float, n > &a) |
| Truncate elements. More...
|
|
template<int n> |
v_reg< int, n *2 > | v_round (const v_reg< double, n > &a) |
|
template<int n> |
v_reg< int, n *2 > | v_floor (const v_reg< double, n > &a) |
|
template<int n> |
v_reg< int, n *2 > | v_ceil (const v_reg< double, n > &a) |
|
template<int n> |
v_reg< int, n *2 > | v_trunc (const v_reg< double, n > &a) |
|
template<int n> |
v_reg< float, n > | v_cvt_f32 (const v_reg< int, n > &a) |
| Convert to float. More...
|
|
template<int n> |
v_reg< float, n *2 > | v_cvt_f32 (const v_reg< double, n > &a) |
| Convert lower half to float. More...
|
|
template<int n> |
v_reg< float, n *2 > | v_cvt_f32 (const v_reg< double, n > &a, const v_reg< double, n > &b) |
| Convert to float. More...
|
|
template<int n> |
CV_INLINE v_reg< double, n/2 > | v_cvt_f64 (const v_reg< int, n > &a) |
| Convert lower half to double. More...
|
|
template<int n> |
CV_INLINE v_reg< double,(n/2)> | v_cvt_f64_high (const v_reg< int, n > &a) |
| Convert to double high part of vector. More...
|
|
template<int n> |
CV_INLINE v_reg< double,(n/2)> | v_cvt_f64 (const v_reg< float, n > &a) |
| Convert lower half to double. More...
|
|
template<int n> |
CV_INLINE v_reg< double,(n/2)> | v_cvt_f64_high (const v_reg< float, n > &a) |
| Convert to double high part of vector. More...
|
|
template<int n> |
CV_INLINE v_reg< double, n > | v_cvt_f64 (const v_reg< int64, n > &a) |
| Convert to double. More...
|
|
template<typename _Tp > |
v_reg< _Tp, simd128_width/sizeof(_Tp)> | v_lut (const _Tp *tab, const int *idx) |
|
template<typename _Tp > |
v_reg< _Tp, simd128_width/sizeof(_Tp)> | v_lut_pairs (const _Tp *tab, const int *idx) |
|
template<typename _Tp > |
v_reg< _Tp, simd128_width/sizeof(_Tp)> | v_lut_quads (const _Tp *tab, const int *idx) |
|
template<int n> |
v_reg< int, n > | v_lut (const int *tab, const v_reg< int, n > &idx) |
|
template<int n> |
v_reg< unsigned, n > | v_lut (const unsigned *tab, const v_reg< int, n > &idx) |
|
template<int n> |
v_reg< float, n > | v_lut (const float *tab, const v_reg< int, n > &idx) |
|
template<int n> |
v_reg< double, n/2 > | v_lut (const double *tab, const v_reg< int, n > &idx) |
|
template<int n> |
void | v_lut_deinterleave (const float *tab, const v_reg< int, n > &idx, v_reg< float, n > &x, v_reg< float, n > &y) |
|
template<int n> |
void | v_lut_deinterleave (const double *tab, const v_reg< int, n *2 > &idx, v_reg< double, n > &x, v_reg< double, n > &y) |
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_interleave_pairs (const v_reg< _Tp, n > &vec) |
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_interleave_quads (const v_reg< _Tp, n > &vec) |
|
template<typename _Tp , int n> |
v_reg< _Tp, n > | v_pack_triplets (const v_reg< _Tp, n > &vec) |
|
template<typename _Tp , int n> |
void | v_transpose4x4 (v_reg< _Tp, n > &a0, const v_reg< _Tp, n > &a1, const v_reg< _Tp, n > &a2, const v_reg< _Tp, n > &a3, v_reg< _Tp, n > &b0, v_reg< _Tp, n > &b1, v_reg< _Tp, n > &b2, v_reg< _Tp, n > &b3) |
| Transpose 4x4 matrix. More...
|
|
template<int n> |
v_reg< float, n > | v_matmul (const v_reg< float, n > &v, const v_reg< float, n > &a, const v_reg< float, n > &b, const v_reg< float, n > &c, const v_reg< float, n > &d) |
| Matrix multiplication. More...
|
|
template<int n> |
v_reg< float, n > | v_matmuladd (const v_reg< float, n > &v, const v_reg< float, n > &a, const v_reg< float, n > &b, const v_reg< float, n > &c, const v_reg< float, n > &d) |
| Matrix multiplication and add. More...
|
|
template<int n> |
v_reg< double, n/2 > | v_dotprod_expand (const v_reg< int, n > &a, const v_reg< int, n > &b) |
|
template<int n> |
v_reg< double, n/2 > | v_dotprod_expand (const v_reg< int, n > &a, const v_reg< int, n > &b, const v_reg< double, n/2 > &c) |
|
template<int n> |
v_reg< double, n/2 > | v_dotprod_expand_fast (const v_reg< int, n > &a, const v_reg< int, n > &b) |
|
template<int n> |
v_reg< double, n/2 > | v_dotprod_expand_fast (const v_reg< int, n > &a, const v_reg< int, n > &b, const v_reg< double, n/2 > &c) |
|
v_reg< float, simd128_width/sizeof(float)> | v_load_expand (const hfloat *ptr) |
|
template<int n> |
void | v_pack_store (hfloat *ptr, const v_reg< float, n > &v) |
|
void | v_cleanup () |
|
template<typename _Tp > |
static _InputArray | rawIn (_Tp &v) |
|
template<typename _Tp > |
static _OutputArray | rawOut (_Tp &v) |
|
template<typename _Tp > |
static _InputOutputArray | rawInOut (_Tp &v) |
|
CV_EXPORTS InputOutputArray | noArray () |
|
static CV__DEBUG_NS_BEGIN void | swap (MatExpr &a, MatExpr &b) |
|
template<typename _Tp , int m> |
static double | determinant (const Matx< _Tp, m, m > &a) |
|
template<typename _Tp , int m, int n> |
static double | trace (const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static double | norm (const Matx< _Tp, m, n > &M) |
|
template<typename _Tp , int m, int n> |
static double | norm (const Matx< _Tp, m, n > &M, int normType) |
|
template<typename _Tp1 , typename _Tp2 , int m, int n> |
static Matx< _Tp1, m, n > & | operator+= (Matx< _Tp1, m, n > &a, const Matx< _Tp2, m, n > &b) |
|
template<typename _Tp1 , typename _Tp2 , int m, int n> |
static Matx< _Tp1, m, n > & | operator-= (Matx< _Tp1, m, n > &a, const Matx< _Tp2, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator+ (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator- (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator*= (Matx< _Tp, m, n > &a, int alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator*= (Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator*= (Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, n > &a, int alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (int alpha, const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (float alpha, const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (double alpha, const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator/= (Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator/= (Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator/ (const Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator/ (const Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator- (const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n, int l> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, l > &a, const Matx< _Tp, l, n > &b) |
|
template<typename _Tp , int m, int n> |
static Vec< _Tp, m > | operator* (const Matx< _Tp, m, n > &a, const Vec< _Tp, n > &b) |
|
template<typename _Tp , int m, int n> |
static bool | operator== (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static bool | operator!= (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , int cn> |
Vec< _Tp, cn > | normalize (const Vec< _Tp, cn > &v) |
|
template<typename _Tp1 , typename _Tp2 , int cn> |
static Vec< _Tp1, cn > & | operator+= (Vec< _Tp1, cn > &a, const Vec< _Tp2, cn > &b) |
|
template<typename _Tp1 , typename _Tp2 , int cn> |
static Vec< _Tp1, cn > & | operator-= (Vec< _Tp1, cn > &a, const Vec< _Tp2, cn > &b) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator+ (const Vec< _Tp, cn > &a, const Vec< _Tp, cn > &b) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator- (const Vec< _Tp, cn > &a, const Vec< _Tp, cn > &b) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator*= (Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator*= (Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator*= (Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator/= (Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator/= (Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator/= (Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (const Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (int alpha, const Vec< _Tp, cn > &a) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (const Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (float alpha, const Vec< _Tp, cn > &a) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (const Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (double alpha, const Vec< _Tp, cn > &a) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator/ (const Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator/ (const Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator/ (const Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator- (const Vec< _Tp, cn > &a) |
|
template<typename _Tp > |
Vec< _Tp, 4 > | operator* (const Vec< _Tp, 4 > &v1, const Vec< _Tp, 4 > &v2) |
|
template<typename _Tp > |
Vec< _Tp, 4 > & | operator*= (Vec< _Tp, 4 > &v1, const Vec< _Tp, 4 > &v2) |
|
template<typename _Tp , typename _T2 , int m, int n> |
static MatxCommaInitializer< _Tp, m, n > | operator<< (const Matx< _Tp, m, n > &mtx, _T2 val) |
|
template<typename _Tp , int m> |
static double | determinant (const Matx< _Tp, m, m > &a) |
|
template<typename _Tp , int m, int n> |
static double | trace (const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static double | norm (const Matx< _Tp, m, n > &M) |
|
template<typename _Tp , int m, int n> |
static double | norm (const Matx< _Tp, m, n > &M, int normType) |
|
template<typename _Tp1 , typename _Tp2 , int m, int n> |
static Matx< _Tp1, m, n > & | operator+= (Matx< _Tp1, m, n > &a, const Matx< _Tp2, m, n > &b) |
|
template<typename _Tp1 , typename _Tp2 , int m, int n> |
static Matx< _Tp1, m, n > & | operator-= (Matx< _Tp1, m, n > &a, const Matx< _Tp2, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator+ (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator- (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator*= (Matx< _Tp, m, n > &a, int alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator*= (Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator*= (Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, n > &a, int alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (int alpha, const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (float alpha, const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator* (double alpha, const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator/= (Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > & | operator/= (Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator/ (const Matx< _Tp, m, n > &a, float alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator/ (const Matx< _Tp, m, n > &a, double alpha) |
|
template<typename _Tp , int m, int n> |
static Matx< _Tp, m, n > | operator- (const Matx< _Tp, m, n > &a) |
|
template<typename _Tp , int m, int n, int l> |
static Matx< _Tp, m, n > | operator* (const Matx< _Tp, m, l > &a, const Matx< _Tp, l, n > &b) |
|
template<typename _Tp , int m, int n> |
static Vec< _Tp, m > | operator* (const Matx< _Tp, m, n > &a, const Vec< _Tp, n > &b) |
|
template<typename _Tp , int m, int n> |
static bool | operator== (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , int m, int n> |
static bool | operator!= (const Matx< _Tp, m, n > &a, const Matx< _Tp, m, n > &b) |
|
template<typename _Tp , typename _T2 , int cn> |
static VecCommaInitializer< _Tp, cn > | operator<< (const Vec< _Tp, cn > &vec, _T2 val) |
|
template<typename _Tp1 , typename _Tp2 , int cn> |
static Vec< _Tp1, cn > & | operator+= (Vec< _Tp1, cn > &a, const Vec< _Tp2, cn > &b) |
|
template<typename _Tp1 , typename _Tp2 , int cn> |
static Vec< _Tp1, cn > & | operator-= (Vec< _Tp1, cn > &a, const Vec< _Tp2, cn > &b) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator+ (const Vec< _Tp, cn > &a, const Vec< _Tp, cn > &b) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator- (const Vec< _Tp, cn > &a, const Vec< _Tp, cn > &b) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator*= (Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator*= (Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator*= (Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator/= (Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator/= (Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > & | operator/= (Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (const Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (int alpha, const Vec< _Tp, cn > &a) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (const Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (float alpha, const Vec< _Tp, cn > &a) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (const Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator* (double alpha, const Vec< _Tp, cn > &a) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator/ (const Vec< _Tp, cn > &a, int alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator/ (const Vec< _Tp, cn > &a, float alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator/ (const Vec< _Tp, cn > &a, double alpha) |
|
template<typename _Tp , int cn> |
static Vec< _Tp, cn > | operator- (const Vec< _Tp, cn > &a) |
|
static void | dumpOpenCLInformation () |
|
CV_EXPORTS String | format (const char *fmt,...) CV_FORMAT_PRINTF(1 |
| Returns a text string formatted using the printf-like expression. More...
|
|
template<typename _Tp , class _EqPredicate > |
CV_EXPORTS String int | partition (const std::vector< _Tp > &_vec, std::vector< int > &labels, _EqPredicate predicate=_EqPredicate()) |
| Splits an element set into equivalency classes. More...
|
|
CV_EXPORTS_W int | solveLP (InputArray Func, InputArray Constr, OutputArray z, double constr_eps) |
| Solve given (non-integer) linear programming problem using the Simplex Algorithm (Simplex Method). More...
|
|
CV_EXPORTS_W int | solveLP (InputArray Func, InputArray Constr, OutputArray z) |
|
CV_EXPORTS_W bool | haveOpenVX () |
| Check if use of OpenVX is possible. More...
|
|
CV_EXPORTS_W bool | useOpenVX () |
| Check if use of OpenVX is enabled. More...
|
|
CV_EXPORTS_W void | setUseOpenVX (bool flag) |
| Enable/disable use of OpenVX. More...
|
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, int value) |
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, float value) |
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, double value) |
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, const String &value) |
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, const Mat &value) |
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, const SparseMat &value) |
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, const std::vector< KeyPoint > &value) |
|
CV_EXPORTS void | write (FileStorage &fs, const String &name, const std::vector< DMatch > &value) |
|
CV_EXPORTS void | writeScalar (FileStorage &fs, int value) |
|
CV_EXPORTS void | writeScalar (FileStorage &fs, float value) |
|
CV_EXPORTS void | writeScalar (FileStorage &fs, double value) |
|
CV_EXPORTS void | writeScalar (FileStorage &fs, const String &value) |
|
CV_EXPORTS void | read (const FileNode &node, int &value, int default_value) |
|
CV_EXPORTS void | read (const FileNode &node, float &value, float default_value) |
|
CV_EXPORTS void | read (const FileNode &node, double &value, double default_value) |
|
CV_EXPORTS void | read (const FileNode &node, std::string &value, const std::string &default_value) |
|
CV_EXPORTS void | read (const FileNode &node, Mat &mat, const Mat &default_mat=Mat()) |
|
CV_EXPORTS void | read (const FileNode &node, SparseMat &mat, const SparseMat &default_mat=SparseMat()) |
|
CV_EXPORTS void | read (const FileNode &node, std::vector< KeyPoint > &keypoints) |
|
CV_EXPORTS void | read (const FileNode &node, std::vector< DMatch > &matches) |
|
CV_EXPORTS void | read (const FileNode &node, KeyPoint &value, const KeyPoint &default_value) |
|
CV_EXPORTS void | read (const FileNode &node, DMatch &value, const DMatch &default_value) |
|
template<typename _Tp > |
static void | read (const FileNode &node, Point_< _Tp > &value, const Point_< _Tp > &default_value) |
|
template<typename _Tp > |
static void | read (const FileNode &node, Point3_< _Tp > &value, const Point3_< _Tp > &default_value) |
|
template<typename _Tp > |
static void | read (const FileNode &node, Size_< _Tp > &value, const Size_< _Tp > &default_value) |
|
template<typename _Tp > |
static void | read (const FileNode &node, Complex< _Tp > &value, const Complex< _Tp > &default_value) |
|
template<typename _Tp > |
static void | read (const FileNode &node, Rect_< _Tp > &value, const Rect_< _Tp > &default_value) |
|
template<typename _Tp , int cn> |
static void | read (const FileNode &node, Vec< _Tp, cn > &value, const Vec< _Tp, cn > &default_value) |
|
template<typename _Tp , int m, int n> |
static void | read (const FileNode &node, Matx< _Tp, m, n > &value, const Matx< _Tp, m, n > &default_matx=Matx< _Tp, m, n >()) |
|
template<typename _Tp > |
static void | read (const FileNode &node, Scalar_< _Tp > &value, const Scalar_< _Tp > &default_value) |
|
static void | read (const FileNode &node, Range &value, const Range &default_value) |
|
CV_EXPORTS FileStorage & | operator<< (FileStorage &fs, const String &str) |
| Writes string to a file storage. More...
|
|
template<typename _Tp > |
static void | write (FileStorage &fs, const _Tp &value) |
|
template<> |
void | write (FileStorage &fs, const int &value) |
|
template<> |
void | write (FileStorage &fs, const float &value) |
|
template<> |
void | write (FileStorage &fs, const double &value) |
|
template<> |
void | write (FileStorage &fs, const String &value) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const Point_< _Tp > &pt) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const Point3_< _Tp > &pt) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const Size_< _Tp > &sz) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const Complex< _Tp > &c) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const Rect_< _Tp > &r) |
|
template<typename _Tp , int cn> |
static void | write (FileStorage &fs, const Vec< _Tp, cn > &v) |
|
template<typename _Tp , int m, int n> |
static void | write (FileStorage &fs, const Matx< _Tp, m, n > &x) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const Scalar_< _Tp > &s) |
|
static void | write (FileStorage &fs, const Range &r) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const std::vector< _Tp > &vec) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const Point_< _Tp > &pt) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const Point3_< _Tp > &pt) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const Size_< _Tp > &sz) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const Complex< _Tp > &c) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const Rect_< _Tp > &r) |
|
template<typename _Tp , int cn> |
static void | write (FileStorage &fs, const String &name, const Vec< _Tp, cn > &v) |
|
template<typename _Tp , int m, int n> |
static void | write (FileStorage &fs, const String &name, const Matx< _Tp, m, n > &x) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const Scalar_< _Tp > &s) |
|
static void | write (FileStorage &fs, const String &name, const Range &r) |
|
static void | write (FileStorage &fs, const String &name, const KeyPoint &kpt) |
|
static void | write (FileStorage &fs, const String &name, const DMatch &m) |
|
template<typename _Tp , typename std::enable_if< std::is_enum< _Tp >::value >::type * = nullptr> |
static void | write (FileStorage &fs, const String &name, const _Tp &val) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const std::vector< _Tp > &vec) |
|
template<typename _Tp > |
static void | write (FileStorage &fs, const String &name, const std::vector< std::vector< _Tp > > &vec) |
|
static void | write (FileStorage &fs, const KeyPoint &kpt) |
|
static void | write (FileStorage &fs, const DMatch &m) |
|
static void | write (FileStorage &fs, const std::vector< KeyPoint > &vec) |
|
static void | write (FileStorage &fs, const std::vector< DMatch > &vec) |
|
static void | read (const FileNode &node, bool &value, bool default_value) |
|
static void | read (const FileNode &node, uchar &value, uchar default_value) |
|
static void | read (const FileNode &node, schar &value, schar default_value) |
|
static void | read (const FileNode &node, ushort &value, ushort default_value) |
|
static void | read (const FileNode &node, short &value, short default_value) |
|
template<typename _Tp > |
static void | read (FileNodeIterator &it, std::vector< _Tp > &vec, size_t maxCount=(size_t) INT_MAX) |
|
template<typename _Tp , typename std::enable_if< std::is_enum< _Tp >::value >::type * = nullptr> |
static void | read (const FileNode &node, _Tp &value, const _Tp &default_value=static_cast< _Tp >(0)) |
|
template<typename _Tp > |
static void | read (const FileNode &node, std::vector< _Tp > &vec, const std::vector< _Tp > &default_value=std::vector< _Tp >()) |
|
static void | read (const FileNode &node, std::vector< KeyPoint > &vec, const std::vector< KeyPoint > &default_value) |
|
static void | read (const FileNode &node, std::vector< DMatch > &vec, const std::vector< DMatch > &default_value) |
|
template<typename _Tp > |
static FileStorage & | operator<< (FileStorage &fs, const _Tp &value) |
| Writes data to a file storage. More...
|
|
static FileStorage & | operator<< (FileStorage &fs, const char *str) |
| Writes data to a file storage. More...
|
|
static FileStorage & | operator<< (FileStorage &fs, char *value) |
| Writes data to a file storage. More...
|
|
template<typename _Tp > |
static FileNodeIterator & | operator>> (FileNodeIterator &it, _Tp &value) |
| Reads data from a file storage. More...
|
|
template<typename _Tp > |
static FileNodeIterator & | operator>> (FileNodeIterator &it, std::vector< _Tp > &vec) |
| Reads data from a file storage. More...
|
|
template<typename _Tp > |
static void | operator>> (const FileNode &n, _Tp &value) |
| Reads data from a file storage. More...
|
|
template<typename _Tp > |
static void | operator>> (const FileNode &n, std::vector< _Tp > &vec) |
| Reads data from a file storage. More...
|
|
static void | operator>> (const FileNode &n, KeyPoint &kpt) |
| Reads KeyPoint from a file storage. More...
|
|
static void | operator>> (const FileNode &n, std::vector< KeyPoint > &vec) |
|
static void | operator>> (const FileNode &n, std::vector< DMatch > &vec) |
|
static void | operator>> (const FileNode &n, DMatch &m) |
| Reads DMatch from a file storage. More...
|
|
CV_EXPORTS bool | operator== (const FileNodeIterator &it1, const FileNodeIterator &it2) |
|
CV_EXPORTS bool | operator!= (const FileNodeIterator &it1, const FileNodeIterator &it2) |
|
static ptrdiff_t | operator- (const FileNodeIterator &it1, const FileNodeIterator &it2) |
|
static bool | operator< (const FileNodeIterator &it1, const FileNodeIterator &it2) |
|
template<typename _Tp > |
std::ostream & | operator<< (std::ostream &, const Quat< _Tp > &) |
|
template<typename T > |
Quat< T > | inv (const Quat< T > &q, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
Quat< T > | sinh (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | cosh (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | tanh (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | sin (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | cos (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | tan (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | asinh (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | acosh (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | atanh (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | asin (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | acos (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | atan (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | power (const Quat< T > &q, const Quat< T > &p, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
Quat< T > | exp (const Quat< T > &q) |
|
template<typename T > |
Quat< T > | log (const Quat< T > &q, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
Quat< T > | power (const Quat< T > &q, const T x, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
Quat< T > | crossProduct (const Quat< T > &p, const Quat< T > &q) |
|
template<typename S > |
Quat< S > | sqrt (const Quat< S > &q, QuatAssumeType assumeUnit=QUAT_ASSUME_NOT_UNIT) |
|
template<typename T > |
Quat< T > | operator* (const T, const Quat< T > &) |
|
template<typename T > |
Quat< T > | operator* (const Quat< T > &, const T) |
|
template<typename S > |
std::ostream & | operator<< (std::ostream &, const Quat< S > &) |
|
template<typename _Tp > |
static _Tp | saturate_cast (uchar v) |
| Template function for accurate conversion from one primitive type to another. More...
|
|
template<typename _Tp > |
static _Tp | saturate_cast (schar v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (ushort v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (short v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (unsigned v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (int v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (float v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (double v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (int64 v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (uint64 v) |
|
template<> |
uchar | saturate_cast< uchar > (schar v) |
|
template<> |
uchar | saturate_cast< uchar > (ushort v) |
|
template<> |
uchar | saturate_cast< uchar > (int v) |
|
template<> |
uchar | saturate_cast< uchar > (short v) |
|
template<> |
uchar | saturate_cast< uchar > (unsigned v) |
|
template<> |
uchar | saturate_cast< uchar > (float v) |
|
template<> |
uchar | saturate_cast< uchar > (double v) |
|
template<> |
uchar | saturate_cast< uchar > (int64 v) |
|
template<> |
uchar | saturate_cast< uchar > (uint64 v) |
|
template<> |
schar | saturate_cast< schar > (uchar v) |
|
template<> |
schar | saturate_cast< schar > (ushort v) |
|
template<> |
schar | saturate_cast< schar > (int v) |
|
template<> |
schar | saturate_cast< schar > (short v) |
|
template<> |
schar | saturate_cast< schar > (unsigned v) |
|
template<> |
schar | saturate_cast< schar > (float v) |
|
template<> |
schar | saturate_cast< schar > (double v) |
|
template<> |
schar | saturate_cast< schar > (int64 v) |
|
template<> |
schar | saturate_cast< schar > (uint64 v) |
|
template<> |
ushort | saturate_cast< ushort > (schar v) |
|
template<> |
ushort | saturate_cast< ushort > (short v) |
|
template<> |
ushort | saturate_cast< ushort > (int v) |
|
template<> |
ushort | saturate_cast< ushort > (unsigned v) |
|
template<> |
ushort | saturate_cast< ushort > (float v) |
|
template<> |
ushort | saturate_cast< ushort > (double v) |
|
template<> |
ushort | saturate_cast< ushort > (int64 v) |
|
template<> |
ushort | saturate_cast< ushort > (uint64 v) |
|
template<> |
short | saturate_cast< short > (ushort v) |
|
template<> |
short | saturate_cast< short > (int v) |
|
template<> |
short | saturate_cast< short > (unsigned v) |
|
template<> |
short | saturate_cast< short > (float v) |
|
template<> |
short | saturate_cast< short > (double v) |
|
template<> |
short | saturate_cast< short > (int64 v) |
|
template<> |
short | saturate_cast< short > (uint64 v) |
|
template<> |
int | saturate_cast< int > (unsigned v) |
|
template<> |
int | saturate_cast< int > (int64 v) |
|
template<> |
int | saturate_cast< int > (uint64 v) |
|
template<> |
int | saturate_cast< int > (float v) |
|
template<> |
int | saturate_cast< int > (double v) |
|
template<> |
unsigned | saturate_cast< unsigned > (schar v) |
|
template<> |
unsigned | saturate_cast< unsigned > (short v) |
|
template<> |
unsigned | saturate_cast< unsigned > (int v) |
|
template<> |
unsigned | saturate_cast< unsigned > (int64 v) |
|
template<> |
unsigned | saturate_cast< unsigned > (uint64 v) |
|
template<> |
unsigned | saturate_cast< unsigned > (float v) |
|
template<> |
unsigned | saturate_cast< unsigned > (double v) |
|
template<> |
uint64 | saturate_cast< uint64 > (schar v) |
|
template<> |
uint64 | saturate_cast< uint64 > (short v) |
|
template<> |
uint64 | saturate_cast< uint64 > (int v) |
|
template<> |
uint64 | saturate_cast< uint64 > (int64 v) |
|
template<> |
int64 | saturate_cast< int64 > (uint64 v) |
|
template<typename _Tp > |
static _Tp | saturate_cast (hfloat v) |
|
template<> |
hfloat | saturate_cast< hfloat > (uchar v) |
|
template<> |
hfloat | saturate_cast< hfloat > (schar v) |
|
template<> |
hfloat | saturate_cast< hfloat > (ushort v) |
|
template<> |
hfloat | saturate_cast< hfloat > (short v) |
|
template<> |
hfloat | saturate_cast< hfloat > (unsigned v) |
|
template<> |
hfloat | saturate_cast< hfloat > (int v) |
|
template<> |
hfloat | saturate_cast< hfloat > (uint64 v) |
|
template<> |
hfloat | saturate_cast< hfloat > (int64 v) |
|
template<> |
hfloat | saturate_cast< hfloat > (float v) |
|
template<> |
hfloat | saturate_cast< hfloat > (double v) |
|
CV_EXPORTS softfloat | mulAdd (const softfloat &a, const softfloat &b, const softfloat &c) |
| Fused Multiplication and Addition. More...
|
|
CV_EXPORTS softdouble | mulAdd (const softdouble &a, const softdouble &b, const softdouble &c) |
|
CV_EXPORTS softfloat | sqrt (const softfloat &a) |
| Square root. More...
|
|
CV_EXPORTS softdouble | sqrt (const softdouble &a) |
|
template<typename _Tp > |
static _Tp | saturate_cast (softfloat a) |
| Saturate casts. More...
|
|
template<typename _Tp > |
static _Tp | saturate_cast (softdouble a) |
|
template<> |
uchar | saturate_cast< uchar > (softfloat a) |
|
template<> |
uchar | saturate_cast< uchar > (softdouble a) |
|
template<> |
schar | saturate_cast< schar > (softfloat a) |
|
template<> |
schar | saturate_cast< schar > (softdouble a) |
|
template<> |
ushort | saturate_cast< ushort > (softfloat a) |
|
template<> |
ushort | saturate_cast< ushort > (softdouble a) |
|
template<> |
short | saturate_cast< short > (softfloat a) |
|
template<> |
short | saturate_cast< short > (softdouble a) |
|
template<> |
int | saturate_cast< int > (softfloat a) |
|
template<> |
int | saturate_cast< int > (softdouble a) |
|
template<> |
int64_t | saturate_cast< int64_t > (softfloat a) |
|
template<> |
int64_t | saturate_cast< int64_t > (softdouble a) |
|
template<> |
unsigned | saturate_cast< unsigned > (softfloat a) |
| Saturate cast to unsigned integer and unsigned long long integer We intentionally do not clip negative numbers, to make -1 become 0xffffffff etc. More...
|
|
template<> |
unsigned | saturate_cast< unsigned > (softdouble a) |
|
template<> |
uint64_t | saturate_cast< uint64_t > (softfloat a) |
|
template<> |
uint64_t | saturate_cast< uint64_t > (softdouble a) |
|
softfloat | min (const softfloat &a, const softfloat &b) |
| Min and Max functions. More...
|
|
softdouble | min (const softdouble &a, const softdouble &b) |
|
softfloat | max (const softfloat &a, const softfloat &b) |
|
softdouble | max (const softdouble &a, const softdouble &b) |
|
softfloat | abs (softfloat a) |
| Absolute value. More...
|
|
softdouble | abs (softdouble a) |
|
CV_EXPORTS softfloat | exp (const softfloat &a) |
| Exponent. More...
|
|
CV_EXPORTS softdouble | exp (const softdouble &a) |
|
CV_EXPORTS softfloat | log (const softfloat &a) |
| Natural logarithm. More...
|
|
CV_EXPORTS softdouble | log (const softdouble &a) |
|
CV_EXPORTS softfloat | pow (const softfloat &a, const softfloat &b) |
| Raising to the power. More...
|
|
CV_EXPORTS softdouble | pow (const softdouble &a, const softdouble &b) |
|
CV_EXPORTS softfloat | cbrt (const softfloat &a) |
| Cube root. More...
|
|
CV_EXPORTS softdouble | sin (const softdouble &a) |
| Sine. More...
|
|
CV_EXPORTS softdouble | cos (const softdouble &a) |
| Cosine. More...
|
|
CV_EXPORTS bool | setBreakOnError (bool flag) |
| Sets/resets the break-on-error mode. More...
|
|
CV_EXPORTS ErrorCallback | redirectError (ErrorCallback errCallback, void *userdata=0, void **prevUserdata=0) |
| Sets the new error handler and the optional user data. More...
|
|
CV_EXPORTS String | tempfile (const char *suffix=0) |
|
CV_EXPORTS void | glob (String pattern, std::vector< String > &result, bool recursive=false) |
|
CV_EXPORTS_W void | setNumThreads (int nthreads) |
| OpenCV will try to set the number of threads for subsequent parallel regions. More...
|
|
CV_EXPORTS_W int | getNumThreads () |
| Returns the number of threads used by OpenCV for parallel regions. More...
|
|
CV_EXPORTS_W int | getThreadNum () |
| Returns the index of the currently executed thread within the current parallel region. Always returns 0 if called outside of parallel region. More...
|
|
CV_EXPORTS_W const String & | getBuildInformation () |
| Returns full configuration time cmake output. More...
|
|
CV_EXPORTS_W String | getVersionString () |
| Returns library version string. More...
|
|
CV_EXPORTS_W int | getVersionMajor () |
| Returns major library version. More...
|
|
CV_EXPORTS_W int | getVersionMinor () |
| Returns minor library version. More...
|
|
CV_EXPORTS_W int | getVersionRevision () |
| Returns revision field of the library version. More...
|
|
CV_EXPORTS_W int64 | getTickCount () |
| Returns the number of ticks. More...
|
|
CV_EXPORTS_W double | getTickFrequency () |
| Returns the number of ticks per second. More...
|
|
static std::ostream & | operator<< (std::ostream &out, const TickMeter &tm) |
| output operator More...
|
|
CV_EXPORTS_W int64 | getCPUTickCount () |
| Returns the number of CPU ticks. More...
|
|
CV_EXPORTS_W bool | checkHardwareSupport (int feature) |
| Returns true if the specified feature is supported by the host hardware. More...
|
|
CV_EXPORTS_W String | getHardwareFeatureName (int feature) |
| Returns feature name by ID. More...
|
|
CV_EXPORTS_W std::string | getCPUFeaturesLine () |
| Returns list of CPU features enabled during compilation. More...
|
|
CV_EXPORTS_W int | getNumberOfCPUs () |
| Returns the number of logical CPUs available for the process. More...
|
|
template<typename _Tp > |
static _Tp * | alignPtr (_Tp *ptr, int n=(int) sizeof(_Tp)) |
| Aligns a pointer to the specified number of bytes. More...
|
|
static size_t | alignSize (size_t sz, int n) |
| Aligns a buffer size to the specified number of bytes. More...
|
|
static int | divUp (int a, unsigned int b) |
| Integer division with result round up. More...
|
|
static size_t | divUp (size_t a, unsigned int b) |
|
static int | roundUp (int a, unsigned int b) |
| Round first value up to the nearest multiple of second value. More...
|
|
static size_t | roundUp (size_t a, unsigned int b) |
|
template<int N, typename T > |
static bool | isAligned (const T &data) |
| Alignment check of passed values. More...
|
|
template<int N> |
static bool | isAligned (const void *p1) |
|
template<int N> |
static bool | isAligned (const void *p1, const void *p2) |
|
template<int N> |
static bool | isAligned (const void *p1, const void *p2, const void *p3) |
|
template<int N> |
static bool | isAligned (const void *p1, const void *p2, const void *p3, const void *p4) |
|
CV_EXPORTS_W void | setUseOptimized (bool onoff) |
| Enables or disables the optimized code. More...
|
|
CV_EXPORTS_W bool | useOptimized () |
| Returns the status of optimized code usage. More...
|
|
static size_t | getElemSize (int type) |
|
CV_EXPORTS void | parallel_for_ (const Range &range, const ParallelLoopBody &body, double nstripes=-1.) |
| Parallel data processor. More...
|
|
static void | parallel_for_ (const Range &range, std::function< void(const Range &)> functor, double nstripes=-1.) |
|
CV_EXPORTS CV_NORETURN void | error (const Exception &exc) |
| Signals an error and raises the exception. More...
|
|
CV_EXPORTS void | swap (Mat &a, Mat &b) |
| Swaps two matrices. More...
|
|
CV_EXPORTS void | swap (UMat &a, UMat &b) |
|
CV_EXPORTS_W int | borderInterpolate (int p, int len, int borderType) |
| Computes the source location of an extrapolated pixel. More...
|
|
CV_EXPORTS_W void | copyMakeBorder (InputArray src, OutputArray dst, int top, int bottom, int left, int right, int borderType, const Scalar &value=Scalar()) |
| Forms a border around an image. More...
|
|
CV_EXPORTS_W void | add (InputArray src1, InputArray src2, OutputArray dst, InputArray mask=noArray(), int dtype=-1) |
| Calculates the per-element sum of two arrays or an array and a scalar. More...
|
|
CV_EXPORTS_W void | subtract (InputArray src1, InputArray src2, OutputArray dst, InputArray mask=noArray(), int dtype=-1) |
| Calculates the per-element difference between two arrays or array and a scalar. More...
|
|
CV_EXPORTS_W void | multiply (InputArray src1, InputArray src2, OutputArray dst, double scale=1, int dtype=-1) |
| Calculates the per-element scaled product of two arrays. More...
|
|
CV_EXPORTS_W void | divide (InputArray src1, InputArray src2, OutputArray dst, double scale=1, int dtype=-1) |
| Performs per-element division of two arrays or a scalar by an array. More...
|
|
CV_EXPORTS_W void | divide (double scale, InputArray src2, OutputArray dst, int dtype=-1) |
|
CV_EXPORTS_W void | scaleAdd (InputArray src1, double alpha, InputArray src2, OutputArray dst) |
| Calculates the sum of a scaled array and another array. More...
|
|
CV_EXPORTS_W void | addWeighted (InputArray src1, double alpha, InputArray src2, double beta, double gamma, OutputArray dst, int dtype=-1) |
| Calculates the weighted sum of two arrays. More...
|
|
CV_EXPORTS_W void | convertScaleAbs (InputArray src, OutputArray dst, double alpha=1, double beta=0) |
| Scales, calculates absolute values, and converts the result to 8-bit. More...
|
|
CV_EXPORTS_W void | convertFp16 (InputArray src, OutputArray dst) |
| Converts an array to half precision floating number. More...
|
|
CV_EXPORTS_W void | LUT (InputArray src, InputArray lut, OutputArray dst) |
| Performs a look-up table transform of an array. More...
|
|
| CV_EXPORTS_AS (sumElems) Scalar sum(InputArray src) |
| Calculates the sum of array elements. More...
|
|
CV_EXPORTS_W bool | hasNonZero (InputArray src) |
| Checks for the presence of at least one non-zero array element. More...
|
|
CV_EXPORTS_W int | countNonZero (InputArray src) |
| Counts non-zero array elements. More...
|
|
CV_EXPORTS_W void | findNonZero (InputArray src, OutputArray idx) |
| Returns the list of locations of non-zero pixels. More...
|
|
CV_EXPORTS_W Scalar | mean (InputArray src, InputArray mask=noArray()) |
| Calculates an average (mean) of array elements. More...
|
|
CV_EXPORTS_W void | meanStdDev (InputArray src, OutputArray mean, OutputArray stddev, InputArray mask=noArray()) |
|
CV_EXPORTS_W double | norm (InputArray src1, int normType=NORM_L2, InputArray mask=noArray()) |
| Calculates the absolute norm of an array. More...
|
|
CV_EXPORTS_W double | norm (InputArray src1, InputArray src2, int normType=NORM_L2, InputArray mask=noArray()) |
| Calculates an absolute difference norm or a relative difference norm. More...
|
|
CV_EXPORTS double | norm (const SparseMat &src, int normType) |
|
CV_EXPORTS_W double | PSNR (InputArray src1, InputArray src2, double R=255.) |
| Computes the Peak Signal-to-Noise Ratio (PSNR) image quality metric. More...
|
|
CV_EXPORTS_W void | batchDistance (InputArray src1, InputArray src2, OutputArray dist, int dtype, OutputArray nidx, int normType=NORM_L2, int K=0, InputArray mask=noArray(), int update=0, bool crosscheck=false) |
| naive nearest neighbor finder More...
|
|
CV_EXPORTS_W void | normalize (InputArray src, InputOutputArray dst, double alpha=1, double beta=0, int norm_type=NORM_L2, int dtype=-1, InputArray mask=noArray()) |
| Normalizes the norm or value range of an array. More...
|
|
CV_EXPORTS void | normalize (const SparseMat &src, SparseMat &dst, double alpha, int normType) |
|
CV_EXPORTS_W void | minMaxLoc (InputArray src, CV_OUT double *minVal, CV_OUT double *maxVal=0, CV_OUT Point *minLoc=0, CV_OUT Point *maxLoc=0, InputArray mask=noArray()) |
| Finds the global minimum and maximum in an array. More...
|
|
CV_EXPORTS_W void | reduceArgMin (InputArray src, OutputArray dst, int axis, bool lastIndex=false) |
| Finds indices of min elements along provided axis. More...
|
|
CV_EXPORTS_W void | reduceArgMax (InputArray src, OutputArray dst, int axis, bool lastIndex=false) |
| Finds indices of max elements along provided axis. More...
|
|
CV_EXPORTS void | minMaxIdx (InputArray src, double *minVal, double *maxVal=0, int *minIdx=0, int *maxIdx=0, InputArray mask=noArray()) |
| Finds the global minimum and maximum in an array. More...
|
|
CV_EXPORTS void | minMaxLoc (const SparseMat &a, double *minVal, double *maxVal, int *minIdx=0, int *maxIdx=0) |
|
CV_EXPORTS_W void | reduce (InputArray src, OutputArray dst, int dim, int rtype, int dtype=-1) |
| Reduces a matrix to a vector. More...
|
|
CV_EXPORTS void | merge (const Mat *mv, size_t count, OutputArray dst) |
| Creates one multi-channel array out of several single-channel ones. More...
|
|
CV_EXPORTS_W void | merge (InputArrayOfArrays mv, OutputArray dst) |
|
CV_EXPORTS void | split (const Mat &src, Mat *mvbegin) |
| Divides a multi-channel array into several single-channel arrays. More...
|
|
CV_EXPORTS_W void | split (InputArray m, OutputArrayOfArrays mv) |
|
CV_EXPORTS void | mixChannels (const Mat *src, size_t nsrcs, Mat *dst, size_t ndsts, const int *fromTo, size_t npairs) |
| Copies specified channels from input arrays to the specified channels of output arrays. More...
|
|
CV_EXPORTS void | mixChannels (InputArrayOfArrays src, InputOutputArrayOfArrays dst, const int *fromTo, size_t npairs) |
|
CV_EXPORTS_W void | mixChannels (InputArrayOfArrays src, InputOutputArrayOfArrays dst, const std::vector< int > &fromTo) |
|
CV_EXPORTS_W void | extractChannel (InputArray src, OutputArray dst, int coi) |
| Extracts a single channel from src (coi is 0-based index) More...
|
|
CV_EXPORTS_W void | insertChannel (InputArray src, InputOutputArray dst, int coi) |
| Inserts a single channel to dst (coi is 0-based index) More...
|
|
CV_EXPORTS_W void | flip (InputArray src, OutputArray dst, int flipCode) |
| Flips a 2D array around vertical, horizontal, or both axes. More...
|
|
CV_EXPORTS_W void | flipND (InputArray src, OutputArray dst, int axis) |
| Flips a n-dimensional at given axis. More...
|
|
CV_EXPORTS_W void | broadcast (InputArray src, InputArray shape, OutputArray dst) |
| Broadcast the given Mat to the given shape. More...
|
|
CV_EXPORTS_W void | rotate (InputArray src, OutputArray dst, int rotateCode) |
| Rotates a 2D array in multiples of 90 degrees. The function cv::rotate rotates the array in one of three different ways: Rotate by 90 degrees clockwise (rotateCode = ROTATE_90_CLOCKWISE). Rotate by 180 degrees clockwise (rotateCode = ROTATE_180). Rotate by 270 degrees clockwise (rotateCode = ROTATE_90_COUNTERCLOCKWISE). More...
|
|
CV_EXPORTS_W void | repeat (InputArray src, int ny, int nx, OutputArray dst) |
| Fills the output array with repeated copies of the input array. More...
|
|
CV_EXPORTS Mat | repeat (const Mat &src, int ny, int nx) |
|
CV_EXPORTS void | hconcat (const Mat *src, size_t nsrc, OutputArray dst) |
| Applies horizontal concatenation to given matrices. More...
|
|
CV_EXPORTS void | hconcat (InputArray src1, InputArray src2, OutputArray dst) |
|
CV_EXPORTS_W void | hconcat (InputArrayOfArrays src, OutputArray dst) |
|
CV_EXPORTS void | vconcat (const Mat *src, size_t nsrc, OutputArray dst) |
| Applies vertical concatenation to given matrices. More...
|
|
CV_EXPORTS void | vconcat (InputArray src1, InputArray src2, OutputArray dst) |
|
CV_EXPORTS_W void | vconcat (InputArrayOfArrays src, OutputArray dst) |
|
CV_EXPORTS_W void | bitwise_and (InputArray src1, InputArray src2, OutputArray dst, InputArray mask=noArray()) |
| computes bitwise conjunction of the two arrays (dst = src1 & src2) Calculates the per-element bit-wise conjunction of two arrays or an array and a scalar. More...
|
|
CV_EXPORTS_W void | bitwise_or (InputArray src1, InputArray src2, OutputArray dst, InputArray mask=noArray()) |
| Calculates the per-element bit-wise disjunction of two arrays or an array and a scalar. More...
|
|
CV_EXPORTS_W void | bitwise_xor (InputArray src1, InputArray src2, OutputArray dst, InputArray mask=noArray()) |
| Calculates the per-element bit-wise "exclusive or" operation on two arrays or an array and a scalar. More...
|
|
CV_EXPORTS_W void | bitwise_not (InputArray src, OutputArray dst, InputArray mask=noArray()) |
| Inverts every bit of an array. More...
|
|
CV_EXPORTS_W void | absdiff (InputArray src1, InputArray src2, OutputArray dst) |
| Calculates the per-element absolute difference between two arrays or between an array and a scalar. More...
|
|
void CV_EXPORTS_W | copyTo (InputArray src, OutputArray dst, InputArray mask) |
| This is an overloaded member function, provided for convenience (python) Copies the matrix to another one. When the operation mask is specified, if the Mat::create call shown above reallocates the matrix, the newly allocated matrix is initialized with all zeros before copying the data. More...
|
|
CV_EXPORTS_W void | inRange (InputArray src, InputArray lowerb, InputArray upperb, OutputArray dst) |
| Checks if array elements lie between the elements of two other arrays. More...
|
|
CV_EXPORTS_W void | compare (InputArray src1, InputArray src2, OutputArray dst, int cmpop) |
| Performs the per-element comparison of two arrays or an array and scalar value. More...
|
|
CV_EXPORTS_W void | min (InputArray src1, InputArray src2, OutputArray dst) |
| Calculates per-element minimum of two arrays or an array and a scalar. More...
|
|
CV_EXPORTS void | min (const Mat &src1, const Mat &src2, Mat &dst) |
|
CV_EXPORTS void | min (const UMat &src1, const UMat &src2, UMat &dst) |
|
CV_EXPORTS_W void | max (InputArray src1, InputArray src2, OutputArray dst) |
| Calculates per-element maximum of two arrays or an array and a scalar. More...
|
|
CV_EXPORTS void | max (const Mat &src1, const Mat &src2, Mat &dst) |
|
CV_EXPORTS void | max (const UMat &src1, const UMat &src2, UMat &dst) |
|
CV_EXPORTS_W void | sqrt (InputArray src, OutputArray dst) |
| Calculates a square root of array elements. More...
|
|
CV_EXPORTS_W void | pow (InputArray src, double power, OutputArray dst) |
| Raises every array element to a power. More...
|
|
CV_EXPORTS_W void | exp (InputArray src, OutputArray dst) |
| Calculates the exponent of every array element. More...
|
|
CV_EXPORTS_W void | log (InputArray src, OutputArray dst) |
| Calculates the natural logarithm of every array element. More...
|
|
CV_EXPORTS_W void | polarToCart (InputArray magnitude, InputArray angle, OutputArray x, OutputArray y, bool angleInDegrees=false) |
| Calculates x and y coordinates of 2D vectors from their magnitude and angle. More...
|
|
CV_EXPORTS_W void | cartToPolar (InputArray x, InputArray y, OutputArray magnitude, OutputArray angle, bool angleInDegrees=false) |
| Calculates the magnitude and angle of 2D vectors. More...
|
|
CV_EXPORTS_W void | phase (InputArray x, InputArray y, OutputArray angle, bool angleInDegrees=false) |
| Calculates the rotation angle of 2D vectors. More...
|
|
CV_EXPORTS_W void | magnitude (InputArray x, InputArray y, OutputArray magnitude) |
| Calculates the magnitude of 2D vectors. More...
|
|
CV_EXPORTS_W bool | checkRange (InputArray a, bool quiet=true, CV_OUT Point *pos=0, double minVal=-DBL_MAX, double maxVal=DBL_MAX) |
| Checks every element of an input array for invalid values. More...
|
|
CV_EXPORTS_W void | patchNaNs (InputOutputArray a, double val=0) |
| Replaces NaNs by given number. More...
|
|
CV_EXPORTS_W void | gemm (InputArray src1, InputArray src2, double alpha, InputArray src3, double beta, OutputArray dst, int flags=0) |
| Performs generalized matrix multiplication. More...
|
|
CV_EXPORTS_W void | mulTransposed (InputArray src, OutputArray dst, bool aTa, InputArray delta=noArray(), double scale=1, int dtype=-1) |
| Calculates the product of a matrix and its transposition. More...
|
|
CV_EXPORTS_W void | transpose (InputArray src, OutputArray dst) |
| Transposes a matrix. More...
|
|
CV_EXPORTS_W void | transposeND (InputArray src, const std::vector< int > &order, OutputArray dst) |
| Transpose for n-dimensional matrices. More...
|
|
CV_EXPORTS_W void | transform (InputArray src, OutputArray dst, InputArray m) |
| Performs the matrix transformation of every array element. More...
|
|
CV_EXPORTS_W void | perspectiveTransform (InputArray src, OutputArray dst, InputArray m) |
| Performs the perspective matrix transformation of vectors. More...
|
|
CV_EXPORTS_W void | completeSymm (InputOutputArray m, bool lowerToUpper=false) |
| Copies the lower or the upper half of a square matrix to its another half. More...
|
|
CV_EXPORTS_W void | setIdentity (InputOutputArray mtx, const Scalar &s=Scalar(1)) |
| Initializes a scaled identity matrix. More...
|
|
CV_EXPORTS_W double | determinant (InputArray mtx) |
| Returns the determinant of a square floating-point matrix. More...
|
|
CV_EXPORTS_W Scalar | trace (InputArray mtx) |
| Returns the trace of a matrix. More...
|
|
CV_EXPORTS_W double | invert (InputArray src, OutputArray dst, int flags=DECOMP_LU) |
| Finds the inverse or pseudo-inverse of a matrix. More...
|
|
CV_EXPORTS_W bool | solve (InputArray src1, InputArray src2, OutputArray dst, int flags=DECOMP_LU) |
| Solves one or more linear systems or least-squares problems. More...
|
|
CV_EXPORTS_W void | sort (InputArray src, OutputArray dst, int flags) |
| Sorts each row or each column of a matrix. More...
|
|
CV_EXPORTS_W void | sortIdx (InputArray src, OutputArray dst, int flags) |
| Sorts each row or each column of a matrix. More...
|
|
CV_EXPORTS_W int | solveCubic (InputArray coeffs, OutputArray roots) |
| Finds the real roots of a cubic equation. More...
|
|
CV_EXPORTS_W double | solvePoly (InputArray coeffs, OutputArray roots, int maxIters=300) |
| Finds the real or complex roots of a polynomial equation. More...
|
|
CV_EXPORTS_W bool | eigen (InputArray src, OutputArray eigenvalues, OutputArray eigenvectors=noArray()) |
| Calculates eigenvalues and eigenvectors of a symmetric matrix. More...
|
|
CV_EXPORTS_W void | eigenNonSymmetric (InputArray src, OutputArray eigenvalues, OutputArray eigenvectors) |
| Calculates eigenvalues and eigenvectors of a non-symmetric matrix (real eigenvalues only). More...
|
|
CV_EXPORTS void | calcCovarMatrix (const Mat *samples, int nsamples, Mat &covar, Mat &mean, int flags, int ctype=CV_64F) |
| Calculates the covariance matrix of a set of vectors. More...
|
|
CV_EXPORTS_W void | calcCovarMatrix (InputArray samples, OutputArray covar, InputOutputArray mean, int flags, int ctype=CV_64F) |
|
CV_EXPORTS_W void | PCACompute (InputArray data, InputOutputArray mean, OutputArray eigenvectors, int maxComponents=0) |
|
| CV_EXPORTS_AS (PCACompute2) void PCACompute(InputArray data |
|
CV_EXPORTS_W void | PCACompute (InputArray data, InputOutputArray mean, OutputArray eigenvectors, double retainedVariance) |
|
CV_EXPORTS_W void | PCAProject (InputArray data, InputArray mean, InputArray eigenvectors, OutputArray result) |
|
CV_EXPORTS_W void | PCABackProject (InputArray data, InputArray mean, InputArray eigenvectors, OutputArray result) |
|
CV_EXPORTS_W void | SVDecomp (InputArray src, OutputArray w, OutputArray u, OutputArray vt, int flags=0) |
|
CV_EXPORTS_W void | SVBackSubst (InputArray w, InputArray u, InputArray vt, InputArray rhs, OutputArray dst) |
|
CV_EXPORTS_W double | Mahalanobis (InputArray v1, InputArray v2, InputArray icovar) |
| Calculates the Mahalanobis distance between two vectors. More...
|
|
CV_EXPORTS_W void | dft (InputArray src, OutputArray dst, int flags=0, int nonzeroRows=0) |
| Performs a forward or inverse Discrete Fourier transform of a 1D or 2D floating-point array. More...
|
|
CV_EXPORTS_W void | idft (InputArray src, OutputArray dst, int flags=0, int nonzeroRows=0) |
| Calculates the inverse Discrete Fourier Transform of a 1D or 2D array. More...
|
|
CV_EXPORTS_W void | dct (InputArray src, OutputArray dst, int flags=0) |
| Performs a forward or inverse discrete Cosine transform of 1D or 2D array. More...
|
|
CV_EXPORTS_W void | idct (InputArray src, OutputArray dst, int flags=0) |
| Calculates the inverse Discrete Cosine Transform of a 1D or 2D array. More...
|
|
CV_EXPORTS_W void | mulSpectrums (InputArray a, InputArray b, OutputArray c, int flags, bool conjB=false) |
| Performs the per-element multiplication of two Fourier spectrums. More...
|
|
CV_EXPORTS_W int | getOptimalDFTSize (int vecsize) |
| Returns the optimal DFT size for a given vector size. More...
|
|
CV_EXPORTS RNG & | theRNG () |
| Returns the default random number generator. More...
|
|
CV_EXPORTS_W void | setRNGSeed (int seed) |
| Sets state of default random number generator. More...
|
|
CV_EXPORTS_W void | randu (InputOutputArray dst, InputArray low, InputArray high) |
| Generates a single uniformly-distributed random number or an array of random numbers. More...
|
|
CV_EXPORTS_W void | randn (InputOutputArray dst, InputArray mean, InputArray stddev) |
| Fills the array with normally distributed random numbers. More...
|
|
CV_EXPORTS_W void | randShuffle (InputOutputArray dst, double iterFactor=1., RNG *rng=0) |
| Shuffles the array elements randomly. More...
|
|
CV_EXPORTS_W double | kmeans (InputArray data, int K, InputOutputArray bestLabels, TermCriteria criteria, int attempts, int flags, OutputArray centers=noArray()) |
| Finds centers of clusters and groups input samples around the clusters. More...
|
|
static String & | operator<< (String &out, Ptr< Formatted > fmtd) |
|
static String & | operator<< (String &out, const Mat &mtx) |
|
CV_EXPORTS void | FAST (InputArray image, CV_OUT std::vector< KeyPoint > &keypoints, int threshold, bool nonmaxSuppression=true) |
|
CV_EXPORTS void | FAST (InputArray image, CV_OUT std::vector< KeyPoint > &keypoints, int threshold, bool nonmaxSuppression, FastFeatureDetector::DetectorType type) |
| Detects corners using the FAST algorithm. More...
|
|
CV_EXPORTS void | AGAST (InputArray image, CV_OUT std::vector< KeyPoint > &keypoints, int threshold, bool nonmaxSuppression=true) |
|
CV_EXPORTS void | AGAST (InputArray image, CV_OUT std::vector< KeyPoint > &keypoints, int threshold, bool nonmaxSuppression, AgastFeatureDetector::DetectorType type) |
| Detects corners using the AGAST algorithm. More...
|
|
CV_EXPORTS_W void | drawKeypoints (InputArray image, const std::vector< KeyPoint > &keypoints, InputOutputArray outImage, const Scalar &color=Scalar::all(-1), DrawMatchesFlags flags=DrawMatchesFlags::DEFAULT) |
| Draws keypoints. More...
|
|
CV_EXPORTS_W void | drawMatches (InputArray img1, const std::vector< KeyPoint > &keypoints1, InputArray img2, const std::vector< KeyPoint > &keypoints2, const std::vector< DMatch > &matches1to2, InputOutputArray outImg, const Scalar &matchColor=Scalar::all(-1), const Scalar &singlePointColor=Scalar::all(-1), const std::vector< char > &matchesMask=std::vector< char >(), DrawMatchesFlags flags=DrawMatchesFlags::DEFAULT) |
| Draws the found matches of keypoints from two images. More...
|
|
CV_EXPORTS_W void | drawMatches (InputArray img1, const std::vector< KeyPoint > &keypoints1, InputArray img2, const std::vector< KeyPoint > &keypoints2, const std::vector< DMatch > &matches1to2, InputOutputArray outImg, const int matchesThickness, const Scalar &matchColor=Scalar::all(-1), const Scalar &singlePointColor=Scalar::all(-1), const std::vector< char > &matchesMask=std::vector< char >(), DrawMatchesFlags flags=DrawMatchesFlags::DEFAULT) |
|
| CV_EXPORTS_AS (drawMatchesKnn) void drawMatches(InputArray img1 |
|
CV_EXPORTS void | evaluateFeatureDetector (const Mat &img1, const Mat &img2, const Mat &H1to2, std::vector< KeyPoint > *keypoints1, std::vector< KeyPoint > *keypoints2, float &repeatability, int &correspCount, const Ptr< FeatureDetector > &fdetector=Ptr< FeatureDetector >()) |
|
CV_EXPORTS void | computeRecallPrecisionCurve (const std::vector< std::vector< DMatch > > &matches1to2, const std::vector< std::vector< uchar > > &correctMatches1to2Mask, std::vector< Point2f > &recallPrecisionCurve) |
|
CV_EXPORTS float | getRecall (const std::vector< Point2f > &recallPrecisionCurve, float l_precision) |
|
CV_EXPORTS int | getNearestPoint (const std::vector< Point2f > &recallPrecisionCurve, float l_precision) |
|
static CV_WRAP void | HoughLinesWithAccumulator (InputArray image, OutputArray lines, double rho, double theta, int threshold, double srn=0, double stn=0, double min_theta=0, double max_theta=CV_PI) |
| Finds lines in a binary image using the standard Hough transform and get accumulator. More...
|
|
CV_EXPORTS_W Ptr< LineSegmentDetector > | createLineSegmentDetector (int refine=LSD_REFINE_STD, double scale=0.8, double sigma_scale=0.6, double quant=2.0, double ang_th=22.5, double log_eps=0, double density_th=0.7, int n_bins=1024) |
| Creates a smart pointer to a LineSegmentDetector object and initializes it. More...
|
|
CV_EXPORTS_W Mat | getGaussianKernel (int ksize, double sigma, int ktype=CV_64F) |
| Returns Gaussian filter coefficients. More...
|
|
CV_EXPORTS_W void | getDerivKernels (OutputArray kx, OutputArray ky, int dx, int dy, int ksize, bool normalize=false, int ktype=CV_32F) |
| Returns filter coefficients for computing spatial image derivatives. More...
|
|
CV_EXPORTS_W Mat | getGaborKernel (Size ksize, double sigma, double theta, double lambd, double gamma, double psi=CV_PI *0.5, int ktype=CV_64F) |
| Returns Gabor filter coefficients. More...
|
|
static Scalar | morphologyDefaultBorderValue () |
| returns "magic" border value for erosion and dilation. It is automatically transformed to Scalar::all(-DBL_MAX) for dilation. More...
|
|
CV_EXPORTS_W Mat | getStructuringElement (int shape, Size ksize, Point anchor=Point(-1,-1)) |
| Returns a structuring element of the specified size and shape for morphological operations. More...
|
|
CV_EXPORTS_W void | medianBlur (InputArray src, OutputArray dst, int ksize) |
| Blurs an image using the median filter. More...
|
|
CV_EXPORTS_W void | GaussianBlur (InputArray src, OutputArray dst, Size ksize, double sigmaX, double sigmaY=0, int borderType=BORDER_DEFAULT) |
| Blurs an image using a Gaussian filter. More...
|
|
CV_EXPORTS_W void | bilateralFilter (InputArray src, OutputArray dst, int d, double sigmaColor, double sigmaSpace, int borderType=BORDER_DEFAULT) |
| Applies the bilateral filter to an image. More...
|
|
CV_EXPORTS_W void | boxFilter (InputArray src, OutputArray dst, int ddepth, Size ksize, Point anchor=Point(-1,-1), bool normalize=true, int borderType=BORDER_DEFAULT) |
| Blurs an image using the box filter. More...
|
|
CV_EXPORTS_W void | sqrBoxFilter (InputArray src, OutputArray dst, int ddepth, Size ksize, Point anchor=Point(-1, -1), bool normalize=true, int borderType=BORDER_DEFAULT) |
| Calculates the normalized sum of squares of the pixel values overlapping the filter. More...
|
|
CV_EXPORTS_W void | blur (InputArray src, OutputArray dst, Size ksize, Point anchor=Point(-1,-1), int borderType=BORDER_DEFAULT) |
| Blurs an image using the normalized box filter. More...
|
|
CV_EXPORTS_W void | stackBlur (InputArray src, OutputArray dst, Size ksize) |
| Blurs an image using the stackBlur. More...
|
|
CV_EXPORTS_W void | filter2D (InputArray src, OutputArray dst, int ddepth, InputArray kernel, Point anchor=Point(-1,-1), double delta=0, int borderType=BORDER_DEFAULT) |
| Convolves an image with the kernel. More...
|
|
CV_EXPORTS_W void | sepFilter2D (InputArray src, OutputArray dst, int ddepth, InputArray kernelX, InputArray kernelY, Point anchor=Point(-1,-1), double delta=0, int borderType=BORDER_DEFAULT) |
| Applies a separable linear filter to an image. More...
|
|
CV_EXPORTS_W void | Sobel (InputArray src, OutputArray dst, int ddepth, int dx, int dy, int ksize=3, double scale=1, double delta=0, int borderType=BORDER_DEFAULT) |
| Calculates the first, second, third, or mixed image derivatives using an extended Sobel operator. More...
|
|
CV_EXPORTS_W void | spatialGradient (InputArray src, OutputArray dx, OutputArray dy, int ksize=3, int borderType=BORDER_DEFAULT) |
| Calculates the first order image derivative in both x and y using a Sobel operator. More...
|
|
CV_EXPORTS_W void | Scharr (InputArray src, OutputArray dst, int ddepth, int dx, int dy, double scale=1, double delta=0, int borderType=BORDER_DEFAULT) |
| Calculates the first x- or y- image derivative using Scharr operator. More...
|
|
CV_EXPORTS_W void | Laplacian (InputArray src, OutputArray dst, int ddepth, int ksize=1, double scale=1, double delta=0, int borderType=BORDER_DEFAULT) |
| Calculates the Laplacian of an image. More...
|
|
CV_EXPORTS_W void | Canny (InputArray image, OutputArray edges, double threshold1, double threshold2, int apertureSize=3, bool L2gradient=false) |
| Finds edges in an image using the Canny algorithm [Canny86] . More...
|
|
CV_EXPORTS_W void | Canny (InputArray dx, InputArray dy, OutputArray edges, double threshold1, double threshold2, bool L2gradient=false) |
|
CV_EXPORTS_W void | cornerMinEigenVal (InputArray src, OutputArray dst, int blockSize, int ksize=3, int borderType=BORDER_DEFAULT) |
| Calculates the minimal eigenvalue of gradient matrices for corner detection. More...
|
|
CV_EXPORTS_W void | cornerHarris (InputArray src, OutputArray dst, int blockSize, int ksize, double k, int borderType=BORDER_DEFAULT) |
| Harris corner detector. More...
|
|
CV_EXPORTS_W void | cornerEigenValsAndVecs (InputArray src, OutputArray dst, int blockSize, int ksize, int borderType=BORDER_DEFAULT) |
| Calculates eigenvalues and eigenvectors of image blocks for corner detection. More...
|
|
CV_EXPORTS_W void | preCornerDetect (InputArray src, OutputArray dst, int ksize, int borderType=BORDER_DEFAULT) |
| Calculates a feature map for corner detection. More...
|
|
CV_EXPORTS_W void | cornerSubPix (InputArray image, InputOutputArray corners, Size winSize, Size zeroZone, TermCriteria criteria) |
| Refines the corner locations. More...
|
|
CV_EXPORTS_W void | goodFeaturesToTrack (InputArray image, OutputArray corners, int maxCorners, double qualityLevel, double minDistance, InputArray mask=noArray(), int blockSize=3, bool useHarrisDetector=false, double k=0.04) |
| Determines strong corners on an image. More...
|
|
CV_EXPORTS_W void | goodFeaturesToTrack (InputArray image, OutputArray corners, int maxCorners, double qualityLevel, double minDistance, InputArray mask, int blockSize, int gradientSize, bool useHarrisDetector=false, double k=0.04) |
|
CV_EXPORTS | CV_WRAP_AS (goodFeaturesToTrackWithQuality) void goodFeaturesToTrack(InputArray image |
| Same as above, but returns also quality measure of the detected corners. More...
|
|
CV_EXPORTS_W void | HoughLines (InputArray image, OutputArray lines, double rho, double theta, int threshold, double srn=0, double stn=0, double min_theta=0, double max_theta=CV_PI) |
| Finds lines in a binary image using the standard Hough transform. More...
|
|
CV_EXPORTS_W void | HoughLinesP (InputArray image, OutputArray lines, double rho, double theta, int threshold, double minLineLength=0, double maxLineGap=0) |
| Finds line segments in a binary image using the probabilistic Hough transform. More...
|
|
CV_EXPORTS_W void | HoughLinesPointSet (InputArray point, OutputArray lines, int lines_max, int threshold, double min_rho, double max_rho, double rho_step, double min_theta, double max_theta, double theta_step) |
| Finds lines in a set of points using the standard Hough transform. More...
|
|
CV_EXPORTS_W void | HoughCircles (InputArray image, OutputArray circles, int method, double dp, double minDist, double param1=100, double param2=100, int minRadius=0, int maxRadius=0) |
| Finds circles in a grayscale image using the Hough transform. More...
|
|
CV_EXPORTS_W void | erode (InputArray src, OutputArray dst, InputArray kernel, Point anchor=Point(-1,-1), int iterations=1, int borderType=BORDER_CONSTANT, const Scalar &borderValue=morphologyDefaultBorderValue()) |
| Erodes an image by using a specific structuring element. More...
|
|
CV_EXPORTS_W void | dilate (InputArray src, OutputArray dst, InputArray kernel, Point anchor=Point(-1,-1), int iterations=1, int borderType=BORDER_CONSTANT, const Scalar &borderValue=morphologyDefaultBorderValue()) |
| Dilates an image by using a specific structuring element. More...
|
|
CV_EXPORTS_W void | morphologyEx (InputArray src, OutputArray dst, int op, InputArray kernel, Point anchor=Point(-1,-1), int iterations=1, int borderType=BORDER_CONSTANT, const Scalar &borderValue=morphologyDefaultBorderValue()) |
| Performs advanced morphological transformations. More...
|
|
CV_EXPORTS_W void | resize (InputArray src, OutputArray dst, Size dsize, double fx=0, double fy=0, int interpolation=INTER_LINEAR) |
| Resizes an image. More...
|
|
CV_EXPORTS_W void | warpAffine (InputArray src, OutputArray dst, InputArray M, Size dsize, int flags=INTER_LINEAR, int borderMode=BORDER_CONSTANT, const Scalar &borderValue=Scalar()) |
| Applies an affine transformation to an image. More...
|
|
CV_EXPORTS_W void | warpPerspective (InputArray src, OutputArray dst, InputArray M, Size dsize, int flags=INTER_LINEAR, int borderMode=BORDER_CONSTANT, const Scalar &borderValue=Scalar()) |
| Applies a perspective transformation to an image. More...
|
|
CV_EXPORTS_W void | remap (InputArray src, OutputArray dst, InputArray map1, InputArray map2, int interpolation, int borderMode=BORDER_CONSTANT, const Scalar &borderValue=Scalar()) |
| Applies a generic geometrical transformation to an image. More...
|
|
CV_EXPORTS_W void | convertMaps (InputArray map1, InputArray map2, OutputArray dstmap1, OutputArray dstmap2, int dstmap1type, bool nninterpolation=false) |
| Converts image transformation maps from one representation to another. More...
|
|
CV_EXPORTS_W Mat | getRotationMatrix2D (Point2f center, double angle, double scale) |
| Calculates an affine matrix of 2D rotation. More...
|
|
CV_EXPORTS Matx23d | getRotationMatrix2D_ (Point2f center, double angle, double scale) |
|
CV_EXPORTS Mat | getAffineTransform (const Point2f src[], const Point2f dst[]) |
| Calculates an affine transform from three pairs of the corresponding points. More...
|
|
CV_EXPORTS_W void | invertAffineTransform (InputArray M, OutputArray iM) |
| Inverts an affine transformation. More...
|
|
CV_EXPORTS_W Mat | getPerspectiveTransform (InputArray src, InputArray dst, int solveMethod=DECOMP_LU) |
| Calculates a perspective transform from four pairs of the corresponding points. More...
|
|
CV_EXPORTS Mat | getPerspectiveTransform (const Point2f src[], const Point2f dst[], int solveMethod=DECOMP_LU) |
|
CV_EXPORTS_W Mat | getAffineTransform (InputArray src, InputArray dst) |
|
CV_EXPORTS_W void | getRectSubPix (InputArray image, Size patchSize, Point2f center, OutputArray patch, int patchType=-1) |
| Retrieves a pixel rectangle from an image with sub-pixel accuracy. More...
|
|
CV_EXPORTS_W void | logPolar (InputArray src, OutputArray dst, Point2f center, double M, int flags) |
| Remaps an image to semilog-polar coordinates space. More...
|
|
CV_EXPORTS_W void | linearPolar (InputArray src, OutputArray dst, Point2f center, double maxRadius, int flags) |
| Remaps an image to polar coordinates space. More...
|
|
CV_EXPORTS_W void | warpPolar (InputArray src, OutputArray dst, Size dsize, Point2f center, double maxRadius, int flags) |
| Remaps an image to polar or semilog-polar coordinates space. More...
|
|
| CV_EXPORTS_AS (integral3) void integral(InputArray src |
| Calculates the integral of an image. More...
|
|
CV_EXPORTS_W void | integral (InputArray src, OutputArray sum, int sdepth=-1) |
|
| CV_EXPORTS_AS (integral2) void integral(InputArray src |
|
CV_EXPORTS_W void | accumulate (InputArray src, InputOutputArray dst, InputArray mask=noArray()) |
| Adds an image to the accumulator image. More...
|
|
CV_EXPORTS_W void | accumulateSquare (InputArray src, InputOutputArray dst, InputArray mask=noArray()) |
| Adds the square of a source image to the accumulator image. More...
|
|
CV_EXPORTS_W void | accumulateProduct (InputArray src1, InputArray src2, InputOutputArray dst, InputArray mask=noArray()) |
| Adds the per-element product of two input images to the accumulator image. More...
|
|
CV_EXPORTS_W void | accumulateWeighted (InputArray src, InputOutputArray dst, double alpha, InputArray mask=noArray()) |
| Updates a running average. More...
|
|
CV_EXPORTS_W Point2d | phaseCorrelate (InputArray src1, InputArray src2, InputArray window=noArray(), CV_OUT double *response=0) |
| The function is used to detect translational shifts that occur between two images. More...
|
|
CV_EXPORTS_W void | createHanningWindow (OutputArray dst, Size winSize, int type) |
| This function computes a Hanning window coefficients in two dimensions. More...
|
|
CV_EXPORTS_W void | divSpectrums (InputArray a, InputArray b, OutputArray c, int flags, bool conjB=false) |
| Performs the per-element division of the first Fourier spectrum by the second Fourier spectrum. More...
|
|
CV_EXPORTS_W double | threshold (InputArray src, OutputArray dst, double thresh, double maxval, int type) |
| Applies a fixed-level threshold to each array element. More...
|
|
CV_EXPORTS_W void | adaptiveThreshold (InputArray src, OutputArray dst, double maxValue, int adaptiveMethod, int thresholdType, int blockSize, double C) |
| Applies an adaptive threshold to an array. More...
|
|
CV_EXPORTS_W void | pyrDown (InputArray src, OutputArray dst, const Size &dstsize=Size(), int borderType=BORDER_DEFAULT) |
| Blurs an image and downsamples it. More...
|
|
CV_EXPORTS_W void | pyrUp (InputArray src, OutputArray dst, const Size &dstsize=Size(), int borderType=BORDER_DEFAULT) |
| Upsamples an image and then blurs it. More...
|
|
CV_EXPORTS void | buildPyramid (InputArray src, OutputArrayOfArrays dst, int maxlevel, int borderType=BORDER_DEFAULT) |
| Constructs the Gaussian pyramid for an image. More...
|
|
CV_EXPORTS void | calcHist (const Mat *images, int nimages, const int *channels, InputArray mask, OutputArray hist, int dims, const int *histSize, const float **ranges, bool uniform=true, bool accumulate=false) |
| Calculates a histogram of a set of arrays. More...
|
|
CV_EXPORTS void | calcHist (const Mat *images, int nimages, const int *channels, InputArray mask, SparseMat &hist, int dims, const int *histSize, const float **ranges, bool uniform=true, bool accumulate=false) |
|
CV_EXPORTS_W void | calcHist (InputArrayOfArrays images, const std::vector< int > &channels, InputArray mask, OutputArray hist, const std::vector< int > &histSize, const std::vector< float > &ranges, bool accumulate=false) |
|
CV_EXPORTS void | calcBackProject (const Mat *images, int nimages, const int *channels, InputArray hist, OutputArray backProject, const float **ranges, double scale=1, bool uniform=true) |
| Calculates the back projection of a histogram. More...
|
|
CV_EXPORTS void | calcBackProject (const Mat *images, int nimages, const int *channels, const SparseMat &hist, OutputArray backProject, const float **ranges, double scale=1, bool uniform=true) |
|
CV_EXPORTS_W void | calcBackProject (InputArrayOfArrays images, const std::vector< int > &channels, InputArray hist, OutputArray dst, const std::vector< float > &ranges, double scale) |
|
CV_EXPORTS_W double | compareHist (InputArray H1, InputArray H2, int method) |
| Compares two histograms. More...
|
|
CV_EXPORTS double | compareHist (const SparseMat &H1, const SparseMat &H2, int method) |
|
CV_EXPORTS_W void | equalizeHist (InputArray src, OutputArray dst) |
| Equalizes the histogram of a grayscale image. More...
|
|
CV_EXPORTS_W Ptr< CLAHE > | createCLAHE (double clipLimit=40.0, Size tileGridSize=Size(8, 8)) |
| Creates a smart pointer to a cv::CLAHE class and initializes it. More...
|
|
CV_EXPORTS float | EMD (InputArray signature1, InputArray signature2, int distType, InputArray cost=noArray(), float *lowerBound=0, OutputArray flow=noArray()) |
| Computes the "minimal work" distance between two weighted point configurations. More...
|
|
| CV_EXPORTS_AS (EMD) float wrapperEMD(InputArray signature1 |
|
CV_EXPORTS_W void | watershed (InputArray image, InputOutputArray markers) |
| Performs a marker-based image segmentation using the watershed algorithm. More...
|
|
CV_EXPORTS_W void | pyrMeanShiftFiltering (InputArray src, OutputArray dst, double sp, double sr, int maxLevel=1, TermCriteria termcrit=TermCriteria(TermCriteria::MAX_ITER+TermCriteria::EPS, 5, 1)) |
| Performs initial step of meanshift segmentation of an image. More...
|
|
CV_EXPORTS_W void | grabCut (InputArray img, InputOutputArray mask, Rect rect, InputOutputArray bgdModel, InputOutputArray fgdModel, int iterCount, int mode=GC_EVAL) |
| Runs the GrabCut algorithm. More...
|
|
| CV_EXPORTS_AS (distanceTransformWithLabels) void distanceTransform(InputArray src |
| Calculates the distance to the closest zero pixel for each pixel of the source image. More...
|
|
CV_EXPORTS_W void | distanceTransform (InputArray src, OutputArray dst, int distanceType, int maskSize, int dstType=CV_32F) |
|
CV_EXPORTS_W int | floodFill (InputOutputArray image, InputOutputArray mask, Point seedPoint, Scalar newVal, CV_OUT Rect *rect=0, Scalar loDiff=Scalar(), Scalar upDiff=Scalar(), int flags=4) |
| Fills a connected component with the given color. More...
|
|
CV_EXPORTS int | floodFill (InputOutputArray image, Point seedPoint, Scalar newVal, CV_OUT Rect *rect=0, Scalar loDiff=Scalar(), Scalar upDiff=Scalar(), int flags=4) |
|
CV_EXPORTS_W void | blendLinear (InputArray src1, InputArray src2, InputArray weights1, InputArray weights2, OutputArray dst) |
|
CV_EXPORTS_W void | cvtColor (InputArray src, OutputArray dst, int code, int dstCn=0) |
| Converts an image from one color space to another. More...
|
|
CV_EXPORTS_W void | cvtColorTwoPlane (InputArray src1, InputArray src2, OutputArray dst, int code) |
| Converts an image from one color space to another where the source image is stored in two planes. More...
|
|
CV_EXPORTS_W void | demosaicing (InputArray src, OutputArray dst, int code, int dstCn=0) |
| main function for all demosaicing processes More...
|
|
CV_EXPORTS_W Moments | moments (InputArray array, bool binaryImage=false) |
| Calculates all of the moments up to the third order of a polygon or rasterized shape. More...
|
|
CV_EXPORTS void | HuMoments (const Moments &moments, double hu[7]) |
| Calculates seven Hu invariants. More...
|
|
CV_EXPORTS_W void | HuMoments (const Moments &m, OutputArray hu) |
|
CV_EXPORTS_W void | matchTemplate (InputArray image, InputArray templ, OutputArray result, int method, InputArray mask=noArray()) |
| Compares a template against overlapped image regions. More...
|
|
| CV_EXPORTS_AS (connectedComponentsWithAlgorithm) int connectedComponents(InputArray image |
| computes the connected components labeled image of boolean image More...
|
|
CV_EXPORTS_W int | connectedComponents (InputArray image, OutputArray labels, int connectivity=8, int ltype=CV_32S) |
|
| CV_EXPORTS_AS (connectedComponentsWithStatsWithAlgorithm) int connectedComponentsWithStats(InputArray image |
| computes the connected components labeled image of boolean image and also produces a statistics output for each label More...
|
|
CV_EXPORTS_W int | connectedComponentsWithStats (InputArray image, OutputArray labels, OutputArray stats, OutputArray centroids, int connectivity=8, int ltype=CV_32S) |
|
CV_EXPORTS_W void | findContours (InputArray image, OutputArrayOfArrays contours, OutputArray hierarchy, int mode, int method, Point offset=Point()) |
| Finds contours in a binary image. More...
|
|
CV_EXPORTS void | findContours (InputArray image, OutputArrayOfArrays contours, int mode, int method, Point offset=Point()) |
|
CV_EXPORTS_W void | findContoursLinkRuns (InputArray image, OutputArrayOfArrays contours, OutputArray hierarchy) |
| Find contours using link runs algorithm. More...
|
|
CV_EXPORTS_W void | findContoursLinkRuns (InputArray image, OutputArrayOfArrays contours) |
| This is an overloaded member function, provided for convenience. It differs from the above function only in what argument(s) it accepts. More...
|
|
CV_EXPORTS_W void | approxPolyDP (InputArray curve, OutputArray approxCurve, double epsilon, bool closed) |
| Approximates a polygonal curve(s) with the specified precision. More...
|
|
CV_EXPORTS_W double | arcLength (InputArray curve, bool closed) |
| Calculates a contour perimeter or a curve length. More...
|
|
CV_EXPORTS_W Rect | boundingRect (InputArray array) |
| Calculates the up-right bounding rectangle of a point set or non-zero pixels of gray-scale image. More...
|
|
CV_EXPORTS_W double | contourArea (InputArray contour, bool oriented=false) |
| Calculates a contour area. More...
|
|
CV_EXPORTS_W RotatedRect | minAreaRect (InputArray points) |
| Finds a rotated rectangle of the minimum area enclosing the input 2D point set. More...
|
|
CV_EXPORTS_W void | boxPoints (RotatedRect box, OutputArray points) |
| Finds the four vertices of a rotated rect. Useful to draw the rotated rectangle. More...
|
|
CV_EXPORTS_W void | minEnclosingCircle (InputArray points, CV_OUT Point2f ¢er, CV_OUT float &radius) |
| Finds a circle of the minimum area enclosing a 2D point set. More...
|
|
CV_EXPORTS_W double | minEnclosingTriangle (InputArray points, CV_OUT OutputArray triangle) |
| Finds a triangle of minimum area enclosing a 2D point set and returns its area. More...
|
|
CV_EXPORTS_W double | matchShapes (InputArray contour1, InputArray contour2, int method, double parameter) |
| Compares two shapes. More...
|
|
CV_EXPORTS_W void | convexHull (InputArray points, OutputArray hull, bool clockwise=false, bool returnPoints=true) |
| Finds the convex hull of a point set. More...
|
|
CV_EXPORTS_W void | convexityDefects (InputArray contour, InputArray convexhull, OutputArray convexityDefects) |
| Finds the convexity defects of a contour. More...
|
|
CV_EXPORTS_W bool | isContourConvex (InputArray contour) |
| Tests a contour convexity. More...
|
|
CV_EXPORTS_W float | intersectConvexConvex (InputArray p1, InputArray p2, OutputArray p12, bool handleNested=true) |
| Finds intersection of two convex polygons. More...
|
|
CV_EXPORTS_W RotatedRect | fitEllipse (InputArray points) |
| Fits an ellipse around a set of 2D points. More...
|
|
CV_EXPORTS_W RotatedRect | fitEllipseAMS (InputArray points) |
| Fits an ellipse around a set of 2D points. More...
|
|
CV_EXPORTS_W RotatedRect | fitEllipseDirect (InputArray points) |
| Fits an ellipse around a set of 2D points. More...
|
|
CV_EXPORTS_W void | fitLine (InputArray points, OutputArray line, int distType, double param, double reps, double aeps) |
| Fits a line to a 2D or 3D point set. More...
|
|
CV_EXPORTS_W double | pointPolygonTest (InputArray contour, Point2f pt, bool measureDist) |
| Performs a point-in-contour test. More...
|
|
CV_EXPORTS_W int | rotatedRectangleIntersection (const RotatedRect &rect1, const RotatedRect &rect2, OutputArray intersectingRegion) |
| Finds out if there is any intersection between two rotated rectangles. More...
|
|
CV_EXPORTS_W Ptr< GeneralizedHoughBallard > | createGeneralizedHoughBallard () |
| Creates a smart pointer to a cv::GeneralizedHoughBallard class and initializes it. More...
|
|
CV_EXPORTS_W Ptr< GeneralizedHoughGuil > | createGeneralizedHoughGuil () |
| Creates a smart pointer to a cv::GeneralizedHoughGuil class and initializes it. More...
|
|
CV_EXPORTS_W void | applyColorMap (InputArray src, OutputArray dst, int colormap) |
| Applies a GNU Octave/MATLAB equivalent colormap on a given image. More...
|
|
CV_EXPORTS_W void | applyColorMap (InputArray src, OutputArray dst, InputArray userColor) |
| Applies a user colormap on a given image. More...
|
|
CV_EXPORTS_W void | line (InputOutputArray img, Point pt1, Point pt2, const Scalar &color, int thickness=1, int lineType=LINE_8, int shift=0) |
| Draws a line segment connecting two points. More...
|
|
CV_EXPORTS_W void | arrowedLine (InputOutputArray img, Point pt1, Point pt2, const Scalar &color, int thickness=1, int line_type=8, int shift=0, double tipLength=0.1) |
| Draws an arrow segment pointing from the first point to the second one. More...
|
|
CV_EXPORTS_W void | rectangle (InputOutputArray img, Point pt1, Point pt2, const Scalar &color, int thickness=1, int lineType=LINE_8, int shift=0) |
| Draws a simple, thick, or filled up-right rectangle. More...
|
|
CV_EXPORTS_W void | rectangle (InputOutputArray img, Rect rec, const Scalar &color, int thickness=1, int lineType=LINE_8, int shift=0) |
|
CV_EXPORTS_W void | circle (InputOutputArray img, Point center, int radius, const Scalar &color, int thickness=1, int lineType=LINE_8, int shift=0) |
| Draws a circle. More...
|
|
CV_EXPORTS_W void | ellipse (InputOutputArray img, Point center, Size axes, double angle, double startAngle, double endAngle, const Scalar &color, int thickness=1, int lineType=LINE_8, int shift=0) |
| Draws a simple or thick elliptic arc or fills an ellipse sector. More...
|
|
CV_EXPORTS_W void | ellipse (InputOutputArray img, const RotatedRect &box, const Scalar &color, int thickness=1, int lineType=LINE_8) |
|
CV_EXPORTS_W void | drawMarker (InputOutputArray img, Point position, const Scalar &color, int markerType=MARKER_CROSS, int markerSize=20, int thickness=1, int line_type=8) |
| Draws a marker on a predefined position in an image. More...
|
|
CV_EXPORTS_W void | fillConvexPoly (InputOutputArray img, InputArray points, const Scalar &color, int lineType=LINE_8, int shift=0) |
| Fills a convex polygon. More...
|
|
CV_EXPORTS void | fillConvexPoly (InputOutputArray img, const Point *pts, int npts, const Scalar &color, int lineType=LINE_8, int shift=0) |
|
CV_EXPORTS_W void | fillPoly (InputOutputArray img, InputArrayOfArrays pts, const Scalar &color, int lineType=LINE_8, int shift=0, Point offset=Point()) |
| Fills the area bounded by one or more polygons. More...
|
|
CV_EXPORTS void | fillPoly (InputOutputArray img, const Point **pts, const int *npts, int ncontours, const Scalar &color, int lineType=LINE_8, int shift=0, Point offset=Point()) |
|
CV_EXPORTS_W void | polylines (InputOutputArray img, InputArrayOfArrays pts, bool isClosed, const Scalar &color, int thickness=1, int lineType=LINE_8, int shift=0) |
| Draws several polygonal curves. More...
|
|
CV_EXPORTS void | polylines (InputOutputArray img, const Point *const *pts, const int *npts, int ncontours, bool isClosed, const Scalar &color, int thickness=1, int lineType=LINE_8, int shift=0) |
|
CV_EXPORTS_W void | drawContours (InputOutputArray image, InputArrayOfArrays contours, int contourIdx, const Scalar &color, int thickness=1, int lineType=LINE_8, InputArray hierarchy=noArray(), int maxLevel=INT_MAX, Point offset=Point()) |
| Draws contours outlines or filled contours. More...
|
|
CV_EXPORTS bool | clipLine (Size imgSize, CV_IN_OUT Point &pt1, CV_IN_OUT Point &pt2) |
| Clips the line against the image rectangle. More...
|
|
CV_EXPORTS bool | clipLine (Size2l imgSize, CV_IN_OUT Point2l &pt1, CV_IN_OUT Point2l &pt2) |
|
CV_EXPORTS_W bool | clipLine (Rect imgRect, CV_OUT CV_IN_OUT Point &pt1, CV_OUT CV_IN_OUT Point &pt2) |
|
CV_EXPORTS_W void | ellipse2Poly (Point center, Size axes, int angle, int arcStart, int arcEnd, int delta, CV_OUT std::vector< Point > &pts) |
| Approximates an elliptic arc with a polyline. More...
|
|
CV_EXPORTS void | ellipse2Poly (Point2d center, Size2d axes, int angle, int arcStart, int arcEnd, int delta, CV_OUT std::vector< Point2d > &pts) |
|
CV_EXPORTS_W void | putText (InputOutputArray img, const String &text, Point org, int fontFace, double fontScale, Scalar color, int thickness=1, int lineType=LINE_8, bool bottomLeftOrigin=false) |
| Draws a text string. More...
|
|
CV_EXPORTS_W Size | getTextSize (const String &text, int fontFace, double fontScale, int thickness, CV_OUT int *baseLine) |
| Calculates the width and height of a text string. More...
|
|
CV_EXPORTS_W double | getFontScaleFromHeight (const int fontFace, const int pixelHeight, const int thickness=1) |
| Calculates the font-specific size to use to achieve a given height in pixels. More...
|
|
CV_EXPORTS void | groupRectangles (std::vector< Rect > &rectList, int groupThreshold, double eps=0.2) |
| Groups the object candidate rectangles. More...
|
|
CV_EXPORTS_W void | groupRectangles (CV_IN_OUT std::vector< Rect > &rectList, CV_OUT std::vector< int > &weights, int groupThreshold, double eps=0.2) |
|
CV_EXPORTS void | groupRectangles (std::vector< Rect > &rectList, int groupThreshold, double eps, std::vector< int > *weights, std::vector< double > *levelWeights) |
|
CV_EXPORTS void | groupRectangles (std::vector< Rect > &rectList, std::vector< int > &rejectLevels, std::vector< double > &levelWeights, int groupThreshold, double eps=0.2) |
|
CV_EXPORTS void | groupRectangles_meanshift (std::vector< Rect > &rectList, std::vector< double > &foundWeights, std::vector< double > &foundScales, double detectThreshold=0.0, Size winDetSize=Size(64, 128)) |
|
CV_EXPORTS Ptr< BaseCascadeClassifier::MaskGenerator > | createFaceDetectionMaskGenerator () |
|
|
Pack boolean values from multiple vectors to one unsigned 8-bit integer vector
- Note
- Must provide valid boolean values to guarantee same result for all architectures.
|
template<int n> |
v_reg< uchar, 2 *n > | v_pack_b (const v_reg< ushort, n > &a, const v_reg< ushort, n > &b) |
| ! For 16-bit boolean values More...
|
|
template<int n> |
v_reg< uchar, 4 *n > | v_pack_b (const v_reg< unsigned, n > &a, const v_reg< unsigned, n > &b, const v_reg< unsigned, n > &c, const v_reg< unsigned, n > &d) |
|
template<int n> |
v_reg< uchar, 8 *n > | v_pack_b (const v_reg< uint64, n > &a, const v_reg< uint64, n > &b, const v_reg< uint64, n > &c, const v_reg< uint64, n > &d, const v_reg< uint64, n > &e, const v_reg< uint64, n > &f, const v_reg< uint64, n > &g, const v_reg< uint64, n > &h) |
|