Home
last modified time | relevance | path

Searched refs:pts1 (Results 1 – 25 of 464) sorted by relevance

12345678910>>...19

/dports/graphics/opencv/opencv-4.5.3/modules/calib3d/test/
H A Dtest_usac.cpp94 cv::divide(pts1.row(0), pts1.row(2), pts1.row(0)); in generatePoints()
95 cv::divide(pts1.row(1), pts1.row(2), pts1.row(1)); in generatePoints()
97 pts1 = pts1.rowRange(0, 2); in generatePoints()
109 cv::Mat noise(pts1.rows, pts1.cols, pts1.type()); in generatePoints()
128 cv::divide(pts1.row(0), pts1.row(2), pts1.row(0)); in generatePoints()
129 cv::divide(pts1.row(1), pts1.row(2), pts1.row(1)); in generatePoints()
140 cv::vconcat(pts1, cv::Mat::ones(1, pts1.cols, pts1.type()), points3d); in generatePoints()
208 pts1.convertTo(pts1, model.type()); in checkInliersMask()
212 cv::vconcat(pts1, cv::Mat::ones(1, pts1.cols, pts1.type()), pts1); in checkInliersMask()
326 cv::vconcat(pts1, cv::Mat::ones(1, pts1.cols, pts1.type()), cpts1_3d); in TEST()
[all …]
/dports/misc/vxl/vxl-3.3.2/core/vpgl/algo/tests/
H A Dtest_equi_rectification.cxx68 std::vector<vnl_vector_fixed<double, 3>> pts1; in test_equi_rectification() local
69 pts1.emplace_back(804.37166610597023, 732.29242173264697, 1.0); in test_equi_rectification()
70 pts1.emplace_back(608.10981184076206, 886.30988997648990, 1.0); in test_equi_rectification()
71 pts1.emplace_back(639.12331300363223, 741.77946271747237, 1.0); in test_equi_rectification()
72 pts1.emplace_back(669.62370166924109, 868.59261223726821, 1.0); in test_equi_rectification()
73 pts1.emplace_back(527.32634094356399, 937.14824986983365, 1.0); in test_equi_rectification()
74 pts1.emplace_back(589.23380555663482, 779.19537477125436, 1.0); in test_equi_rectification()
75 pts1.emplace_back(730.63082919432691, 813.32064833166964, 1.0); in test_equi_rectification()
76 pts1.emplace_back(740.38139587443618, 817.13405514819260, 1.0); in test_equi_rectification()
77 pts1.emplace_back(505.46073221505446, 878.16309403135233, 1.0); in test_equi_rectification()
[all …]
/dports/cad/opencascade/opencascade-7.6.0/src/BlendFunc/
H A DBlendFunc_ConstThroatWithPenetration.cxx72 temp1.SetXYZ(pts1.XYZ() - ptgui.XYZ()); in IsSolution()
74 temp3.SetXYZ(pts2.XYZ() - pts1.XYZ()); in IsSolution()
75 surf1->D1(Sol(1),Sol(2),pts1,d1u1,d1v1); in IsSolution()
112 surf1->D0( X(1), X(2), pts1 ); in Value()
118 const gp_Vec vref(ptgui, pts1); in Value()
122 const gp_Vec vec12(pts1, pts2); in Value()
148 D(3,1) = 2.*gp_Vec(ptgui,pts1).Dot(d1u1); in Derivatives()
152 D(4,1) = d1u1.Dot(gp_Vec(pts1,pts2)) - gp_Vec(ptgui,pts1).Dot(d1u1); in Derivatives()
153 D(4,2) = d1v1.Dot(gp_Vec(pts1,pts2)) - gp_Vec(ptgui,pts1).Dot(d1v1); in Derivatives()
154 D(4,3) = gp_Vec(ptgui,pts1).Dot(d1u2); in Derivatives()
[all …]
H A DBlendFunc_ConstThroat.cxx102 temp1.SetXYZ(pts1.XYZ() - ptgui.XYZ()); in IsSolution()
105 surf1->D1(Sol(1),Sol(2),pts1,d1u1,d1v1); in IsSolution()
126 distmin = Min(distmin, pts1.Distance(pts2)); in IsSolution()
141 surf1->D0( X(1), X(2), pts1 ); in Value()
144 F(1) = nplan.XYZ().Dot(pts1.XYZ()) + theD; in Value()
147 const gp_Pnt ptmid((pts1.XYZ() + pts2.XYZ())/2); in Value()
152 const gp_Vec vref1(ptgui, pts1); in Value()
167 surf1->D1( X(1), X(2), pts1, d1u1, d1v1); in Derivatives()
182 D(4,1) = 2.*gp_Vec(ptgui,pts1).Dot(d1u1); in Derivatives()
183 D(4,2) = 2.*gp_Vec(ptgui,pts1).Dot(d1v1); in Derivatives()
[all …]
H A DBlendFunc_ConstThroatInv.cxx139 surf1->D0( XX(1), XX(2), pts1 ); in Value()
142 F(1) = nplan.XYZ().Dot(pts1.XYZ()) + theD; in Value()
145 const gp_Pnt ptmid((pts1.XYZ() + pts2.XYZ())/2); in Value()
150 const gp_Vec vref1(ptgui, pts1); in Value()
185 temp1.SetXYZ(pts1.XYZ() - ptgui.XYZ()); in Derivatives()
187 tempmid.SetXYZ((pts1.XYZ() + pts2.XYZ())/2 - ptgui.XYZ()); in Derivatives()
202 surf1->D1(XX(1), XX(2), pts1, d1u1, d1v1); in Derivatives()
213 D(3,1) = gp_Vec(ptgui,pts1).Dot(temp); in Derivatives()
214 D(4,1) = 2*(gp_Vec(ptgui,pts1).Dot(temp)); in Derivatives()
244 D(4,3) = 2.*gp_Vec(ptgui,pts1).Dot(d1u1); in Derivatives()
[all …]
/dports/misc/vxl/vxl-3.3.2/contrib/mul/mbl/tests/
H A Dtest_thin_plate_spline_weights_3d.cxx15 std::vector<vgl_point_3d<double> > pts1(n_points),pts2(n_points); in test_tpsw3d_at_fixed_points() local
22 pts1[i]=vgl_point_3d<double>(mz_random.drand64(), in test_tpsw3d_at_fixed_points()
31 tps.build(pts1,pts2); in test_tpsw3d_at_fixed_points()
37 TEST_NEAR("Warped point = target point",vgl_distance(tps(pts1[i]),pts2[i]),0.0,1e-6); in test_tpsw3d_at_fixed_points()
45 tps3.set_source_pts(pts1); in test_tpsw3d_at_fixed_points()
50 TEST_NEAR("Warped point = target point",vgl_distance(tps3(pts1[i]),pts2[i]),0.0,1e-6); in test_tpsw3d_at_fixed_points()
57 std::vector<vgl_point_3d<double> > pts1(n_points),pts2(n_points),wts(n_points); in test_tpsw3d_at_fixed_points_with_weights() local
64 pts1[i]=vgl_point_3d<double>(mz_random.drand64(), in test_tpsw3d_at_fixed_points_with_weights()
77 tps.build(pts1,pts2); in test_tpsw3d_at_fixed_points_with_weights()
83 TEST_NEAR("Warped point = target point",vgl_distance(tps(pts1[i]),pts2[i]),0.0,1e-6); in test_tpsw3d_at_fixed_points_with_weights()
[all …]
H A Dtest_thin_plate_spline_2d.cxx15 std::vector<vgl_point_2d<double> > pts1(n_points),pts2(n_points); in test_tps_at_fixed_points() local
22 pts1[i]=vgl_point_2d<double>(mz_random.drand64(),mz_random.drand64()); in test_tps_at_fixed_points()
29 tps.build(pts1,pts2); in test_tps_at_fixed_points()
35 TEST_NEAR("Warped point = target point",vgl_distance(tps(pts1[i]),pts2[i]),0.0,1e-6); in test_tps_at_fixed_points()
43 tps3.set_source_pts(pts1); in test_tps_at_fixed_points()
48 TEST_NEAR("Warped point = target point",vgl_distance(tps3(pts1[i]),pts2[i]),0.0,1e-6); in test_tps_at_fixed_points()
H A Dtest_thin_plate_spline_3d.cxx15 std::vector<vgl_point_3d<double> > pts1(n_points),pts2(n_points); in test_tps3d_at_fixed_points() local
22 pts1[i]=vgl_point_3d<double>(mz_random.drand64(), in test_tps3d_at_fixed_points()
31 tps.build(pts1,pts2); in test_tps3d_at_fixed_points()
37 TEST_NEAR("Warped point = target point",vgl_distance(tps(pts1[i]),pts2[i]),0.0,1e-6); in test_tps3d_at_fixed_points()
45 tps3.set_source_pts(pts1); in test_tps3d_at_fixed_points()
50 TEST_NEAR("Warped point = target point",vgl_distance(tps3(pts1[i]),pts2[i]),0.0,1e-6); in test_tps3d_at_fixed_points()
H A Dtest_clamped_plate_spline_2d.cxx15 std::vector<vgl_point_2d<double> > pts1(n_points),pts2(n_points); in test_cps_at_fixed_points() local
22 pts1[i]=vgl_point_2d<double>(0.5*mz_random.drand64(),0.5*mz_random.drand64()); in test_cps_at_fixed_points()
29 cps.build(pts1,pts2); in test_cps_at_fixed_points()
35 TEST_NEAR("Warped point = target",vgl_distance(cps(pts1[i]),pts2[i]),0.0,1e-6); in test_cps_at_fixed_points()
43 cps3.set_source_pts(pts1); in test_cps_at_fixed_points()
48 TEST_NEAR("Warped point = target",vgl_distance(cps3(pts1[i]),pts2[i]),0.0,1e-6); in test_cps_at_fixed_points()
/dports/graphics/opencv/opencv-4.5.3/modules/imgproc/src/
H A Dintersection.cpp58 Point2f pts1[4], pts2[4]; in _rotatedRectangleIntersection() local
60 rect1.points(pts1); in _rotatedRectangleIntersection()
71 … if( fabs(pts1[i].x - pts2[i].x) > samePointEps || (fabs(pts1[i].y - pts2[i].y) > samePointEps) ) in _rotatedRectangleIntersection()
84 intersection[i] = pts1[i]; in _rotatedRectangleIntersection()
95 vec1[i].x = pts1[(i+1)%4].x - pts1[i].x; in _rotatedRectangleIntersection()
96 vec1[i].y = pts1[(i+1)%4].y - pts1[i].y; in _rotatedRectangleIntersection()
108 float x21 = pts2[j].x - pts1[i].x; in _rotatedRectangleIntersection()
152 float x = pts1[i].x; in _rotatedRectangleIntersection()
153 float y = pts1[i].y; in _rotatedRectangleIntersection()
177 intersection.push_back(pts1[i]); in _rotatedRectangleIntersection()
[all …]
/dports/math/jts/jts-jts-1.18.1/modules/core/src/main/java/org/locationtech/jts/geom/
H A DCoordinateArrays.java216 if (i < pts1.length) return 1; in compare()
229 Coordinate[] pts1 = (Coordinate[]) o1; in compare() local
272 for (int i = 0; i < pts1.length; i++) { in isEqualReversed()
273 Coordinate p1 = pts1[i]; in isEqualReversed()
292 Coordinate[] pts1 = (Coordinate[]) o1; in compare() local
296 if (pts1.length > pts2.length) return 1; in compare()
298 if (pts1.length == 0) return 0; in compare()
308 Coordinate[] pts1 = (Coordinate[]) o1; in OLDcompare() local
314 if (pts1.length == 0) return 0; in OLDcompare()
316 int dir1 = increasingDirection(pts1); in OLDcompare()
[all …]
/dports/science/rdkit/rdkit-Release_2021_03_5/rdkit/Chem/Draw/
H A DmplCanvas.py81 pts1 = self._getLinePoints(p1, p2, dash)
83 pts1 = [self.rescalePt(p) for p in pts1]
85 if len(pts2) < len(pts1):
86 pts2, pts1 = pts1, pts2
87 for i in range(len(pts1)):
89 mp = (pts1[i][0] + pts2[i][0]) / 2., (pts1[i][1] + pts2[i][1]) / 2.
90 canvas.add_line(Line2D((pts1[i][0], mp[0]), (pts1[i][1], mp[1]), color=color, **kwargs))
94 Line2D((pts1[i][0], pts2[i][0]), (pts1[i][1], pts2[i][1]), color=color, **kwargs))
/dports/misc/vxl/vxl-3.3.2/contrib/oxl/mvl/
H A DHMatrix2DEuclideanCompute.cxx33 PointArray pts1(matches.count()); in compute() local
35 matches.extract_matches(pts1, pts2); in compute()
37 tmp_fun(pts1,pts2,&H); in compute()
51 HMatrix2DEuclideanCompute::compute_p(PointArray const& pts1, in compute_p() argument
55 return tmp_fun(pts1,pts2,H); in compute_p()
59 HMatrix2DEuclideanCompute::tmp_fun(PointArray const& pts1, in tmp_fun() argument
63 assert(pts1.size() == pts2.size()); in tmp_fun()
65 NonHomg p1(pts1); in tmp_fun()
H A DHMatrix2DSimilarityCompute.cxx32 PointArray pts1(matches.count()); in compute() local
34 matches.extract_matches(pts1, pts2); in compute()
36 tmp_fun(pts1,pts2,&H); in compute()
50 HMatrix2DSimilarityCompute::compute_p(PointArray const& pts1, in compute_p() argument
54 return tmp_fun(pts1,pts2,H); in compute_p()
58 HMatrix2DSimilarityCompute::tmp_fun(PointArray const& pts1, in tmp_fun() argument
62 assert(pts1.size() == pts2.size()); in tmp_fun()
64 NonHomg p1(pts1); in tmp_fun()
H A DHMatrix2DAffineCompute.cxx35 assert(pts1.size() == pts2.size()); in tmp_fun()
37 NonHomg p1(pts1); in tmp_fun()
47 vnl_matrix<double> joint(pts1.size(),2+2); in tmp_fun()
69 static bool tmp_fun(std::vector<HomgPoint2D> const& pts1, in tmp_fun() argument
77 assert(pts1.size() == pts2.size()); in tmp_fun()
79 NonHomg p1(pts1); in tmp_fun()
89 vnl_matrix<double> joint(pts1.size(),2+2); in tmp_fun()
114 std::vector<HomgPoint2D> pts1(matches.count()); in compute() local
116 matches.extract_matches(pts1, pts2); in compute()
118 tmp_fun(pts1,pts2,H); in compute()
[all …]
/dports/multimedia/replex/replex-0.1.6.8/
H A Dpes.h122 int64_t ptsdiff(uint64_t pts1, uint64_t pts2);
123 uint64_t uptsdiff(uint64_t pts1, uint64_t pts2);
124 int ptscmp(uint64_t pts1, uint64_t pts2);
125 uint64_t ptsadd(uint64_t pts1, uint64_t pts2);
151 static inline void ptsdec(uint64_t *pts1, uint64_t pts2) in ptsdec() argument
153 *pts1= uptsdiff(*pts1, pts2); in ptsdec()
156 static inline void ptsinc(uint64_t *pts1, uint64_t pts2) in ptsinc() argument
158 *pts1 = (*pts1 + pts2)%MAX_PTS2; in ptsinc()
/dports/x11-toolkits/gnustep-gui/libs-gui-gui-0_28_0/Tests/gui/NSBezierPath/
H A Dbasic.m55 NSPoint pts1[3];
102 type1 = [self elementAtIndex: i associatedPoints: pts1];
110 if (!eq(pts1[0].x, pts2[0].x) || !eq(pts1[0].y, pts2[0].y))
112 NSLog(@"different point %@ %@", NSStringFromPoint(pts1[0]), NSStringFromPoint(pts2[0]));
118 if (!eq(pts1[1].x, pts2[1].x) || !eq(pts1[1].y, pts2[1].y))
120 … NSLog(@"different point %@ %@", NSStringFromPoint(pts1[1]), NSStringFromPoint(pts2[1]));
123 if (!eq(pts1[2].x, pts2[2].x) || !eq(pts1[2].y, pts2[2].y))
125 … NSLog(@"different point %@ %@", NSStringFromPoint(pts1[2]), NSStringFromPoint(pts2[2]));
/dports/misc/vxl/vxl-3.3.2/contrib/brl/bbas/bwm/exe/
H A Dbwm_3d_site_transform.cxx27 vnl_matrix<double> const& pts1, in compute_similarity() argument
32 vpgl_ortho_procrustes op(pts0, pts1); in compute_similarity()
117 vnl_matrix<double> pts0, pts1; in main() local
127 pts1.set_size(3,n); in main()
131 pts0[0][i] = match_pts[0].x(); pts1[0][i] = match_pts[1].x(); in main()
132 pts0[1][i] = match_pts[0].y(); pts1[1][i] = match_pts[1].y(); in main()
133 pts0[2][i] = match_pts[0].z(); pts1[2][i] = match_pts[1].z(); in main()
135 if (!compute_similarity(pts0, pts1, R, t, scale)) { in main()
176 pts1.set_size(3,n_cams); in main()
178 pts0[0][i] = cam_centers_bundler[i].x(); pts1[0][i] = cam_centers_gps[i].x(); in main()
[all …]
/dports/graphics/opencv/opencv-4.5.3/contrib/modules/shape/src/
H A Dtps_trans.cpp176 Mat pts1 = inPts.getMat(); in applyTransformation() local
177 CV_Assert((pts1.channels()==2) && (pts1.cols>0)); in applyTransformation()
183 outPts.create(1,pts1.cols, CV_32FC2); in applyTransformation()
185 for (int i=0; i<pts1.cols; i++) in applyTransformation()
187 Point2f pt=pts1.at<Point2f>(0,i); in applyTransformation()
200 Mat pts1 = _pts1.getMat(); in estimateTransformation() local
202 CV_Assert((pts1.channels()==2) && (pts1.cols>0) && (pts2.channels()==2) && (pts2.cols>0)); in estimateTransformation()
205 if (pts1.type() != CV_32F) in estimateTransformation()
206 pts1.convertTo(pts1, CV_32F); in estimateTransformation()
214 if (_matches[i].queryIdx<pts1.cols && in estimateTransformation()
[all …]
/dports/graphics/opencv/opencv-4.5.3/samples/python/
H A Dessential_mat_reconstr.py5 pts1 = np.concatenate((pts1_.T, np.ones((1, pts1_.shape[0]))))[:,inliers]
7 lines2 = np.dot(F , pts1)
10 …return np.median((np.abs(np.sum(pts1 * lines1, axis=0)) / np.sqrt(lines1[0,:]**2 + lines1[1,:]**2)…
53 pts1 = []; pts2 = [] variable
57 pts1.append(keypoints1[m[0].queryIdx].pt)
59 pts1 = np.array(pts1); pts2 = np.array(pts2) variable
60 print('points size', pts1.shape[0])
64 E, inliers = cv.findEssentialMat(pts1, pts2, K, cv.RANSAC, 0.999, 1.0)
67 (np.dot(np.linalg.inv(K).T, np.dot(E, np.linalg.inv(K))), pts1, pts2, inliers.squeeze()),
84 for i, (pt1, pt2) in enumerate(zip(pts1, pts2)):
[all …]
/dports/misc/vxl/vxl-3.3.2/contrib/mul/msm/
H A Dmsm_zoom_aligner.cxx90 { vgl_point_2d<double> cog1 = pts1.cog(); in calc_transform()
92 const double* p1 = pts1.vector().begin(); in calc_transform()
94 const double* p1_end = pts1.vector().end(); in calc_transform()
143 const double* p1 = pts1.vector().begin(); in calc_transform_wt()
146 assert(wts.size()==pts1.size()); in calc_transform_wt()
147 const double* p1_end = pts1.vector().end(); in calc_transform_wt()
178 assert(pts2.size()==pts1.size()); in calc_transform_wt_mat()
179 assert(wt_mat.size()==pts1.size()); in calc_transform_wt_mat()
184 const double* p1 = pts1.vector().begin(); in calc_transform_wt_mat()
186 const double* p1_end = pts1.vector().end(); in calc_transform_wt_mat()
[all …]
/dports/math/eigen3/eigen-3.3.9/test/
H A Dgeo_homogeneous.cpp80 Matrix<Scalar, Size+1, Dynamic> pts1, pts2; in homogeneous() local
86 pts1 = pts.colwise().homogeneous(); in homogeneous()
87 VERIFY_IS_APPROX(aff * pts.colwise().homogeneous(), (aff * pts1).colwise().hnormalized()); in homogeneous()
88 VERIFY_IS_APPROX(caff * pts.colwise().homogeneous(), (caff * pts1).colwise().hnormalized()); in homogeneous()
89 VERIFY_IS_APPROX(proj * pts.colwise().homogeneous(), (proj * pts1)); in homogeneous()
91 VERIFY_IS_APPROX((aff * pts1).colwise().hnormalized(), aff * pts); in homogeneous()
92 VERIFY_IS_APPROX((caff * pts1).colwise().hnormalized(), caff * pts); in homogeneous()
94 pts2 = pts1; in homogeneous()
107 (Matrix<Scalar, Size+1, Dynamic>(t2 * pts1).colwise().hnormalized()) ); in homogeneous()
110 …yProduct ( pts.colwise().homogeneous() )).colwise().hnormalized(), (t2 * pts1).colwise().hnormali… in homogeneous()
[all …]
/dports/math/stanmath/math-4.2.0/lib/eigen_3.3.9/test/
H A Dgeo_homogeneous.cpp80 Matrix<Scalar, Size+1, Dynamic> pts1, pts2; in homogeneous() local
86 pts1 = pts.colwise().homogeneous(); in homogeneous()
87 VERIFY_IS_APPROX(aff * pts.colwise().homogeneous(), (aff * pts1).colwise().hnormalized()); in homogeneous()
88 VERIFY_IS_APPROX(caff * pts.colwise().homogeneous(), (caff * pts1).colwise().hnormalized()); in homogeneous()
89 VERIFY_IS_APPROX(proj * pts.colwise().homogeneous(), (proj * pts1)); in homogeneous()
91 VERIFY_IS_APPROX((aff * pts1).colwise().hnormalized(), aff * pts); in homogeneous()
92 VERIFY_IS_APPROX((caff * pts1).colwise().hnormalized(), caff * pts); in homogeneous()
94 pts2 = pts1; in homogeneous()
107 (Matrix<Scalar, Size+1, Dynamic>(t2 * pts1).colwise().hnormalized()) ); in homogeneous()
110 …yProduct ( pts.colwise().homogeneous() )).colwise().hnormalized(), (t2 * pts1).colwise().hnormali… in homogeneous()
[all …]
/dports/math/libsemigroups/libsemigroups-1.3.7/extern/eigen-3.3.7/test/
H A Dgeo_homogeneous.cpp80 Matrix<Scalar, Size+1, Dynamic> pts1, pts2; in homogeneous() local
86 pts1 = pts.colwise().homogeneous(); in homogeneous()
87 VERIFY_IS_APPROX(aff * pts.colwise().homogeneous(), (aff * pts1).colwise().hnormalized()); in homogeneous()
88 VERIFY_IS_APPROX(caff * pts.colwise().homogeneous(), (caff * pts1).colwise().hnormalized()); in homogeneous()
89 VERIFY_IS_APPROX(proj * pts.colwise().homogeneous(), (proj * pts1)); in homogeneous()
91 VERIFY_IS_APPROX((aff * pts1).colwise().hnormalized(), aff * pts); in homogeneous()
92 VERIFY_IS_APPROX((caff * pts1).colwise().hnormalized(), caff * pts); in homogeneous()
94 pts2 = pts1; in homogeneous()
107 (Matrix<Scalar, Size+1, Dynamic>(t2 * pts1).colwise().hnormalized()) ); in homogeneous()
110 …yProduct ( pts.colwise().homogeneous() )).colwise().hnormalized(), (t2 * pts1).colwise().hnormali… in homogeneous()
[all …]
/dports/misc/opennn/opennn-5.0.5/eigen/test/
H A Dgeo_homogeneous.cpp80 Matrix<Scalar, Size+1, Dynamic> pts1, pts2; in homogeneous() local
86 pts1 = pts.colwise().homogeneous(); in homogeneous()
87 VERIFY_IS_APPROX(aff * pts.colwise().homogeneous(), (aff * pts1).colwise().hnormalized()); in homogeneous()
88 VERIFY_IS_APPROX(caff * pts.colwise().homogeneous(), (caff * pts1).colwise().hnormalized()); in homogeneous()
89 VERIFY_IS_APPROX(proj * pts.colwise().homogeneous(), (proj * pts1)); in homogeneous()
91 VERIFY_IS_APPROX((aff * pts1).colwise().hnormalized(), aff * pts); in homogeneous()
92 VERIFY_IS_APPROX((caff * pts1).colwise().hnormalized(), caff * pts); in homogeneous()
94 pts2 = pts1; in homogeneous()
107 (Matrix<Scalar, Size+1, Dynamic>(t2 * pts1).colwise().hnormalized()) ); in homogeneous()
110 …yProduct ( pts.colwise().homogeneous() )).colwise().hnormalized(), (t2 * pts1).colwise().hnormali… in homogeneous()
[all …]

12345678910>>...19