16 #include <Eigen/Dense> 18 #include <Eigen/StdVector> 19 #include <unsupported/Eigen/Polynomials> 24 Eigen::MatrixXd obj_pts_, Eigen::MatrixXd img_pts_, Eigen::MatrixXd cam_,
36 for (
int i = 0; i <
n; i++)
Q.col(i) =
Q.col(i) /
Q.col(i).norm();
43 Eigen::Ref<Eigen::Matrix3d> R_, Eigen::Ref<Eigen::Vector3d> t_)
48 Q(0, i1) * Q(0, i2) + Q(1, i1) * Q(1, i2) + Q(2, i1) * Q(2, i2);
50 Eigen::MatrixXi rij(
n, 2);
52 R_ = Eigen::MatrixXd::Identity(3, 3);
53 t_ = Eigen::Vector3d::Zero();
55 for (
int i = 0; i <
n; i++)
56 for (
int j = 0; j < 2; j++) rij(i, j) = rand() %
n;
58 for (
int ii = 0; ii <
n; ii++)
60 int i = rij(ii, 0), j = rij(ii, 1);
64 double l = Q(0, i) * Q(0, j) + Q(1, i) * Q(1, j) + Q(2, i) * Q(2, j);
75 Eigen::Vector3d p1, p2, p0,
x,
y,
z, dum_vec;
84 if (std::abs(
x(1)) < std::abs(
x(2)))
107 for (
int i = 0; i <
n; i++) P.col(i) = R0.transpose() * (P.col(i) - p0);
112 Eigen::Vector3d
v1 = Q.col(i1),
v2 = Q.col(i2);
113 double cg1 =
v1.dot(
v2);
114 double sg1 = sqrt(1 - cg1 * cg1);
115 double D1 = (P.col(i1) - P.col(i2)).
norm();
116 Eigen::MatrixXd D4(
n - 2, 5);
120 Eigen::VectorXd rowvec(5);
121 for (
int i = 0; i <
n; i++)
123 if (i == i1 || i == i2)
continue;
126 double cg2 =
v1.dot(vi);
127 double cg3 =
v2.dot(vi);
128 double sg2 = sqrt(1 - cg2 * cg2);
129 double D2 = (P.col(i1) - P.col(i)).
norm();
130 double D3 = (P.col(i) - P.col(i2)).
norm();
134 rowvec = getp3p(cg1, cg2, cg3, sg1, sg2, D1, D2, D3);
138 if (j >
n - 3)
break;
141 Eigen::VectorXd D7(8), dumvec(8), dumvec1(5);
144 for (
int i = 0; i <
n - 2; i++)
147 dumvec = getpoly7(dumvec1);
151 Eigen::PolynomialSolver<double, 7> psolve(D7.reverse());
152 Eigen::VectorXcd comp_roots = psolve.roots().transpose();
153 Eigen::VectorXd real_comp, imag_comp;
154 real_comp = comp_roots.real();
155 imag_comp = comp_roots.imag();
157 Eigen::VectorXd::Index max_index;
159 double max_real = real_comp.cwiseAbs().maxCoeff(&max_index);
161 std::vector<double> act_roots_;
165 for (
int i = 0; i < imag_comp.size(); i++)
167 if (std::abs(imag_comp(i)) / max_real < 0.001)
169 act_roots_.push_back(real_comp(i));
174 double* ptr = &act_roots_[0];
175 Eigen::Map<Eigen::VectorXd> act_roots(ptr, cnt);
182 Eigen::VectorXd act_roots1(cnt);
183 act_roots1 << act_roots.segment(0, cnt);
185 std::vector<Eigen::Matrix3d> R_cum(cnt);
186 std::vector<Eigen::Vector3d> t_cum(cnt);
187 std::vector<double> err_cum(cnt);
189 for (
int i = 0; i < cnt; i++)
191 double root = act_roots(i);
195 double d2 = cg1 + root;
197 Eigen::Vector3d unitx, unity, unitz;
203 if (std::abs(unity.dot(
x)) < std::abs(unitz.dot(
x)))
223 Eigen::MatrixXd D(2 *
n, 6);
228 Eigen::Map<Eigen::VectorXd>(R0.data(), R0.cols() * R0.rows()));
230 for (
int j = 0; j <
n; j++)
232 double ui = img_pts(j, 0), vi = img_pts(j, 1), xi = P(0, j),
233 yi = P(1, j), zi = P(2, j);
234 D.row(2 * j) << -
r(1) * yi + ui * (
r(7) * yi +
r(8) * zi) -
236 -
r(2) * yi + ui * (
r(8) * yi -
r(7) * zi) +
r(1) * zi, -1, 0,
237 ui, ui *
r(6) * xi -
r(0) * xi;
240 << -
r(4) * yi + vi * (
r(7) * yi +
r(8) * zi) -
r(5) * zi,
241 -
r(5) * yi + vi * (
r(8) * yi -
r(7) * zi) +
r(4) * zi, 0, -1,
242 vi, vi *
r(6) * xi -
r(3) * xi;
245 Eigen::MatrixXd DTD = D.transpose() * D;
247 Eigen::EigenSolver<Eigen::MatrixXd> es(DTD);
249 Eigen::VectorXd Diag = es.pseudoEigenvalueMatrix().diagonal();
251 Eigen::MatrixXd V_mat = es.pseudoEigenvectors();
253 Eigen::MatrixXd::Index min_index;
255 Diag.minCoeff(&min_index);
257 Eigen::VectorXd V = V_mat.col(min_index);
261 double c = V(0),
s = V(1);
262 t << V(2), V(3), V(4);
265 Eigen::VectorXd xi, yi, zi;
270 Eigen::MatrixXd XXcs(3,
n), XXc(3,
n);
273 XXcs.row(0) =
r(0) * xi + (
r(1) *
c +
r(2) *
s) * yi +
274 (-
r(1) *
s +
r(2) *
c) * zi +
275 t(0) * Eigen::VectorXd::Ones(
n);
276 XXcs.row(1) =
r(3) * xi + (
r(4) *
c +
r(5) *
s) * yi +
277 (-
r(4) *
s +
r(5) *
c) * zi +
278 t(1) * Eigen::VectorXd::Ones(
n);
279 XXcs.row(2) =
r(6) * xi + (
r(7) *
c +
r(8) *
s) * yi +
280 (-
r(7) *
s +
r(8) *
c) * zi +
281 t(2) * Eigen::VectorXd::Ones(
n);
283 for (
int ii = 0; ii <
n; ii++)
284 XXc.col(ii) = Q.col(ii) * XXcs.col(ii).norm();
289 Eigen::MatrixXd XXw = obj_pts.transpose();
291 calcampose(XXc, XXw, R2, t2);
296 for (
int k = 0; k <
n; k++) XXc.col(k) = R2 * XXw.col(k) + t2;
298 Eigen::MatrixXd xxc(2,
n);
300 xxc.row(0) = XXc.row(0).array() / XXc.row(2).array();
301 xxc.row(1) = XXc.row(1).array() / XXc.row(2).array();
303 double res = ((xxc.row(0) - img_pts.col(0).transpose()).
norm() +
304 (xxc.row(1) - img_pts.col(1).transpose()).
norm()) /
311 std::min_element(err_cum.begin(), err_cum.end()) - err_cum.begin();
320 Eigen::MatrixXd& XXc, Eigen::MatrixXd& XXw, Eigen::Matrix3d& R2,
323 Eigen::MatrixXd X = XXc;
324 Eigen::MatrixXd Y = XXw;
326 Eigen::MatrixXd::Identity(
n,
n) - Eigen::MatrixXd::Ones(
n,
n) * 1 /
n;
327 Eigen::VectorXd ux, uy;
328 uy = X.rowwise().mean();
329 ux = Y.rowwise().mean();
333 (((X * K).array() * (X * K).array()).colwise().sum()).
mean();
335 Eigen::MatrixXd SXY = Y * K * (X.transpose()) /
n;
337 Eigen::JacobiSVD<Eigen::MatrixXd> svd(
338 SXY, Eigen::ComputeThinU | Eigen::ComputeThinV);
340 Eigen::Matrix3d S = Eigen::MatrixXd::Identity(3, 3);
341 if (SXY.determinant() < 0) S(2, 2) = -1;
343 R2 = svd.matrixV() * S * svd.matrixU().transpose();
345 double c2 = (svd.singularValues().asDiagonal() * S).trace() / sigmax2;
346 t2 = uy - c2 * R2 * ux;
348 Eigen::Vector3d
x,
y,
z;
353 if ((
x.cross(
y) -
z).
norm() > 0.02) R2.col(2) = -R2.col(2);
358 Eigen::VectorXd vout(8);
359 vout << 4 * pow(vin(0), 2), 7 * vin(1) * vin(0),
360 6 * vin(2) * vin(0) + 3 * pow(vin(1), 2),
361 5 * vin(3) * vin(0) + 5 * vin(2) * vin(1),
362 4 * vin(4) * vin(0) + 4 * vin(3) * vin(1) + 2 * pow(vin(2), 2),
363 3 * vin(4) * vin(1) + 3 * vin(3) * vin(2),
364 2 * vin(4) * vin(2) + pow(vin(3), 2), vin(4) * vin(3);
369 double l1,
double l2,
double A5,
double C1,
double C2,
double D1,
double D2,
372 double A1 = (D2 / D1) * (D2 / D1);
373 double A2 =
A1 * pow(C1, 2) - pow(C2, 2);
374 double A3 = l2 * A5 - l1;
375 double A4 = l1 * A5 - l2;
376 double A6 = (pow(D3, 2) - pow(D1, 2) - pow(D2, 2)) / (2 * pow(D1, 2));
377 double A7 = 1 - pow(l1, 2) - pow(l2, 2) + l1 * l2 * A5 + A6 * pow(C1, 2);
379 Eigen::VectorXd vec(5);
381 vec << pow(A6, 2) -
A1 * pow(A5, 2), 2 * (A3 * A6 -
A1 * A4 * A5),
382 pow(A3, 2) + 2 * A6 * A7 -
A1 * pow(A4, 2) - A2 * pow(A5, 2),
383 2 * (A3 * A7 - A2 * A4 * A5), pow(A7, 2) - A2 * pow(A4, 2);
Eigen::MatrixXd P
Camera Intrinsic Matrix.
void calcampose(Eigen::MatrixXd &XXc, Eigen::MatrixXd &XXw, Eigen::Matrix3d &R2, Eigen::Vector3d &t2)
Function to calculate final pose.
Eigen::MatrixXd cam_intrinsic
Image Points (n X 3) in Camera Co-ordinate system.
rpnp(Eigen::MatrixXd obj_pts_, Eigen::MatrixXd img_pts_, Eigen::MatrixXd cam_, int n0)
Number of 2D/3D correspondences.
Eigen::VectorXd getp3p(double l1, double l2, double A5, double C1, double C2, double D1, double D2, double D3)
Function to compute pose using P3P.
Eigen::MatrixXd img_pts
Object Points (n X 3) in Camera Co-ordinate system.
Robust - PnP class definition for computing pose.
bool compute_pose(Eigen::Ref< Eigen::Matrix3d > R_, Eigen::Ref< Eigen::Vector3d > t_)
Function to compute pose.
GLdouble GLdouble GLdouble r
Eigen::MatrixXd Q
Transposed Object Points (3 X n) for computations.
Eigen::Matrix3d R
Transposed Image Points (3 X n) for computations.
Eigen::VectorXd getpoly7(const Eigen::VectorXd &vin)
Get Polynomial from input vector.
GLfloat GLfloat GLfloat v2
EIGEN_STRONG_INLINE double mean() const
Computes the mean of the entire matrix.
CONTAINER::Scalar norm(const CONTAINER &v)