orb_slam3_details/src/Optimizer.cc

6642 lines
264 KiB
C++
Raw Normal View History

2020-12-01 11:58:17 +08:00
/**
2022-07-21 21:32:11 +08:00
* This file is part of ORB-SLAM3
*
* Copyright (C) 2017-2021 Carlos Campos, Richard Elvira, Juan J. Gómez Rodríguez, José M.M. Montiel and Juan D. Tardós, University of Zaragoza.
* Copyright (C) 2014-2016 Raúl Mur-Artal, José M.M. Montiel and Juan D. Tardós, University of Zaragoza.
*
* ORB-SLAM3 is free software: you can redistribute it and/or modify it under the terms of the GNU General Public
* License as published by the Free Software Foundation, either version 3 of the License, or
* (at your option) any later version.
*
* ORB-SLAM3 is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even
* the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
* GNU General Public License for more details.
*
* You should have received a copy of the GNU General Public License along with ORB-SLAM3.
* If not, see <http://www.gnu.org/licenses/>.
*/
2020-12-01 11:58:17 +08:00
#include "Optimizer.h"
#include <complex>
#include <Eigen/StdVector>
#include <Eigen/Dense>
#include <unsupported/Eigen/MatrixFunctions>
#include "Thirdparty/g2o/g2o/core/sparse_block_matrix.h"
#include "Thirdparty/g2o/g2o/core/block_solver.h"
#include "Thirdparty/g2o/g2o/core/optimization_algorithm_levenberg.h"
#include "Thirdparty/g2o/g2o/core/optimization_algorithm_gauss_newton.h"
#include "Thirdparty/g2o/g2o/solvers/linear_solver_eigen.h"
#include "Thirdparty/g2o/g2o/types/types_six_dof_expmap.h"
#include "Thirdparty/g2o/g2o/core/robust_kernel_impl.h"
#include "Thirdparty/g2o/g2o/solvers/linear_solver_dense.h"
#include "G2oTypes.h"
#include "Converter.h"
2022-07-21 21:32:11 +08:00
#include <mutex>
2020-12-01 11:58:17 +08:00
#include "OptimizableTypes.h"
namespace ORB_SLAM3
{
2022-07-21 21:32:11 +08:00
bool sortByVal(const pair<MapPoint *, int> &a, const pair<MapPoint *, int> &b)
2020-12-01 11:58:17 +08:00
{
return (a.second < b.second);
}
2022-07-21 21:32:11 +08:00
/**************************************以下为单帧优化**************************************************************/
2022-03-28 21:20:28 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief 姿使姿
* @param pFrame
*/
2022-07-21 21:32:11 +08:00
int Optimizer::PoseOptimization(Frame *pFrame)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 该优化函数主要用于Tracking线程中运动跟踪、参考帧跟踪、地图跟踪、重定位
// Step 1构造g2o优化器, BlockSolver_6_3表示位姿 _PoseDim 为6维路标点 _LandmarkDim 是3维
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
linearSolver = new g2o::LinearSolverDense<g2o::BlockSolver_6_3::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3 *solver_ptr = new g2o::BlockSolver_6_3(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
optimizer.setAlgorithm(solver);
2022-07-21 22:27:32 +08:00
// 输入的帧中,有效的,参与优化过程的2D-3D点对
2022-07-21 21:32:11 +08:00
int nInitialCorrespondences = 0;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Frame vertex
2022-07-21 22:27:32 +08:00
// Step 2添加顶点待优化当前帧的Tcw
2022-07-21 21:32:11 +08:00
g2o::VertexSE3Expmap *vSE3 = new g2o::VertexSE3Expmap();
Sophus::SE3<float> Tcw = pFrame->GetPose();
vSE3->setEstimate(g2o::SE3Quat(Tcw.unit_quaternion().cast<double>(), Tcw.translation().cast<double>()));
2022-07-21 22:27:32 +08:00
// 设置id保证本次优化过程中id独立即可
2022-07-21 21:32:11 +08:00
vSE3->setId(0);
2022-07-21 22:27:32 +08:00
// 要优化的变量,所以不能固定
2022-07-21 21:32:11 +08:00
vSE3->setFixed(false);
2022-07-21 22:27:32 +08:00
// 添加节点
2022-07-21 21:32:11 +08:00
optimizer.addVertex(vSE3);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
// 当前帧的特征点数量
2022-07-21 21:32:11 +08:00
const int N = pFrame->N;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
vector<ORB_SLAM3::EdgeSE3ProjectXYZOnlyPose *> vpEdgesMono; // 存放单目边
vector<ORB_SLAM3::EdgeSE3ProjectXYZOnlyPoseToBody *> vpEdgesMono_FHR; // 存放另一目的边
vector<size_t> vnIndexEdgeMono, vnIndexEdgeRight; // 边对应特征点的id
2022-07-21 21:32:11 +08:00
vpEdgesMono.reserve(N);
vpEdgesMono_FHR.reserve(N);
vnIndexEdgeMono.reserve(N);
vnIndexEdgeRight.reserve(N);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
vector<g2o::EdgeStereoSE3ProjectXYZOnlyPose *> vpEdgesStereo; // 存放双目边
2022-07-21 21:32:11 +08:00
vector<size_t> vnIndexEdgeStereo;
vpEdgesStereo.reserve(N);
vnIndexEdgeStereo.reserve(N);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 自由度为2的卡方分布显著性水平为0.05对应的临界阈值5.991
// 可以理解为卡方值高于5.991 95%的几率维外点
2022-07-21 21:32:11 +08:00
const float deltaMono = sqrt(5.991);
2022-07-21 22:27:32 +08:00
// 自由度为3的卡方分布显著性水平为0.05对应的临界阈值7.815
2022-07-21 21:32:11 +08:00
const float deltaStereo = sqrt(7.815);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// Step 3添加一元边
2022-07-21 21:32:11 +08:00
{
2022-07-21 22:27:32 +08:00
// 锁定地图点。由于需要使用地图点来构造顶点和边,因此不希望在构造的过程中部分地图点被改写造成不一致甚至是段错误
2022-07-21 21:32:11 +08:00
unique_lock<mutex> lock(MapPoint::mGlobalMutex);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 遍历当前帧中的所有地图点
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
{
MapPoint *pMP = pFrame->mvpMapPoints[i];
2022-07-21 22:27:32 +08:00
// 如果这个地图点还存在没有被剔除掉
2022-07-21 21:32:11 +08:00
if (pMP)
{
// Conventional SLAM
2022-07-21 22:27:32 +08:00
// 不存在相机2则有可能为单目与双目
2022-07-21 21:32:11 +08:00
if (!pFrame->mpCamera2)
{
// Monocular observation
2022-07-21 22:27:32 +08:00
// 单目情况因为双目模式下pFrame->mvuRight[i]会大于0
2022-07-21 21:32:11 +08:00
if (pFrame->mvuRight[i] < 0)
{
nInitialCorrespondences++;
pFrame->mvbOutlier[i] = false;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 对这个地图点的观测,也就是去畸变像素坐标
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
const cv::KeyPoint &kpUn = pFrame->mvKeysUn[i];
obs << kpUn.pt.x, kpUn.pt.y;
2022-07-21 22:27:32 +08:00
// 新建节点,注意这个节点的只是优化位姿Pose
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZOnlyPose *e = new ORB_SLAM3::EdgeSE3ProjectXYZOnlyPose();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(0)));
e->setMeasurement(obs);
2022-07-21 22:27:32 +08:00
// 这个点的可信程度和特征点所在的图层有关层数约高invSigma2越小信息矩阵越小表示误差越大优化时考虑的比较少
2022-07-21 21:32:11 +08:00
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave];
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2022-07-21 22:27:32 +08:00
// 在这里使用了鲁棒核函数
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(deltaMono);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 设置相机
2022-07-21 21:32:11 +08:00
e->pCamera = pFrame->mpCamera;
2022-07-21 22:27:32 +08:00
// 地图点的空间位置,作为迭代的初始值,因为是一元边,所以不以节点的形式出现
2022-07-21 21:32:11 +08:00
e->Xw = pMP->GetWorldPos().cast<double>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesMono.push_back(e);
vnIndexEdgeMono.push_back(i);
}
2022-07-21 22:27:32 +08:00
else // 双目
2022-07-21 21:32:11 +08:00
{
nInitialCorrespondences++;
pFrame->mvbOutlier[i] = false;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// SET EDGE
// 观测多了一项右目的坐标
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 3, 1> obs;
const cv::KeyPoint &kpUn = pFrame->mvKeysUn[i];
const float &kp_ur = pFrame->mvuRight[i];
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2022-07-21 22:27:32 +08:00
// 新建节点,注意这里也是只优化位姿
2022-07-21 21:32:11 +08:00
g2o::EdgeStereoSE3ProjectXYZOnlyPose *e = new g2o::EdgeStereoSE3ProjectXYZOnlyPose();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(0)));
e->setMeasurement(obs);
2022-07-21 22:27:32 +08:00
// 置信程度主要是看左目特征点所在的图层
2022-07-21 21:32:11 +08:00
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave];
Eigen::Matrix3d Info = Eigen::Matrix3d::Identity() * invSigma2;
e->setInformation(Info);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(deltaStereo);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 双目下没有加入相机
2022-07-21 21:32:11 +08:00
e->fx = pFrame->fx;
e->fy = pFrame->fy;
e->cx = pFrame->cx;
e->cy = pFrame->cy;
e->bf = pFrame->mbf;
e->Xw = pMP->GetWorldPos().cast<double>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesStereo.push_back(e);
vnIndexEdgeStereo.push_back(i);
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// SLAM with respect a rigid body
2022-07-21 22:27:32 +08:00
else // 两个相机
2022-07-21 21:32:11 +08:00
{
nInitialCorrespondences++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
cv::KeyPoint kpUn;
2022-07-21 22:27:32 +08:00
// 总数N = 相机1所有特征点数量+相机2所有特征点数量
2022-07-21 21:32:11 +08:00
if (i < pFrame->Nleft)
{ // Left camera observation
kpUn = pFrame->mvKeys[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[i] = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZOnlyPose *e = new ORB_SLAM3::EdgeSE3ProjectXYZOnlyPose();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(0)));
e->setMeasurement(obs);
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave];
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(deltaMono);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->pCamera = pFrame->mpCamera;
e->Xw = pMP->GetWorldPos().cast<double>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesMono.push_back(e);
vnIndexEdgeMono.push_back(i);
}
else
2022-07-21 22:27:32 +08:00
{ // Right camera observation
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeysRight[i - pFrame->Nleft];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[i] = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZOnlyPoseToBody *e = new ORB_SLAM3::EdgeSE3ProjectXYZOnlyPoseToBody();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(0)));
e->setMeasurement(obs);
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave];
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(deltaMono);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->pCamera = pFrame->mpCamera2;
e->Xw = pMP->GetWorldPos().cast<double>();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
e->mTrl = g2o::SE3Quat(
pFrame->GetRelativePoseTrl().unit_quaternion().cast<double>(), pFrame->GetRelativePoseTrl().translation().cast<double>());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesMono_FHR.push_back(e);
vnIndexEdgeRight.push_back(i);
}
2020-12-01 11:58:17 +08:00
}
}
}
}
2022-07-21 22:27:32 +08:00
// 如果没有足够的匹配点,那么就只好放弃了
// cout << "PO: vnIndexEdgeMono.size() = " << vnIndexEdgeMono.size() << " vnIndexEdgeRight.size() = " << vnIndexEdgeRight.size() << endl;
2022-07-21 21:32:11 +08:00
if (nInitialCorrespondences < 3)
return 0;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// We perform 4 optimizations, after each optimization we classify observation as inlier/outlier
// At the next optimization, outliers are not included, but at the end they can be classified as inliers again.
2022-07-21 22:27:32 +08:00
// Step 4开始优化总共优化四次每次优化迭代10次,每次优化后将观测分为outlier和inlieroutlier不参与下次优化
// 由于每次优化后是对所有的观测进行outlier和inlier判别因此之前被判别为outlier有可能变成inlier反之亦然
// 基于卡方检验计算出的阈值(假设测量有一个像素的偏差)
const float chi2Mono[4] = {5.991, 5.991, 5.991, 5.991}; // 单目
const float chi2Stereo[4] = {7.815, 7.815, 7.815, 7.815}; // 双目
const int its[4] = {10, 10, 10, 10}; // 四次迭代,每次迭代的次数
// bad 的地图点个数
2022-07-21 21:32:11 +08:00
int nBad = 0;
2022-07-21 22:27:32 +08:00
// 一共进行四次优化,每次会剔除外点
2022-07-21 21:32:11 +08:00
for (size_t it = 0; it < 4; it++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
Tcw = pFrame->GetPose();
vSE3->setEstimate(g2o::SE3Quat(Tcw.unit_quaternion().cast<double>(), Tcw.translation().cast<double>()));
2022-07-21 22:27:32 +08:00
// 其实就是初始化优化器,这里的参数0就算是不填写,默认也是0,也就是只对level为0的边进行优化
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization(0);
2022-07-21 22:27:32 +08:00
// 开始优化优化10次
2022-07-21 21:32:11 +08:00
optimizer.optimize(its[it]);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
nBad = 0;
2022-07-21 22:27:32 +08:00
// 优化结束,开始遍历参与优化的每一条误差边(单目或双相机的相机1)
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
{
ORB_SLAM3::EdgeSE3ProjectXYZOnlyPose *e = vpEdgesMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const size_t idx = vnIndexEdgeMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 如果这条误差边是来自于outlier也就是上一次优化去掉的
// 重新计算,因为上一次外点这一次可能成为内点
2022-07-21 21:32:11 +08:00
if (pFrame->mvbOutlier[idx])
{
e->computeError();
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 就是error*\Omega*error,表征了这个点的误差大小(考虑置信度以后)
2022-07-21 21:32:11 +08:00
const float chi2 = e->chi2();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (chi2 > chi2Mono[it])
{
pFrame->mvbOutlier[idx] = true;
2022-07-21 22:27:32 +08:00
e->setLevel(1); // 设置为outlier , level 1 对应为外点,上面的过程中我们设置其为不优化
2022-07-21 21:32:11 +08:00
nBad++;
}
else
{
pFrame->mvbOutlier[idx] = false;
2022-07-21 22:27:32 +08:00
e->setLevel(0); // 设置为inlier, level 0 对应为内点,上面的过程中我们就是要优化这些关系
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (it == 2)
2022-07-21 22:27:32 +08:00
e->setRobustKernel(0); // 除了前两次优化需要RobustKernel以外, 其余的优化都不需要 -- 因为重投影的误差已经有明显的下降了
2022-07-21 21:32:11 +08:00
}
2022-07-21 22:27:32 +08:00
// 对于相机2
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesMono_FHR.size(); i < iend; i++)
{
ORB_SLAM3::EdgeSE3ProjectXYZOnlyPoseToBody *e = vpEdgesMono_FHR[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const size_t idx = vnIndexEdgeRight[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pFrame->mvbOutlier[idx])
{
e->computeError();
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float chi2 = e->chi2();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (chi2 > chi2Mono[it])
{
pFrame->mvbOutlier[idx] = true;
e->setLevel(1);
nBad++;
}
else
{
pFrame->mvbOutlier[idx] = false;
e->setLevel(0);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
if (it == 2)
e->setRobustKernel(0);
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 对于双目
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
g2o::EdgeStereoSE3ProjectXYZOnlyPose *e = vpEdgesStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const size_t idx = vnIndexEdgeStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pFrame->mvbOutlier[idx])
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
e->computeError();
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
const float chi2 = e->chi2();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (chi2 > chi2Stereo[it])
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = true;
e->setLevel(1);
nBad++;
}
else
{
e->setLevel(0);
pFrame->mvbOutlier[idx] = false;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (it == 2)
e->setRobustKernel(0);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (optimizer.edges().size() < 10)
break;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Recover optimized pose and return number of inliers
2022-07-21 22:27:32 +08:00
// Step 5 得到优化后的当前帧的位姿
2022-07-21 21:32:11 +08:00
g2o::VertexSE3Expmap *vSE3_recov = static_cast<g2o::VertexSE3Expmap *>(optimizer.vertex(0));
g2o::SE3Quat SE3quat_recov = vSE3_recov->estimate();
2022-07-21 22:27:32 +08:00
Sophus::SE3<float> pose(
SE3quat_recov.rotation().cast<float>(),
SE3quat_recov.translation().cast<float>());
2022-07-21 21:32:11 +08:00
pFrame->SetPose(pose);
2022-03-28 21:20:28 +08:00
2022-07-21 22:27:32 +08:00
// 并且返回内点数目
2022-07-21 21:32:11 +08:00
return nInitialCorrespondences - nBad;
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief 使+IMU姿
*
*
* // Step 1创建g2o优化器初始化顶点和边
* // Step 2启动多轮优化剔除外点
* // Step 3更新当前帧位姿、速度、IMU偏置
* // Step 4记录当前帧的优化状态包括参数信息和对应的海森矩阵
*
* @param[in] pFrame
* @param[in] bRecInit false
* @return int
*/
2022-07-21 21:32:11 +08:00
int Optimizer::PoseInertialOptimizationLastKeyFrame(Frame *pFrame, bool bRecInit)
{
2022-07-21 22:27:32 +08:00
// 1. 创建g2o优化器初始化顶点和边
// 构建一个稀疏求解器
2022-07-21 21:32:11 +08:00
g2o::SparseOptimizer optimizer;
g2o::BlockSolverX::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 使用dense的求解器常见非dense求解器有cholmod线性求解器和shur补线性求解器
2022-07-21 21:32:11 +08:00
linearSolver = new g2o::LinearSolverDense<g2o::BlockSolverX::PoseMatrixType>();
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2022-07-21 22:27:32 +08:00
// 使用高斯牛顿求解器
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmGaussNewton *solver = new g2o::OptimizationAlgorithmGaussNewton(solver_ptr);
optimizer.setVerbose(false);
optimizer.setAlgorithm(solver);
2022-03-28 21:20:28 +08:00
2022-07-21 22:27:32 +08:00
// 当前帧单(左)目地图点数目
2022-07-21 21:32:11 +08:00
int nInitialMonoCorrespondences = 0;
int nInitialStereoCorrespondences = 0;
2022-07-21 22:27:32 +08:00
//上面两项的和,即参与优化的地图点总数目
2022-07-21 21:32:11 +08:00
int nInitialCorrespondences = 0;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Frame vertex
2022-07-21 22:27:32 +08:00
// 2. 确定节点
// 当前帧的位姿,旋转+平移6-dim
2022-07-21 21:32:11 +08:00
VertexPose *VP = new VertexPose(pFrame);
VP->setId(0);
VP->setFixed(false);
optimizer.addVertex(VP);
2022-07-21 22:27:32 +08:00
// 当前帧的速度3-dim
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = new VertexVelocity(pFrame);
VV->setId(1);
VV->setFixed(false);
optimizer.addVertex(VV);
2022-07-21 22:27:32 +08:00
// 当前帧的陀螺仪偏置3-dim
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG = new VertexGyroBias(pFrame);
VG->setId(2);
VG->setFixed(false);
optimizer.addVertex(VG);
2022-07-21 22:27:32 +08:00
// 当前帧的加速度偏置3-dim
2022-07-21 21:32:11 +08:00
VertexAccBias *VA = new VertexAccBias(pFrame);
VA->setId(3);
VA->setFixed(false);
optimizer.addVertex(VA);
2022-07-21 22:27:32 +08:00
// setFixed(false)这个设置使以上四个顶点15个参数在优化时更新
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
// 当前帧的特征点总数
2022-07-21 21:32:11 +08:00
const int N = pFrame->N;
2022-07-21 22:27:32 +08:00
// 当前帧左目的特征点总数
2022-07-21 21:32:11 +08:00
const int Nleft = pFrame->Nleft;
2022-07-21 22:27:32 +08:00
// 当前帧是否存在右目(即是否为双目)
2022-07-21 21:32:11 +08:00
const bool bRight = (Nleft != -1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<EdgeMonoOnlyPose *> vpEdgesMono;
vector<EdgeStereoOnlyPose *> vpEdgesStereo;
vector<size_t> vnIndexEdgeMono;
vector<size_t> vnIndexEdgeStereo;
vpEdgesMono.reserve(N);
vpEdgesStereo.reserve(N);
vnIndexEdgeMono.reserve(N);
vnIndexEdgeStereo.reserve(N);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 自由度为2的卡方分布显著性水平为0.05对应的临界阈值5.991
2020-12-01 11:58:17 +08:00
const float thHuberMono = sqrt(5.991);
2022-07-21 22:27:32 +08:00
// 自由度为3的卡方分布显著性水平为0.05对应的临界阈值7.815
2020-12-01 11:58:17 +08:00
const float thHuberStereo = sqrt(7.815);
{
2022-07-21 22:27:32 +08:00
// 锁定地图点。由于需要使用地图点来构造顶点和边,因此不希望在构造的过程中部分地图点被改写造成不一致甚至是段错误
// 3. 投影边
2022-07-21 21:32:11 +08:00
unique_lock<mutex> lock(MapPoint::mGlobalMutex);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = pFrame->mvpMapPoints[i];
if (pMP)
2020-12-01 11:58:17 +08:00
{
cv::KeyPoint kpUn;
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
// Left monocular observation
2022-07-21 22:27:32 +08:00
// 这里说的Left monocular包含两种情况1.单目情况 2.双目情况下的左目
2022-07-21 21:32:11 +08:00
if ((!bRight && pFrame->mvuRight[i] < 0) || i < Nleft)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 如果是双目情况下的左目
2022-07-21 21:32:11 +08:00
if (i < Nleft) // pair left-right
2022-07-21 22:27:32 +08:00
//使用未畸变校正的特征点
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeys[i];
2022-07-21 22:27:32 +08:00
// 如果是单目
2022-07-21 21:32:11 +08:00
else
2022-07-21 22:27:32 +08:00
// 使用畸变校正过的特征点
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeysUn[i];
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 单目地图点计数增加
2022-07-21 21:32:11 +08:00
nInitialMonoCorrespondences++;
2022-07-21 22:27:32 +08:00
// 当前地图点默认设置为不是外点
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[i] = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 第一种边(视觉重投影约束):地图点投影到该帧图像的坐标与特征点坐标偏差尽可能小
2022-07-21 21:32:11 +08:00
EdgeMonoOnlyPose *e = new EdgeMonoOnlyPose(pMP->GetWorldPos(), 0);
2022-07-21 22:27:32 +08:00
// 将位姿作为第一个顶点
2022-07-21 21:32:11 +08:00
e->setVertex(0, VP);
2022-07-21 22:27:32 +08:00
// 设置观测值,即去畸变后的像素坐标
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
2022-07-21 22:27:32 +08:00
// 获取不确定度这里调用uncertainty2返回固定值1.0
// ?这里的1.0是作为缺省值的意思吗?是否可以根据对视觉信息的信任度动态修改这个值,比如标定的误差?
2022-07-21 21:32:11 +08:00
const float unc2 = pFrame->mpCamera->uncertainty2(obs);
2022-07-21 22:27:32 +08:00
// invSigma2 = (Inverse(协方差矩阵))^2表明该约束在各个维度上的可信度
// 图像金字塔层数越高,可信度越差
2022-07-21 21:32:11 +08:00
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave] / unc2;
2022-07-21 22:27:32 +08:00
// 设置该约束的信息矩阵
2022-07-21 21:32:11 +08:00
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2022-07-21 22:27:32 +08:00
// 设置鲁棒核函数,避免其误差的平方项出现数值过大的增长 注后续在优化2次后会用e->setRobustKernel(0)禁掉鲁棒核函数
2020-12-01 11:58:17 +08:00
e->setRobustKernel(rk);
2022-07-21 22:27:32 +08:00
// 重投影误差的自由度为2设置对应的卡方阈值
2020-12-01 11:58:17 +08:00
rk->setDelta(thHuberMono);
2022-07-21 22:27:32 +08:00
// 将第一种边加入优化器
2020-12-01 11:58:17 +08:00
optimizer.addEdge(e);
2022-07-21 21:32:11 +08:00
2022-07-21 22:27:32 +08:00
// 将第一种边加入vpEdgesMono
2022-07-21 21:32:11 +08:00
vpEdgesMono.push_back(e);
2022-07-21 22:27:32 +08:00
// 将对应的特征点索引加入vnIndexEdgeMono
2022-07-21 21:32:11 +08:00
vnIndexEdgeMono.push_back(i);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Stereo observation
else if (!bRight)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
nInitialStereoCorrespondences++;
pFrame->mvbOutlier[i] = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeysUn[i];
const float kp_ur = pFrame->mvuRight[i];
Eigen::Matrix<double, 3, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeStereoOnlyPose *e = new EdgeStereoOnlyPose(pMP->GetWorldPos());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, VP);
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
const float unc2 = pFrame->mpCamera->uncertainty2(obs.head(2));
const float &invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave] / unc2;
e->setInformation(Eigen::Matrix3d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2020-12-01 11:58:17 +08:00
e->setRobustKernel(rk);
rk->setDelta(thHuberStereo);
optimizer.addEdge(e);
2022-07-21 21:32:11 +08:00
vpEdgesStereo.push_back(e);
vnIndexEdgeStereo.push_back(i);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Right monocular observation
if (bRight && i >= Nleft)
{
nInitialMonoCorrespondences++;
pFrame->mvbOutlier[i] = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeysRight[i - Nleft];
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeMonoOnlyPose *e = new EdgeMonoOnlyPose(pMP->GetWorldPos(), 1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, VP);
e->setMeasurement(obs);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
const float unc2 = pFrame->mpCamera->uncertainty2(obs);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave] / unc2;
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
vpEdgesMono.push_back(e);
vnIndexEdgeMono.push_back(i);
2020-12-01 11:58:17 +08:00
}
}
}
2022-07-21 21:32:11 +08:00
}
2022-07-21 22:27:32 +08:00
// 统计参与优化的地图点总数目
2022-07-21 21:32:11 +08:00
nInitialCorrespondences = nInitialMonoCorrespondences + nInitialStereoCorrespondences;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 4. 上一个关键帧节点
// pKF为上一关键帧
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = pFrame->mpLastKeyFrame;
2022-07-21 22:27:32 +08:00
// 上一关键帧的位姿,旋转+平移6-dim
2022-07-21 21:32:11 +08:00
VertexPose *VPk = new VertexPose(pKF);
VPk->setId(4);
VPk->setFixed(true);
optimizer.addVertex(VPk);
2022-07-21 22:27:32 +08:00
// 上一关键帧的速度3-dim
2022-07-21 21:32:11 +08:00
VertexVelocity *VVk = new VertexVelocity(pKF);
VVk->setId(5);
VVk->setFixed(true);
optimizer.addVertex(VVk);
2022-07-21 22:27:32 +08:00
// 上一关键帧的陀螺仪偏置3-dim
2022-07-21 21:32:11 +08:00
VertexGyroBias *VGk = new VertexGyroBias(pKF);
VGk->setId(6);
VGk->setFixed(true);
optimizer.addVertex(VGk);
2022-07-21 22:27:32 +08:00
// 上一关键帧的加速度偏置3-dim
2022-07-21 21:32:11 +08:00
VertexAccBias *VAk = new VertexAccBias(pKF);
VAk->setId(7);
VAk->setFixed(true);
optimizer.addVertex(VAk);
2022-07-21 22:27:32 +08:00
// setFixed(true)这个设置使以上四个顶点15个参数的值在优化时保持固定
// 既然被选为关键帧,就不能太善变
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 5. 第二种边IMU预积分约束两帧之间位姿的变化量与IMU预积分的值偏差尽可能小
2022-07-21 21:32:11 +08:00
EdgeInertial *ei = new EdgeInertial(pFrame->mpImuPreintegrated);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 将上一关键帧四个顶点P、V、BG、BA和当前帧两个顶点P、V加入第二种边
2022-07-21 21:32:11 +08:00
ei->setVertex(0, VPk);
ei->setVertex(1, VVk);
ei->setVertex(2, VGk);
ei->setVertex(3, VAk);
ei->setVertex(4, VP);
ei->setVertex(5, VV);
2022-07-21 22:27:32 +08:00
// 把第二种边加入优化器
2022-07-21 21:32:11 +08:00
optimizer.addEdge(ei);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 6. 第三种边(陀螺仪随机游走约束):陀螺仪的随机游走值在相近帧间不会相差太多 residual=VG-VGk
// 用大白话来讲就是用固定的VGK拽住VG防止VG在优化中放飞自我
2022-07-21 21:32:11 +08:00
EdgeGyroRW *egr = new EdgeGyroRW();
2022-07-21 22:27:32 +08:00
// 将上一关键帧的BG加入第三种边
2022-07-21 21:32:11 +08:00
egr->setVertex(0, VGk);
2022-07-21 22:27:32 +08:00
// 将当前帧的BG加入第三种边
2022-07-21 21:32:11 +08:00
egr->setVertex(1, VG);
2022-07-21 22:27:32 +08:00
// C值在预积分阶段更新range(9,12)对应陀螺仪偏置的协方差最终cvInfoG值为inv(∑(GyroRW^2/freq))
2022-07-21 21:32:11 +08:00
Eigen::Matrix3d InfoG = pFrame->mpImuPreintegrated->C.block<3, 3>(9, 9).cast<double>().inverse();
egr->setInformation(InfoG);
2022-07-21 22:27:32 +08:00
// 把第三种边加入优化器
2022-07-21 21:32:11 +08:00
optimizer.addEdge(egr);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 7. 第四种边(加速度随机游走约束):加速度的随机游走值在相近帧间不会相差太多 residual=VA-VAk
// 用大白话来讲就是用固定的VAK拽住VA防止VA在优化中放飞自我
2022-07-21 21:32:11 +08:00
EdgeAccRW *ear = new EdgeAccRW();
2022-07-21 22:27:32 +08:00
// 将上一关键帧的BA加入第四种边
2022-07-21 21:32:11 +08:00
ear->setVertex(0, VAk);
2022-07-21 22:27:32 +08:00
// 将当前帧的BA加入第四种边
2022-07-21 21:32:11 +08:00
ear->setVertex(1, VA);
2022-07-21 22:27:32 +08:00
// C值在预积分阶段更新range(12,15)对应加速度偏置的协方差最终cvInfoG值为inv(∑(AccRW^2/freq))
2022-07-21 21:32:11 +08:00
Eigen::Matrix3d InfoA = pFrame->mpImuPreintegrated->C.block<3, 3>(12, 12).cast<double>().inverse();
ear->setInformation(InfoA);
2022-07-21 22:27:32 +08:00
// 把第四种边加入优化器
2022-07-21 21:32:11 +08:00
optimizer.addEdge(ear);
2022-03-28 21:20:28 +08:00
2022-07-21 22:27:32 +08:00
// 8. 启动多轮优化,剔除外点
2022-07-21 21:32:11 +08:00
// We perform 4 optimizations, after each optimization we classify observation as inlier/outlier
// At the next optimization, outliers are not included, but at the end they can be classified as inliers again.
2022-07-21 22:27:32 +08:00
// 卡方检验值呈递减趋势,目的是让检验越来越苛刻
2022-07-21 21:32:11 +08:00
float chi2Mono[4] = {12, 7.5, 5.991, 5.991};
float chi2Stereo[4] = {15.6, 9.8, 7.815, 7.815};
2022-07-21 22:27:32 +08:00
// 4次优化的迭代次数都为10
2022-07-21 21:32:11 +08:00
int its[4] = {10, 10, 10, 10};
2022-07-21 22:27:32 +08:00
// 坏点数
2022-07-21 21:32:11 +08:00
int nBad = 0;
2022-07-21 22:27:32 +08:00
// 单目坏点数
2022-07-21 21:32:11 +08:00
int nBadMono = 0;
2022-07-21 22:27:32 +08:00
// 双目坏点数
2022-07-21 21:32:11 +08:00
int nBadStereo = 0;
2022-07-21 22:27:32 +08:00
// 单目内点数
2022-07-21 21:32:11 +08:00
int nInliersMono = 0;
2022-07-21 22:27:32 +08:00
// 双目内点数
2022-07-21 21:32:11 +08:00
int nInliersStereo = 0;
2022-07-21 22:27:32 +08:00
// 内点数
2022-07-21 21:32:11 +08:00
int nInliers = 0;
2022-07-21 22:27:32 +08:00
bool bOut = false;
// 进行4次优化
2022-07-21 21:32:11 +08:00
for (size_t it = 0; it < 4; it++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 初始化优化器,这里的参数0代表只对level为0的边进行优化不传参数默认也是0
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization(0);
2022-07-21 22:27:32 +08:00
// 每次优化迭代十次
2022-07-21 21:32:11 +08:00
optimizer.optimize(its[it]);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 每次优化都重新统计各类点的数目
2022-07-21 21:32:11 +08:00
nBad = 0;
nBadMono = 0;
nBadStereo = 0;
nInliers = 0;
nInliersMono = 0;
nInliersStereo = 0;
2022-07-21 22:27:32 +08:00
// 使用1.5倍的chi2Mono作为“近点”的卡方检验值意味着地图点越近检验越宽松
// 地图点如何定义为“近点”在下面的代码中有解释
2022-07-21 21:32:11 +08:00
float chi2close = 1.5 * chi2Mono[it];
// For monocular observations
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
EdgeMonoOnlyPose *e = vpEdgesMono[i];
const size_t idx = vnIndexEdgeMono[i];
2022-07-21 22:27:32 +08:00
// 如果这条误差边是来自于outlier
2022-07-21 21:32:11 +08:00
if (pFrame->mvbOutlier[idx])
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 计算这条边上次优化后的误差
2022-07-21 21:32:11 +08:00
e->computeError();
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 就是error*\Omega*error表示了这条边考虑置信度以后的误差大小
2022-07-21 21:32:11 +08:00
const float chi2 = e->chi2();
2022-07-21 22:27:32 +08:00
// 当地图点在当前帧的深度值小于10时该地图点属于close近点
// mTrackDepth是在Frame.cc的isInFrustum函数中计算出来的
2022-07-21 21:32:11 +08:00
bool bClose = pFrame->mvpMapPoints[idx]->mTrackDepth < 10.f;
2022-07-21 22:27:32 +08:00
// 判断某地图点为外点的条件有以下三种:
// 1.该地图点不是近点并且误差大于卡方检验值chi2Mono[it]
// 2.该地图点是近点并且误差大于卡方检验值chi2close
// 3.深度不为正
// 每次优化后,用更小的卡方检验值,原因是随着优化的进行,对划分为内点的信任程度越来越低
2022-07-21 21:32:11 +08:00
if ((chi2 > chi2Mono[it] && !bClose) || (bClose && chi2 > chi2close) || !e->isDepthPositive())
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 将该点设置为外点
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = true;
2022-07-21 22:27:32 +08:00
// 外点不参与下一轮优化
2022-07-21 21:32:11 +08:00
e->setLevel(1);
2022-07-21 22:27:32 +08:00
// 单目坏点数+1
2022-07-21 21:32:11 +08:00
nBadMono++;
2020-12-01 11:58:17 +08:00
}
else
{
2022-07-21 22:27:32 +08:00
// 将该点设置为内点(暂时)
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = false;
2022-07-21 22:27:32 +08:00
// 内点继续参与下一轮优化
2022-07-21 21:32:11 +08:00
e->setLevel(0);
2022-07-21 22:27:32 +08:00
// 单目内点数+1
2022-07-21 21:32:11 +08:00
nInliersMono++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 从第三次优化开始就不设置鲁棒核函数了,原因是经过两轮优化已经趋向准确值,不会有太大误差
2022-07-21 21:32:11 +08:00
if (it == 2)
e->setRobustKernel(0);
}
// For stereo observations
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
EdgeStereoOnlyPose *e = vpEdgesStereo[i];
const size_t idx = vnIndexEdgeStereo[i];
if (pFrame->mvbOutlier[idx])
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
e->computeError();
}
const float chi2 = e->chi2();
if (chi2 > chi2Stereo[it])
{
pFrame->mvbOutlier[idx] = true;
e->setLevel(1); // not included in next optimization
nBadStereo++;
2020-12-01 11:58:17 +08:00
}
else
{
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = false;
e->setLevel(0);
nInliersStereo++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
if (it == 2)
e->setRobustKernel(0);
}
2022-07-21 22:27:32 +08:00
// 内点总数=单目内点数+双目内点数
2022-07-21 21:32:11 +08:00
nInliers = nInliersMono + nInliersStereo;
2022-07-21 22:27:32 +08:00
// 坏点数=单目坏点数+双目坏点数
2022-07-21 21:32:11 +08:00
nBad = nBadMono + nBadStereo;
if (optimizer.edges().size() < 10)
{
2022-07-21 22:27:32 +08:00
cout << "PIOLKF: NOT ENOUGH EDGES" << endl;
2022-07-21 21:32:11 +08:00
break;
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
// If not too much tracks, recover not too bad points
2022-07-21 22:27:32 +08:00
// 9. 若4次优化后内点数小于30尝试恢复一部分不那么糟糕的坏点
2022-07-21 21:32:11 +08:00
if ((nInliers < 30) && !bRecInit)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 重新从0开始统计坏点数
2022-07-21 21:32:11 +08:00
nBad = 0;
2022-07-21 22:27:32 +08:00
// 单目可容忍的卡方检验最大值(如果误差比这还大就不要挣扎了...
2022-07-21 21:32:11 +08:00
const float chi2MonoOut = 18.f;
const float chi2StereoOut = 24.f;
EdgeMonoOnlyPose *e1;
EdgeStereoOnlyPose *e2;
2022-07-21 22:27:32 +08:00
// 遍历所有单目特征点
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vnIndexEdgeMono.size(); i < iend; i++)
{
const size_t idx = vnIndexEdgeMono[i];
2022-07-21 22:27:32 +08:00
// 获取这些特征点对应的边
2022-07-21 21:32:11 +08:00
e1 = vpEdgesMono[i];
e1->computeError();
2022-07-21 22:27:32 +08:00
// 判断误差值是否超过单目可容忍的卡方检验最大值,是的话就把这个点保下来
2022-07-21 21:32:11 +08:00
if (e1->chi2() < chi2MonoOut)
pFrame->mvbOutlier[idx] = false;
else
nBad++;
}
for (size_t i = 0, iend = vnIndexEdgeStereo.size(); i < iend; i++)
{
const size_t idx = vnIndexEdgeStereo[i];
e2 = vpEdgesStereo[i];
e2->computeError();
if (e2->chi2() < chi2StereoOut)
pFrame->mvbOutlier[idx] = false;
else
nBad++;
}
}
2022-07-21 22:27:32 +08:00
// 10. 更新当前帧位姿、速度、IMU偏置
2022-07-21 21:32:11 +08:00
// Recover optimized pose, velocity and biases
2022-07-21 22:27:32 +08:00
// 给当前帧设置优化后的旋转、位移、速度,用来更新位姿
2022-07-21 21:32:11 +08:00
pFrame->SetImuPoseVelocity(VP->estimate().Rwb.cast<float>(), VP->estimate().twb.cast<float>(), VV->estimate().cast<float>());
Vector6d b;
b << VG->estimate(), VA->estimate();
2022-07-21 22:27:32 +08:00
// 给当前帧设置优化后的bgba
2022-07-21 21:32:11 +08:00
pFrame->mImuBias = IMU::Bias(b[3], b[4], b[5], b[0], b[1], b[2]);
2022-07-21 22:27:32 +08:00
// 11. 记录当前帧的优化状态,包括参数信息和对应的海森矩阵
2022-07-21 21:32:11 +08:00
// Recover Hessian, marginalize keyFframe states and generate new prior for frame
Eigen::Matrix<double, 15, 15> H;
H.setZero();
2022-07-21 22:27:32 +08:00
// H(x)=J(x).t()*info*J(x)
// J(x)取的是EdgeInertial中的_jacobianOplus[4]和_jacobianOplus[5]即EdgeInertial::computeError计算出来的er,ev,ep对当前帧Pose和Velocity的偏导
//因此ei->GetHessian2的结果为
// H(∂er/∂r) H(∂er/∂t) H(∂er/∂v)
// H(∂ev/∂r) H(∂ev/∂t) H(∂ev/∂v)
// H(∂ep/∂r) H(∂ep/∂t) H(∂ep/∂v)
//每项H都是3x3故GetHessian2的结果是9x9
2022-07-21 21:32:11 +08:00
H.block<9, 9>(0, 0) += ei->GetHessian2();
2022-07-21 22:27:32 +08:00
// J(x)取的是EdgeGyroRW中的_jacobianOplusXj即EdgeGyroRW::computeError计算出来的_error(ebg)对当前帧bg的偏导
//因此egr->GetHessian2的结果为
// H(∂ebg/∂bg) 3x3
2022-07-21 21:32:11 +08:00
H.block<3, 3>(9, 9) += egr->GetHessian2();
2022-07-21 22:27:32 +08:00
// J(x)取的是EdgeAccRW中的_jacobianOplusXj即EdgeAccRW::computeError计算出来的_error(ebg)对当前帧ba的偏导
//因此ear->GetHessian2的结果为
// H(∂eba/∂ba) 3x3
2022-07-21 21:32:11 +08:00
H.block<3, 3>(12, 12) += ear->GetHessian2();
2022-07-21 22:27:32 +08:00
//经过前面几步Hessian Matrix长这个样子省略了->GetHessian2()
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// 0 0 0 0 0 0 0 0 0 egr egr egr 0 0 0
// 0 0 0 0 0 0 0 0 0 egr egr egr 0 0 0
// 0 0 0 0 0 0 0 0 0 egr egr egr 0 0 0
// 0 0 0 0 0 0 0 0 0 0 0 0 ear ear ear
// 0 0 0 0 0 0 0 0 0 0 0 0 ear ear ear
// 0 0 0 0 0 0 0 0 0 0 0 0 ear ear ear
2022-07-21 21:32:11 +08:00
int tot_in = 0, tot_out = 0;
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
{
EdgeMonoOnlyPose *e = vpEdgesMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const size_t idx = vnIndexEdgeMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pFrame->mvbOutlier[idx])
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
H.block<6, 6>(0, 0) += e->GetHessian();
tot_in++;
2020-12-01 11:58:17 +08:00
}
else
2022-07-21 21:32:11 +08:00
tot_out++;
}
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
EdgeStereoOnlyPose *e = vpEdgesStereo[i];
const size_t idx = vnIndexEdgeStereo[i];
if (!pFrame->mvbOutlier[idx])
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
H.block<6, 6>(0, 0) += e->GetHessian();
tot_in++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
else
tot_out++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 设eie = ei->GetHessian2()+∑(e->GetHessian())
// 则最终Hessian Matrix长这样
// eie eie eie eie eie eie ei ei ei 0 0 0 0 0 0
// eie eie eie eie eie eie ei ei ei 0 0 0 0 0 0
// eie eie eie eie eie eie ei ei ei 0 0 0 0 0 0
// eie eie eie eie eie eie ei ei ei 0 0 0 0 0 0
// eie eie eie eie eie eie ei ei ei 0 0 0 0 0 0
// eie eie eie eie eie eie ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// ei ei ei ei ei ei ei ei ei 0 0 0 0 0 0
// 0 0 0 0 0 0 0 0 0 egr egr egr 0 0 0
// 0 0 0 0 0 0 0 0 0 egr egr egr 0 0 0
// 0 0 0 0 0 0 0 0 0 egr egr egr 0 0 0
// 0 0 0 0 0 0 0 0 0 0 0 0 ear ear ear
// 0 0 0 0 0 0 0 0 0 0 0 0 ear ear ear
// 0 0 0 0 0 0 0 0 0 0 0 0 ear ear ear
// 构造一个ConstraintPoseImu对象为下一帧提供先验约束
// 构造对象所使用的参数是当前帧P、V、BG、BA的估计值和H矩阵
2022-07-21 21:32:11 +08:00
pFrame->mpcpi = new ConstraintPoseImu(VP->estimate().Rwb, VP->estimate().twb, VV->estimate(), VG->estimate(), VA->estimate(), H);
2022-07-21 22:27:32 +08:00
// 在PoseInertialOptimizationLastFrame函数中会将ConstraintPoseImu信息作为“上一帧先验约束”生成一条优化边
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 返回值:内点数 = 总地图点数目 - 坏点(外点)数目
2022-07-21 21:32:11 +08:00
return nInitialCorrespondences - nBad;
}
2021-12-08 22:09:39 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief 使+IMU姿
*
*
* // Step 1创建g2o优化器初始化顶点和边
* // Step 2启动多轮优化剔除外点
* // Step 3更新当前帧位姿、速度、IMU偏置
* // Step 4记录当前帧的优化状态包括参数信息和边缘化后的海森矩阵
*
* @param[in] pFrame
* @param[in] bRecInit false
* @return int
*/
2022-07-21 21:32:11 +08:00
int Optimizer::PoseInertialOptimizationLastFrame(Frame *pFrame, bool bRecInit)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// Step 1创建g2o优化器初始化顶点和边
// 构建一个稀疏求解器
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 使用dense的求解器常见非dense求解器有cholmod线性求解器和shur补线性求解器
2022-07-21 21:32:11 +08:00
linearSolver = new g2o::LinearSolverDense<g2o::BlockSolverX::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 使用高斯牛顿求解器
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmGaussNewton *solver = new g2o::OptimizationAlgorithmGaussNewton(solver_ptr);
2020-12-01 11:58:17 +08:00
optimizer.setAlgorithm(solver);
2022-07-21 21:32:11 +08:00
optimizer.setVerbose(false);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 当前帧单(左)目地图点数目
2022-07-21 21:32:11 +08:00
int nInitialMonoCorrespondences = 0;
int nInitialStereoCorrespondences = 0;
int nInitialCorrespondences = 0;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Current Frame vertex
2022-07-21 22:27:32 +08:00
// 当前帧的位姿,旋转+平移6-dim
2022-07-21 21:32:11 +08:00
VertexPose *VP = new VertexPose(pFrame);
VP->setId(0);
2022-07-21 22:27:32 +08:00
VP->setFixed(false); // 需要优化,所以不固定
2022-07-21 21:32:11 +08:00
optimizer.addVertex(VP);
2022-07-21 22:27:32 +08:00
// 当前帧的速度3-dim
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = new VertexVelocity(pFrame);
VV->setId(1);
VV->setFixed(false);
optimizer.addVertex(VV);
2022-07-21 22:27:32 +08:00
// 当前帧的陀螺仪偏置3-dim
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG = new VertexGyroBias(pFrame);
VG->setId(2);
VG->setFixed(false);
optimizer.addVertex(VG);
2022-07-21 22:27:32 +08:00
// 当前帧的加速度偏置3-dim
2022-07-21 21:32:11 +08:00
VertexAccBias *VA = new VertexAccBias(pFrame);
VA->setId(3);
VA->setFixed(false);
optimizer.addVertex(VA);
2020-12-01 11:58:17 +08:00
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
// 当前帧的特征点总数 N = Nleft + Nright
// 对于单目 N!=0, Nleft=-1Nright=-1
// 对于双目 N!=0, Nleft!=-1Nright!=-1
2020-12-01 11:58:17 +08:00
const int N = pFrame->N;
2022-07-21 22:27:32 +08:00
// 当前帧左目的特征点总数
2022-07-21 21:32:11 +08:00
const int Nleft = pFrame->Nleft;
2022-07-21 22:27:32 +08:00
// 当前帧是否存在右目即是否为双目存在为true
//?感觉可以更直接点啊 bRight = (Nright!=-1)
2022-07-21 21:32:11 +08:00
const bool bRight = (Nleft != -1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<EdgeMonoOnlyPose *> vpEdgesMono;
vector<EdgeStereoOnlyPose *> vpEdgesStereo;
vector<size_t> vnIndexEdgeMono;
2020-12-01 11:58:17 +08:00
vector<size_t> vnIndexEdgeStereo;
2022-07-21 21:32:11 +08:00
vpEdgesMono.reserve(N);
2020-12-01 11:58:17 +08:00
vpEdgesStereo.reserve(N);
2022-07-21 21:32:11 +08:00
vnIndexEdgeMono.reserve(N);
2020-12-01 11:58:17 +08:00
vnIndexEdgeStereo.reserve(N);
2022-07-21 22:27:32 +08:00
// 自由度为2的卡方分布显著性水平为0.05对应的临界阈值5.991
2022-07-21 21:32:11 +08:00
const float thHuberMono = sqrt(5.991);
2022-07-21 22:27:32 +08:00
// 自由度为3的卡方分布显著性水平为0.05对应的临界阈值7.815
2022-07-21 21:32:11 +08:00
const float thHuberStereo = sqrt(7.815);
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 锁定地图点。由于需要使用地图点来构造顶点和边,因此不希望在构造的过程中部分地图点被改写造成不一致甚至是段错误
2022-07-21 21:32:11 +08:00
unique_lock<mutex> lock(MapPoint::mGlobalMutex);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = pFrame->mvpMapPoints[i];
if (pMP)
{
cv::KeyPoint kpUn;
// Left monocular observation
2022-07-21 22:27:32 +08:00
// 这里说的Left monocular包含两种情况1.单目情况 2.双目情况下的左目
2022-07-21 21:32:11 +08:00
if ((!bRight && pFrame->mvuRight[i] < 0) || i < Nleft)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 如果是双目情况下的左目
if (i < Nleft) // pair left-right
// 使用未畸变校正的特征点
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeys[i];
2022-07-21 22:27:32 +08:00
// 如果是单目
2022-07-21 21:32:11 +08:00
else
2022-07-21 22:27:32 +08:00
// 使用畸变校正过的特征点
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeysUn[i];
2022-07-21 22:27:32 +08:00
// 单目地图点计数增加
2022-07-21 21:32:11 +08:00
nInitialMonoCorrespondences++;
2022-07-21 22:27:32 +08:00
// 当前地图点默认设置为不是外点
2020-12-01 11:58:17 +08:00
pFrame->mvbOutlier[i] = false;
2022-07-21 22:27:32 +08:00
// 观测的特征点
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
2020-12-01 11:58:17 +08:00
obs << kpUn.pt.x, kpUn.pt.y;
2022-07-21 22:27:32 +08:00
// 第一种边(视觉重投影约束):地图点投影到该帧图像的坐标与特征点坐标偏差尽可能小
2022-07-21 21:32:11 +08:00
EdgeMonoOnlyPose *e = new EdgeMonoOnlyPose(pMP->GetWorldPos(), 0);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 将位姿作为第一个顶点
2022-07-21 21:32:11 +08:00
e->setVertex(0, VP);
2022-07-21 22:27:32 +08:00
// 设置观测值,即去畸变后的像素坐标
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
2022-07-21 22:27:32 +08:00
// 获取不确定度这里调用uncertainty2返回固定值1.0
// ?这里返回1.0是作为缺省值,是否可以根据对视觉信息的信任度动态修改这个值,比如标定的误差?
2022-07-21 21:32:11 +08:00
const float unc2 = pFrame->mpCamera->uncertainty2(obs);
2022-07-21 22:27:32 +08:00
// invSigma2 = (Inverse(协方差矩阵))^2表明该约束在各个维度上的可信度
// 图像金字塔层数越高,可信度越差
2022-07-21 21:32:11 +08:00
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave] / unc2;
2022-07-21 22:27:32 +08:00
// 设置该约束的信息矩阵
2022-07-21 21:32:11 +08:00
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2022-07-21 22:27:32 +08:00
// 设置鲁棒核函数,避免其误差的平方项出现数值过大的增长 注后续在优化2次后会用e->setRobustKernel(0)禁掉鲁棒核函数
2022-07-21 21:32:11 +08:00
e->setRobustKernel(rk);
2022-07-21 22:27:32 +08:00
// 重投影误差的自由度为2设置对应的卡方阈值
2022-07-21 21:32:11 +08:00
rk->setDelta(thHuberMono);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 将第一种边加入优化器
2020-12-01 11:58:17 +08:00
optimizer.addEdge(e);
2022-07-21 22:27:32 +08:00
// 将第一种边加入vpEdgesMono
2020-12-01 11:58:17 +08:00
vpEdgesMono.push_back(e);
2022-07-21 22:27:32 +08:00
// 将对应的特征点索引加入vnIndexEdgeMono
2020-12-01 11:58:17 +08:00
vnIndexEdgeMono.push_back(i);
}
2022-07-21 21:32:11 +08:00
// Stereo observation
else if (!bRight)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
nInitialStereoCorrespondences++;
2020-12-01 11:58:17 +08:00
pFrame->mvbOutlier[i] = false;
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeysUn[i];
const float kp_ur = pFrame->mvuRight[i];
Eigen::Matrix<double, 3, 1> obs;
2020-12-01 11:58:17 +08:00
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
EdgeStereoOnlyPose *e = new EdgeStereoOnlyPose(pMP->GetWorldPos());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, VP);
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
const float unc2 = pFrame->mpCamera->uncertainty2(obs.head(2));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float &invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave] / unc2;
e->setInformation(Eigen::Matrix3d::Identity() * invSigma2);
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuberStereo);
2020-12-01 11:58:17 +08:00
optimizer.addEdge(e);
vpEdgesStereo.push_back(e);
vnIndexEdgeStereo.push_back(i);
}
2022-07-21 21:32:11 +08:00
// Right monocular observation
if (bRight && i >= Nleft)
{
nInitialMonoCorrespondences++;
2020-12-01 11:58:17 +08:00
pFrame->mvbOutlier[i] = false;
2022-07-21 21:32:11 +08:00
kpUn = pFrame->mvKeysRight[i - Nleft];
2020-12-01 11:58:17 +08:00
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2022-07-21 21:32:11 +08:00
EdgeMonoOnlyPose *e = new EdgeMonoOnlyPose(pMP->GetWorldPos(), 1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, VP);
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
const float unc2 = pFrame->mpCamera->uncertainty2(obs);
const float invSigma2 = pFrame->mvInvLevelSigma2[kpUn.octave] / unc2;
2020-12-01 11:58:17 +08:00
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
2022-07-21 21:32:11 +08:00
rk->setDelta(thHuberMono);
2020-12-01 11:58:17 +08:00
optimizer.addEdge(e);
vpEdgesMono.push_back(e);
vnIndexEdgeMono.push_back(i);
}
2022-07-21 21:32:11 +08:00
}
}
}
2022-07-21 22:27:32 +08:00
// 统计参与优化的地图点总数目
2022-07-21 21:32:11 +08:00
nInitialCorrespondences = nInitialMonoCorrespondences + nInitialStereoCorrespondences;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Previous Frame Vertex
2022-07-21 22:27:32 +08:00
// pFp为上一帧
2022-07-21 21:32:11 +08:00
Frame *pFp = pFrame->mpPrevFrame;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 上一帧的位姿,旋转+平移6-dim
2022-07-21 21:32:11 +08:00
VertexPose *VPk = new VertexPose(pFp);
VPk->setId(4);
VPk->setFixed(false);
optimizer.addVertex(VPk);
2022-07-21 22:27:32 +08:00
// 上一帧的速度3-dim
2022-07-21 21:32:11 +08:00
VertexVelocity *VVk = new VertexVelocity(pFp);
VVk->setId(5);
VVk->setFixed(false);
optimizer.addVertex(VVk);
2022-07-21 22:27:32 +08:00
// 上一帧的陀螺仪偏置3-dim
2022-07-21 21:32:11 +08:00
VertexGyroBias *VGk = new VertexGyroBias(pFp);
VGk->setId(6);
VGk->setFixed(false);
optimizer.addVertex(VGk);
2022-07-21 22:27:32 +08:00
// 上一帧的加速度偏置3-dim
2022-07-21 21:32:11 +08:00
VertexAccBias *VAk = new VertexAccBias(pFp);
VAk->setId(7);
VAk->setFixed(false);
optimizer.addVertex(VAk);
2022-07-21 22:27:32 +08:00
// setFixed(false)这个设置使以上四个顶点15个参数的值随优化而变这样做会给上一帧再提供一些优化空间
// 但理论上不应该优化过多,否则会有不良影响,故后面的代码会用第五种边来约束上一帧的变化量
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 第二种边IMU预积分约束两帧之间位姿的变化量与IMU预积分的值偏差尽可能小
2022-07-21 21:32:11 +08:00
EdgeInertial *ei = new EdgeInertial(pFrame->mpImuPreintegratedFrame);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 将上一帧四个顶点P、V、BG、BA和当前帧两个顶点P、V加入第二种边
2022-07-21 21:32:11 +08:00
ei->setVertex(0, VPk);
ei->setVertex(1, VVk);
ei->setVertex(2, VGk);
ei->setVertex(3, VAk);
ei->setVertex(4, VP);
ei->setVertex(5, VV);
2022-07-21 22:27:32 +08:00
// 把第二种边加入优化器
2022-07-21 21:32:11 +08:00
optimizer.addEdge(ei);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 第三种边(陀螺仪随机游走约束):陀螺仪的随机游走值在相邻帧间不会相差太多 residual=VG-VGk
// 用大白话来讲就是用固定的VGK拽住VG防止VG在优化中放飞自我
2022-07-21 21:32:11 +08:00
EdgeGyroRW *egr = new EdgeGyroRW();
2022-07-21 22:27:32 +08:00
// 将上一帧的BG加入第三种边
2022-07-21 21:32:11 +08:00
egr->setVertex(0, VGk);
2022-07-21 22:27:32 +08:00
// 将当前帧的BG加入第三种边
2022-07-21 21:32:11 +08:00
egr->setVertex(1, VG);
2022-07-21 22:27:32 +08:00
// C值在预积分阶段更新range(9,12)对应陀螺仪偏置的协方差最终cvInfoG值为inv(∑(GyroRW^2/freq))
2022-07-21 21:32:11 +08:00
Eigen::Matrix3d InfoG = pFrame->mpImuPreintegrated->C.block<3, 3>(9, 9).cast<double>().inverse();
egr->setInformation(InfoG);
2022-07-21 22:27:32 +08:00
// 把第三种边加入优化器
2022-07-21 21:32:11 +08:00
optimizer.addEdge(egr);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 第四种边(加速度随机游走约束):加速度的随机游走值在相近帧间不会相差太多 residual=VA-VAk
// 用大白话来讲就是用固定的VAK拽住VA防止VA在优化中放飞自我
2022-07-21 21:32:11 +08:00
EdgeAccRW *ear = new EdgeAccRW();
2022-07-21 22:27:32 +08:00
// 将上一帧的BA加入第四种边
2022-07-21 21:32:11 +08:00
ear->setVertex(0, VAk);
2022-07-21 22:27:32 +08:00
// 将当前帧的BA加入第四种边
2022-07-21 21:32:11 +08:00
ear->setVertex(1, VA);
2022-07-21 22:27:32 +08:00
// C值在预积分阶段更新range(12,15)对应加速度偏置的协方差最终cvInfoG值为inv(∑(AccRW^2/freq))
2022-07-21 21:32:11 +08:00
Eigen::Matrix3d InfoA = pFrame->mpImuPreintegrated->C.block<3, 3>(12, 12).cast<double>().inverse();
ear->setInformation(InfoA);
2022-07-21 22:27:32 +08:00
// 把第四种边加入优化器
2022-07-21 21:32:11 +08:00
optimizer.addEdge(ear);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// ?既然有判空的操作,可以区分一下有先验信息(五条边)和无先验信息(四条边)的情况
2022-07-21 21:32:11 +08:00
if (!pFp->mpcpi)
Verbose::PrintMess("pFp->mpcpi does not exist!!!\nPrevious Frame " + to_string(pFp->mnId), Verbose::VERBOSITY_NORMAL);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 第五种边(先验约束):上一帧信息随优化的改变量要尽可能小
2022-07-21 21:32:11 +08:00
EdgePriorPoseImu *ep = new EdgePriorPoseImu(pFp->mpcpi);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 将上一帧的四个顶点P、V、BG、BA加入第五种边
2022-07-21 21:32:11 +08:00
ep->setVertex(0, VPk);
ep->setVertex(1, VVk);
ep->setVertex(2, VGk);
ep->setVertex(3, VAk);
g2o::RobustKernelHuber *rkp = new g2o::RobustKernelHuber;
ep->setRobustKernel(rkp);
rkp->setDelta(5);
2022-07-21 22:27:32 +08:00
// 把第五种边加入优化器
2022-07-21 21:32:11 +08:00
optimizer.addEdge(ep);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// Step 2启动多轮优化剔除外点
2020-12-01 11:58:17 +08:00
// We perform 4 optimizations, after each optimization we classify observation as inlier/outlier
// At the next optimization, outliers are not included, but at the end they can be classified as inliers again.
2022-07-21 22:27:32 +08:00
//与PoseInertialOptimizationLastKeyFrame函数对比区别在于在优化过程中保持卡方阈值不变
// 以下参数的解释
// 自由度为2的卡方分布显著性水平为0.05对应的临界阈值5.991
// 自由度为3的卡方分布显著性水平为0.05对应的临界阈值7.815
// 自由度为3的卡方分布显著性水平为0.02对应的临界阈值9.8
// 自由度为3的卡方分布显著性水平为0.001对应的临界阈值15.6
// 计算方法https://stattrek.com/online-calculator/chi-square.aspx
2022-07-21 21:32:11 +08:00
const float chi2Mono[4] = {5.991, 5.991, 5.991, 5.991};
const float chi2Stereo[4] = {15.6f, 9.8f, 7.815f, 7.815f};
2022-07-21 22:27:32 +08:00
// 4次优化的迭代次数都为10
2022-07-21 21:32:11 +08:00
const int its[4] = {10, 10, 10, 10};
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 坏点数
2022-07-21 21:32:11 +08:00
int nBad = 0;
2022-07-21 22:27:32 +08:00
// 单目坏点数
2022-07-21 21:32:11 +08:00
int nBadMono = 0;
2022-07-21 22:27:32 +08:00
// 双目坏点数
2022-07-21 21:32:11 +08:00
int nBadStereo = 0;
2022-07-21 22:27:32 +08:00
// 单目内点数
2022-07-21 21:32:11 +08:00
int nInliersMono = 0;
2022-07-21 22:27:32 +08:00
// 双目内点数
2022-07-21 21:32:11 +08:00
int nInliersStereo = 0;
2022-07-21 22:27:32 +08:00
// 内点数
2022-07-21 21:32:11 +08:00
int nInliers = 0;
for (size_t it = 0; it < 4; it++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 初始化优化器,这里的参数0代表只对level为0的边进行优化不传参数默认也是0
2020-12-01 11:58:17 +08:00
optimizer.initializeOptimization(0);
2022-07-21 22:27:32 +08:00
// 每次优化迭代十次
2020-12-01 11:58:17 +08:00
optimizer.optimize(its[it]);
2022-07-21 22:27:32 +08:00
// 每次优化都重新统计各类点的数目
2022-07-21 21:32:11 +08:00
nBad = 0;
nBadMono = 0;
nBadStereo = 0;
nInliers = 0;
nInliersMono = 0;
nInliersStereo = 0;
2022-07-21 22:27:32 +08:00
// 使用1.5倍的chi2Mono作为“近点”的卡方检验值意味着地图点越近检验越宽松
// 地图点如何定义为“近点”在下面的代码中有解释
2022-07-21 21:32:11 +08:00
float chi2close = 1.5 * chi2Mono[it];
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
EdgeMonoOnlyPose *e = vpEdgesMono[i];
2020-12-01 11:58:17 +08:00
const size_t idx = vnIndexEdgeMono[i];
2022-07-21 22:27:32 +08:00
// 当地图点在当前帧的深度值小于10时该地图点属于close近点
// mTrackDepth是在Frame.cc的isInFrustum函数中计算出来的
2022-07-21 21:32:11 +08:00
bool bClose = pFrame->mvpMapPoints[idx]->mTrackDepth < 10.f;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 如果这条误差边是来自于outlier
2022-07-21 21:32:11 +08:00
if (pFrame->mvbOutlier[idx])
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
//计算本次优化后的误差
2020-12-01 11:58:17 +08:00
e->computeError();
}
2022-07-21 22:27:32 +08:00
// 就是error*\Omega*error表示了这条边考虑置信度以后的误差大小
2020-12-01 11:58:17 +08:00
const float chi2 = e->chi2();
2022-07-21 22:27:32 +08:00
// 判断某地图点为外点的条件有以下三种:
// 1.该地图点不是近点并且误差大于卡方检验值chi2Mono[it]
// 2.该地图点是近点并且误差大于卡方检验值chi2close
// 3.深度不为正
// 每次优化后,用更小的卡方检验值,原因是随着优化的进行,对划分为内点的信任程度越来越低
2022-07-21 21:32:11 +08:00
if ((chi2 > chi2Mono[it] && !bClose) || (bClose && chi2 > chi2close) || !e->isDepthPositive())
{
2022-07-21 22:27:32 +08:00
// 将该点设置为外点
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = true;
2022-07-21 22:27:32 +08:00
// 外点不参与下一轮优化
2022-03-28 21:20:28 +08:00
e->setLevel(1);
2022-07-21 22:27:32 +08:00
// 单目坏点数+1
2022-07-21 21:32:11 +08:00
nBadMono++;
2020-12-01 11:58:17 +08:00
}
else
{
2022-07-21 22:27:32 +08:00
// 将该点设置为内点(暂时)
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = false;
2022-07-21 22:27:32 +08:00
// 内点继续参与下一轮优化
2022-03-28 21:20:28 +08:00
e->setLevel(0);
2022-07-21 22:27:32 +08:00
// 单目内点数+1
2022-07-21 21:32:11 +08:00
nInliersMono++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 从第三次优化开始就不设置鲁棒核函数了,原因是经过两轮优化已经趋向准确值,不会有太大误差
2022-07-21 21:32:11 +08:00
if (it == 2)
2022-03-28 21:20:28 +08:00
e->setRobustKernel(0);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
EdgeStereoOnlyPose *e = vpEdgesStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const size_t idx = vnIndexEdgeStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pFrame->mvbOutlier[idx])
2020-12-01 11:58:17 +08:00
{
e->computeError();
}
const float chi2 = e->chi2();
2022-07-21 21:32:11 +08:00
if (chi2 > chi2Stereo[it])
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = true;
2020-12-01 11:58:17 +08:00
e->setLevel(1);
2022-07-21 21:32:11 +08:00
nBadStereo++;
2020-12-01 11:58:17 +08:00
}
else
{
2022-07-21 21:32:11 +08:00
pFrame->mvbOutlier[idx] = false;
2020-12-01 11:58:17 +08:00
e->setLevel(0);
2022-07-21 21:32:11 +08:00
nInliersStereo++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
if (it == 2)
2020-12-01 11:58:17 +08:00
e->setRobustKernel(0);
}
2022-07-21 22:27:32 +08:00
// 内点总数=单目内点数+双目内点数
2022-07-21 21:32:11 +08:00
nInliers = nInliersMono + nInliersStereo;
2022-07-21 22:27:32 +08:00
// 坏点数=单目坏点数+双目坏点数
2022-07-21 21:32:11 +08:00
nBad = nBadMono + nBadStereo;
if (optimizer.edges().size() < 10)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
cout << "PIOLF: NOT ENOUGH EDGES" << endl;
2022-07-21 21:32:11 +08:00
break;
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 若4次优化后内点数小于30尝试恢复一部分不那么糟糕的坏点
2022-07-21 21:32:11 +08:00
if ((nInliers < 30) && !bRecInit)
{
2022-07-21 22:27:32 +08:00
// 重新从0开始统计坏点数
2022-07-21 21:32:11 +08:00
nBad = 0;
2022-07-21 22:27:32 +08:00
// 单目可容忍的卡方检验最大值(如果误差比这还大就不要挣扎了...
2022-07-21 21:32:11 +08:00
const float chi2MonoOut = 18.f;
const float chi2StereoOut = 24.f;
EdgeMonoOnlyPose *e1;
EdgeStereoOnlyPose *e2;
2022-07-21 22:27:32 +08:00
// 遍历所有单目特征点
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vnIndexEdgeMono.size(); i < iend; i++)
{
const size_t idx = vnIndexEdgeMono[i];
2022-07-21 22:27:32 +08:00
// 获取这些特征点对应的边
2022-07-21 21:32:11 +08:00
e1 = vpEdgesMono[i];
e1->computeError();
if (e1->chi2() < chi2MonoOut)
pFrame->mvbOutlier[idx] = false;
else
nBad++;
}
for (size_t i = 0, iend = vnIndexEdgeStereo.size(); i < iend; i++)
{
2020-12-01 11:58:17 +08:00
const size_t idx = vnIndexEdgeStereo[i];
2022-07-21 21:32:11 +08:00
e2 = vpEdgesStereo[i];
e2->computeError();
if (e2->chi2() < chi2StereoOut)
pFrame->mvbOutlier[idx] = false;
else
nBad++;
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// ?多此一举优化过程中nInliers这个值已经计算过了nInliersMono和nInliersStereo在后续代码中一直保持不变
2022-07-21 21:32:11 +08:00
nInliers = nInliersMono + nInliersStereo;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// Step 3更新当前帧位姿、速度、IMU偏置
2022-07-21 21:32:11 +08:00
// Recover optimized pose, velocity and biases
2022-07-21 22:27:32 +08:00
// 给当前帧设置优化后的旋转、位移、速度,用来更新位姿
2022-07-21 21:32:11 +08:00
pFrame->SetImuPoseVelocity(VP->estimate().Rwb.cast<float>(), VP->estimate().twb.cast<float>(), VV->estimate().cast<float>());
Vector6d b;
b << VG->estimate(), VA->estimate();
2022-07-21 22:27:32 +08:00
// 给当前帧设置优化后的bgba
2022-07-21 21:32:11 +08:00
pFrame->mImuBias = IMU::Bias(b[3], b[4], b[5], b[0], b[1], b[2]);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// Step 4记录当前帧的优化状态包括参数信息和边缘化后的海森矩阵
2022-07-21 21:32:11 +08:00
// Recover Hessian, marginalize previous frame states and generate new prior for frame
2022-07-21 22:27:32 +08:00
// 包含本次优化所有信息矩阵的和,它代表本次优化对确定性的影响
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 30, 30> H;
H.setZero();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
//第1步加上EdgeInertialIMU预积分约束的海森矩阵
// ei的定义
// EdgeInertial* ei = new EdgeInertial(pFrame->mpImuPreintegratedFrame);
// ei->setVertex(0, VPk);
// ei->setVertex(1, VVk);
// ei->setVertex(2, VGk);
// ei->setVertex(3, VAk);
// ei->setVertex(4, VP); // VertexPose* VP = new VertexPose(pFrame);
// ei->setVertex(5, VV); // VertexVelocity* VV = new VertexVelocity(pFrame);
// ei->GetHessian() = J.t * J 下同,不做详细标注了
// J
// rn + tn vn gn an rn+1 + tn+1 vn+1
// er Jp1 Jv1 Jg1 Ja1 Jp2 Jv2
// 角标1表示上一帧2表示当前帧
// 6 3 3 3 6 3
// Jp1.t * Jp1 Jp1.t * Jv1 Jp1.t * Jg1 Jp1.t * Ja1 Jp1.t * Jp2 Jp1.t * Jv2 6
// Jv1.t * Jp1 Jv1.t * Jv1 Jv1.t * Jg1 Jv1.t * Ja1 Jv1.t * Jp2 Jv1.t * Jv2 3
// Jg1.t * Jp1 Jg1.t * Jv1 Jg1.t * Jg1 Jg1.t * Ja1 Jg1.t * Jp2 Jg1.t * Jv2 3
// Ja1.t * Jp1 Ja1.t * Jv1 Ja1.t * Jg1 Ja1.t * Ja1 Ja1.t * Jp2 Ja1.t * Jv2 3
// Jp2.t * Jp1 Jp2.t * Jv1 Jp2.t * Jg1 Jp2.t * Ja1 Jp2.t * Jp2 Jp2.t * Jv2 6
// Jv2.t * Jp1 Jv2.t * Jv1 Jv2.t * Jg1 Jv2.t * Ja1 Jv2.t * Jp2 Jv2.t * Jv2 3
// 所以矩阵是24*24 的
2022-07-21 21:32:11 +08:00
H.block<24, 24>(0, 0) += ei->GetHessian();
2022-07-21 22:27:32 +08:00
// 经过这步H变成了
// 列数 6 3 3 3 6 3 6
// ---------------------------------------------------------------------------------- 行数
// Jp1.t * Jp1 Jp1.t * Jv1 Jp1.t * Jg1 Jp1.t * Ja1 Jp1.t * Jp2 Jp1.t * Jv2 0 | 6
// Jv1.t * Jp1 Jv1.t * Jv1 Jv1.t * Jg1 Jv1.t * Ja1 Jv1.t * Jp2 Jv1.t * Jv2 0 | 3
// Jg1.t * Jp1 Jg1.t * Jv1 Jg1.t * Jg1 Jg1.t * Ja1 Jg1.t * Jp2 Jg1.t * Jv2 0 | 3
// Ja1.t * Jp1 Ja1.t * Jv1 Ja1.t * Jg1 Ja1.t * Ja1 Ja1.t * Jp2 Ja1.t * Jv2 0 | 3
// Jp2.t * Jp1 Jp2.t * Jv1 Jp2.t * Jg1 Jp2.t * Ja1 Jp2.t * Jp2 Jp2.t * Jv2 0 | 6
// Jv2.t * Jp1 Jv2.t * Jv1 Jv2.t * Jg1 Jv2.t * Ja1 Jv2.t * Jp2 Jv2.t * Jv2 0 | 3
// 0 0 0 0 0 0 0 | 6
// ----------------------------------------------------------------------------------
//第2步加上EdgeGyroRW陀螺仪随机游走约束的信息矩阵
//| 0~8 | 9~11 | 12~23 | 24~26 |27~29
// 9~11是上一帧的bg(3-dim)24~26是当前帧的bg(3-dim)
// egr的定义
// EdgeGyroRW* egr = new EdgeGyroRW();
// egr->setVertex(0, VGk);
// egr->setVertex(1, VG);
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 6, 6> Hgr = egr->GetHessian();
2022-07-21 22:27:32 +08:00
H.block<3, 3>(9, 9) += Hgr.block<3, 3>(0, 0); // Jgr1.t * Jgr1
H.block<3, 3>(9, 24) += Hgr.block<3, 3>(0, 3); // Jgr1.t * Jgr2
H.block<3, 3>(24, 9) += Hgr.block<3, 3>(3, 0); // Jgr2.t * Jgr1
H.block<3, 3>(24, 24) += Hgr.block<3, 3>(3, 3); // Jgr2.t * Jgr2
// 经过这步H变成了
// 列数 6 3 3 3 6 3 3 3
// ----------------------------------------------------------------------------------------------------------------- 行数
// Jp1.t * Jp1 Jp1.t * Jv1 Jp1.t * Jg1 Jp1.t * Ja1 Jp1.t * Jp2 Jp1.t * Jv2 0 0 | 6
// Jv1.t * Jp1 Jv1.t * Jv1 Jv1.t * Jg1 Jv1.t * Ja1 Jv1.t * Jp2 Jv1.t * Jv2 0 0 | 3
// Jg1.t * Jp1 Jg1.t * Jv1 Jg1.t * Jg1 + Jgr1.t * Jgr1 Jg1.t * Ja1 Jg1.t * Jp2 Jg1.t * Jv2 Jgr1.t * Jgr2 0 | 3
// Ja1.t * Jp1 Ja1.t * Jv1 Ja1.t * Jg1 Ja1.t * Ja1 Ja1.t * Jp2 Ja1.t * Jv2 0 0 | 3
// Jp2.t * Jp1 Jp2.t * Jv1 Jp2.t * Jg1 Jp2.t * Ja1 Jp2.t * Jp2 Jp2.t * Jv2 0 0 | 6
// Jv2.t * Jp1 Jv2.t * Jv1 Jv2.t * Jg1 Jv2.t * Ja1 Jv2.t * Jp2 Jv2.t * Jv2 0 0 | 3
// 0 0 Jgr2.t * Jgr1 0 0 0 Jgr2.t * Jgr2 0 | 3
// 0 0 0 0 0 0 0 0 | 3
// -----------------------------------------------------------------------------------------------------------------
//第3步加上EdgeAccRW加速度随机游走约束的信息矩阵
//| 0~11 | 12~14 | 15~26 | 27~29 |30
// 12~14是上一帧的ba(3-dim)27~29是当前帧的ba(3-dim)
// ear的定义
// EdgeAccRW* ear = new EdgeAccRW();
// ear->setVertex(0, VAk);
// ear->setVertex(1, VA);
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 6, 6> Har = ear->GetHessian();
2022-07-21 22:27:32 +08:00
H.block<3, 3>(12, 12) += Har.block<3, 3>(0, 0); // Jar1.t * Jar1
H.block<3, 3>(12, 27) += Har.block<3, 3>(0, 3); // Jar1.t * Jar2
H.block<3, 3>(27, 12) += Har.block<3, 3>(3, 0); // Jar2.t * Jar1
H.block<3, 3>(27, 27) += Har.block<3, 3>(3, 3); // Jar2.t * Jar2
// 经过这步H变成了
// 列数 6 3 3 3 6 3 3 3
// --------------------------------------------------------------------------------------------------------------------------------------------------- 行数
// | Jp1.t * Jp1 Jp1.t * Jv1 Jp1.t * Jg1 Jp1.t * Ja1 | Jp1.t * Jp2 Jp1.t * Jv2 0 0 | 6
// | Jv1.t * Jp1 Jv1.t * Jv1 Jv1.t * Jg1 Jv1.t * Ja1 | Jv1.t * Jp2 Jv1.t * Jv2 0 0 | 3
// | Jg1.t * Jp1 Jg1.t * Jv1 Jg1.t * Jg1 + Jgr1.t * Jgr1 Jg1.t * Ja1 | Jg1.t * Jp2 Jg1.t * Jv2 Jgr1.t * Jgr2 0 | 3
// | Ja1.t * Jp1 Ja1.t * Jv1 Ja1.t * Jg1 Ja1.t * Ja1 + Jar1.t * Jar1 | Ja1.t * Jp2 Ja1.t * Jv2 0 Jar1.t * Jar2 | 3
// |--------------------------------------------------------------------------------------------------------------------------------------------------
// | Jp2.t * Jp1 Jp2.t * Jv1 Jp2.t * Jg1 Jp2.t * Ja1 | Jp2.t * Jp2 Jp2.t * Jv2 0 0 | 6
// | Jv2.t * Jp1 Jv2.t * Jv1 Jv2.t * Jg1 Jv2.t * Ja1 | Jv2.t * Jp2 Jv2.t * Jv2 0 0 | 3
// | 0 0 Jgr2.t * Jgr1 0 | 0 0 Jgr2.t * Jgr2 0 | 3
// | 0 0 0 Jar2.t * Jar1 | 0 0 0 Jar2.t * Jar2 | 3
// ---------------------------------------------------------------------------------------------------------------------------------------------------
//第4步加上EdgePriorPoseImu先验约束的信息矩阵
//| 0~14 | 15~29
// 0~14是上一帧的P(6-dim)、V(3-dim)、BG(3-dim)、BA(3-dim)
// ep定义
// EdgePriorPoseImu* ep = new EdgePriorPoseImu(pFp->mpcpi);
// ep->setVertex(0, VPk);
// ep->setVertex(1, VVk);
// ep->setVertex(2, VGk);
// ep->setVertex(3, VAk);
// 6 3 3 3
// Jp1.t * Jp1 Jp1.t * Jv1 Jp1.t * Jg1 Jp1.t * Ja1 6
// Jv1.t * Jp1 Jv1.t * Jv1 Jv1.t * Jg1 Jv1.t * Ja1 3
// Jg1.t * Jp1 Jg1.t * Jv1 Jg1.t * Jg1 Jg1.t * Ja1 3
// Ja1.t * Jp1 Ja1.t * Jv1 Ja1.t * Jg1 Ja1.t * Ja1 3
H.block<15, 15>(0, 0) += ep->GetHessian(); // 上一帧 的H矩阵矩阵太大了不写了。。。总之就是加到下标为1相关的了
2022-07-21 21:32:11 +08:00
int tot_in = 0, tot_out = 0;
2022-07-21 22:27:32 +08:00
// 第5步 关于位姿的海森
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
{
EdgeMonoOnlyPose *e = vpEdgesMono[i];
const size_t idx = vnIndexEdgeMono[i];
if (!pFrame->mvbOutlier[idx])
{
2022-07-21 22:27:32 +08:00
// 0~14 | 15~20 | 21~29
// 15~20是当前帧的P(6-dim)
H.block<6, 6>(15, 15) += e->GetHessian(); // 当前帧的H矩阵矩阵太大了不写了。。。总之就是加到p2相关的了
2022-07-21 21:32:11 +08:00
tot_in++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
else
tot_out++;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
EdgeStereoOnlyPose *e = vpEdgesStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const size_t idx = vnIndexEdgeStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pFrame->mvbOutlier[idx])
{
2022-07-21 22:27:32 +08:00
// 0~14 | 15~20 | 21~29
2022-07-21 21:32:11 +08:00
H.block<6, 6>(15, 15) += e->GetHessian();
tot_in++;
}
else
tot_out++;
}
2022-07-21 22:27:32 +08:00
// H = |B E.t| ------> |0 0|
// |E A| |0 A-E*B.inv*E.t|
2022-07-21 21:32:11 +08:00
H = Marginalize(H, 0, 14);
2022-07-21 22:27:32 +08:00
/*
Marginalize
Eigen::JacobiSVD<Eigen::MatrixXd> svd(H.block(0, 0, 15, 15), Eigen::ComputeThinU | Eigen::ComputeThinV);
Eigen::JacobiSVD<Eigen::MatrixXd>::SingularValuesType singularValues_inv = svd.singularValues();
for (int i = 0; i < 15; ++i)
{
if (singularValues_inv(i) > 1e-6)
singularValues_inv(i) = 1.0 / singularValues_inv(i);
else
singularValues_inv(i) = 0;
}
Eigen::MatrixXd invHb = svd.matrixV() * singularValues_inv.asDiagonal() * svd.matrixU().transpose();
H.block(15, 15, 15, 15) = H.block(15, 15, 15, 15) - H.block(15, 0, 15, 15) * invHb - H.block(0, 15, 15, 15);
*/
2022-07-21 21:32:11 +08:00
2022-07-21 22:27:32 +08:00
//构造一个ConstraintPoseImu对象为下一帧提供先验约束
//构造对象所使用的参数是当前帧P、V、BG、BA的估计值和边缘化后的H矩阵
2022-07-21 21:32:11 +08:00
pFrame->mpcpi = new ConstraintPoseImu(VP->estimate().Rwb, VP->estimate().twb, VV->estimate(), VG->estimate(), VA->estimate(), H.block<15, 15>(15, 15));
2022-07-21 22:27:32 +08:00
//下一帧使用的EdgePriorPoseImu参数来自于此
2022-07-21 21:32:11 +08:00
delete pFp->mpcpi;
pFp->mpcpi = NULL;
2022-07-21 22:27:32 +08:00
//返回值:内点数 = 总地图点数目 - 坏点(外点)数目
2022-07-21 21:32:11 +08:00
return nInitialCorrespondences - nBad;
}
2022-07-21 22:27:32 +08:00
/**
* @brief PoseInertialOptimizationLastFrame 使 Marginalize(H, 0, 14);
* 使
* 6 3 3 3 6 3 3 3
* ---------------------------------------------------------------------------------------------------------------------------------------------------
* | Jp1.t * Jp1 Jp1.t * Jv1 Jp1.t * Jg1 Jp1.t * Ja1 | Jp1.t * Jp2 Jp1.t * Jv2 0 0 | 6
* | Jv1.t * Jp1 Jv1.t * Jv1 Jv1.t * Jg1 Jv1.t * Ja1 | Jv1.t * Jp2 Jv1.t * Jv2 0 0 | 3
* | Jg1.t * Jp1 Jg1.t * Jv1 Jg1.t * Jg1 + Jgr1.t * Jgr1 Jg1.t * Ja1 | Jg1.t * Jp2 Jg1.t * Jv2 Jgr1.t * Jgr2 0 | 3
* | Ja1.t * Jp1 Ja1.t * Jv1 Ja1.t * Jg1 Ja1.t * Ja1 + Jar1.t * Jar1 | Ja1.t * Jp2 Ja1.t * Jv2 Jar1.t * Jar2 0 | 3
* |--------------------------------------------------------------------------------------------------------------------------------------------------
* | Jp2.t * Jp1 Jp2.t * Jv1 Jp2.t * Jg1 Jp2.t * Ja1 | Jp2.t * Jp2 Jp2.t * Jv2 0 0 | 6
* | Jv2.t * Jp1 Jv2.t * Jv1 Jv2.t * Jg1 Jv2.t * Ja1 | Jv2.t * Jp2 Jv2.t * Jv2 0 0 | 3
* | 0 0 Jgr2.t * Jgr1 0 | 0 0 Jgr2.t * Jgr2 0 | 3
* | 0 0 0 Jar2.t * Jar1 | 0 0 0 Jar2.t * Jar2 | 3
* ---------------------------------------------------------------------------------------------------------------------------------------------------
* @param H 30*30
* @param start
* @param end
*/
2022-07-21 21:32:11 +08:00
Eigen::MatrixXd Optimizer::Marginalize(const Eigen::MatrixXd &H, const int &start, const int &end)
{
// Goal
// a | ab | ac a* | 0 | ac*
// ba | b | bc --> 0 | 0 | 0
// ca | cb | c ca* | 0 | c*
// Size of block before block to marginalize
const int a = start;
// Size of block to marginalize
const int b = end - start + 1;
// Size of block after block to marginalize
const int c = H.cols() - (end + 1);
// Reorder as follows:
// a | ab | ac a | ac | ab
// ba | b | bc --> ca | c | cb
// ca | cb | c ba | bc | b
Eigen::MatrixXd Hn = Eigen::MatrixXd::Zero(H.rows(), H.cols());
if (a > 0)
{
Hn.block(0, 0, a, a) = H.block(0, 0, a, a);
Hn.block(0, a + c, a, b) = H.block(0, a, a, b);
Hn.block(a + c, 0, b, a) = H.block(a, 0, b, a);
}
if (a > 0 && c > 0)
{
Hn.block(0, a, a, c) = H.block(0, a + b, a, c);
Hn.block(a, 0, c, a) = H.block(a + b, 0, c, a);
}
if (c > 0)
{
Hn.block(a, a, c, c) = H.block(a + b, a + b, c, c);
Hn.block(a, a + c, c, b) = H.block(a + b, a, c, b);
Hn.block(a + c, a, b, c) = H.block(a, a + b, b, c);
}
Hn.block(a + c, a + c, b, b) = H.block(a, a, b, b);
// Perform marginalization (Schur complement)
Eigen::JacobiSVD<Eigen::MatrixXd> svd(Hn.block(a + c, a + c, b, b), Eigen::ComputeThinU | Eigen::ComputeThinV);
Eigen::JacobiSVD<Eigen::MatrixXd>::SingularValuesType singularValues_inv = svd.singularValues();
for (int i = 0; i < b; ++i)
{
if (singularValues_inv(i) > 1e-6)
singularValues_inv(i) = 1.0 / singularValues_inv(i);
else
singularValues_inv(i) = 0;
}
Eigen::MatrixXd invHb = svd.matrixV() * singularValues_inv.asDiagonal() * svd.matrixU().transpose();
Hn.block(0, 0, a + c, a + c) = Hn.block(0, 0, a + c, a + c) - Hn.block(0, a + c, a + c, b) * invHb * Hn.block(a + c, 0, b, a + c);
Hn.block(a + c, a + c, b, b) = Eigen::MatrixXd::Zero(b, b);
Hn.block(0, a + c, a + c, b) = Eigen::MatrixXd::Zero(a + c, b);
Hn.block(a + c, 0, b, a + c) = Eigen::MatrixXd::Zero(b, a + c);
// Inverse reorder
// a* | ac* | 0 a* | 0 | ac*
// ca* | c* | 0 --> 0 | 0 | 0
// 0 | 0 | 0 ca* | 0 | c*
Eigen::MatrixXd res = Eigen::MatrixXd::Zero(H.rows(), H.cols());
if (a > 0)
{
res.block(0, 0, a, a) = Hn.block(0, 0, a, a);
res.block(0, a, a, b) = Hn.block(0, a + c, a, b);
res.block(a, 0, b, a) = Hn.block(a + c, 0, b, a);
}
if (a > 0 && c > 0)
{
res.block(0, a + b, a, c) = Hn.block(0, a, a, c);
res.block(a + b, 0, c, a) = Hn.block(a, 0, c, a);
}
if (c > 0)
{
res.block(a + b, a + b, c, c) = Hn.block(a, a, c, c);
res.block(a + b, a, c, b) = Hn.block(a, a + c, c, b);
res.block(a, a + b, b, c) = Hn.block(a + c, a, b, c);
}
res.block(a, a, b, b) = Hn.block(a + c, a + c, b, b);
return res;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
2022-07-21 21:32:11 +08:00
/**************************************以下为局部地图优化**************************************************************/
2022-07-21 22:27:32 +08:00
/**
* @brief Local Bundle Adjustment LocalMapping::Run() 使
* @param pKF KeyFrame
* @param pbStopFlag
* @param pMap MapmMutexMapUpdate
* @param
*
* ORBSLAM2
* 23
*/
void Optimizer::LocalBundleAdjustment(KeyFrame *pKF, bool *pbStopFlag, Map *pMap, int &num_fixedKF, int &num_OptKF, int &num_MPs, int &num_edges)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 该优化函数用于LocalMapping线程的局部BA优化
2020-12-01 11:58:17 +08:00
// Local KeyFrames: First Breath Search from Current Keyframe
2022-07-21 21:32:11 +08:00
list<KeyFrame *> lLocalKeyFrames;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 步骤1将当前关键帧加入lLocalKeyFrames
2020-12-01 11:58:17 +08:00
lLocalKeyFrames.push_back(pKF);
pKF->mnBALocalForKF = pKF->mnId;
2022-07-21 21:32:11 +08:00
Map *pCurrentMap = pKF->GetMap();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 步骤2找到关键帧连接的关键帧一级相连加入lLocalKeyFrames中
2022-07-21 21:32:11 +08:00
const vector<KeyFrame *> vNeighKFs = pKF->GetVectorCovisibleKeyFrames();
for (int i = 0, iend = vNeighKFs.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vNeighKFs[i];
2022-07-21 22:27:32 +08:00
// 记录局部优化id该数为不断变化数值等于局部化的关键帧的id该id用于防止重复添加
2020-12-01 11:58:17 +08:00
pKFi->mnBALocalForKF = pKF->mnId;
2022-07-21 21:32:11 +08:00
if (!pKFi->isBad() && pKFi->GetMap() == pCurrentMap)
2020-12-01 11:58:17 +08:00
lLocalKeyFrames.push_back(pKFi);
}
// Local MapPoints seen in Local KeyFrames
2022-03-28 21:20:28 +08:00
num_fixedKF = 0;
2022-07-21 22:27:32 +08:00
// 步骤3遍历lLocalKeyFrames中关键帧将它们观测的MapPoints加入到lLocalMapPoints
2022-07-21 21:32:11 +08:00
list<MapPoint *> lLocalMapPoints;
set<MapPoint *> sNumObsMP;
for (list<KeyFrame *>::iterator lit = lLocalKeyFrames.begin(), lend = lLocalKeyFrames.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = *lit;
if (pKFi->mnId == pMap->GetInitKFid())
2020-12-01 11:58:17 +08:00
{
num_fixedKF = 1;
}
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMPs = pKFi->GetMapPointMatches();
for (vector<MapPoint *>::iterator vit = vpMPs.begin(), vend = vpMPs.end(); vit != vend; vit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = *vit;
if (pMP)
if (!pMP->isBad() && pMP->GetMap() == pCurrentMap)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pMP->mnBALocalForKF != pKF->mnId)
2020-12-01 11:58:17 +08:00
{
lLocalMapPoints.push_back(pMP);
2022-07-21 21:32:11 +08:00
pMP->mnBALocalForKF = pKF->mnId;
2020-12-01 11:58:17 +08:00
}
}
}
}
// Fixed Keyframes. Keyframes that see Local MapPoints but that are not Local Keyframes
2022-07-21 22:27:32 +08:00
// 步骤4得到能被局部MapPoints观测到但不属于局部关键帧的关键帧这些关键帧在局部BA优化时不优化
2022-07-21 21:32:11 +08:00
list<KeyFrame *> lFixedCameras;
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
map<KeyFrame *, tuple<int, int>> observations = (*lit)->GetObservations();
for (map<KeyFrame *, tuple<int, int>>::iterator mit = observations.begin(), mend = observations.end(); mit != mend; mit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = mit->first;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mnBALocalForKF != pKF->mnId && pKFi->mnBAFixedForKF != pKF->mnId)
{
pKFi->mnBAFixedForKF = pKF->mnId;
if (!pKFi->isBad() && pKFi->GetMap() == pCurrentMap)
2020-12-01 11:58:17 +08:00
lFixedCameras.push_back(pKFi);
}
}
}
2022-07-21 22:27:32 +08:00
// 步骤4.1相比ORBSLAM2多出了判断固定关键帧的个数最起码要两个固定的,如果实在没有就把lLocalKeyFrames中最早的KF固定还是不够再加上第二早的KF固定
2020-12-01 11:58:17 +08:00
num_fixedKF = lFixedCameras.size() + num_fixedKF;
2022-07-21 22:27:32 +08:00
// 1.0 版本没有以下这段
// if (num_fixedKF < 2)
// {
// list<KeyFrame *>::iterator lit = lLocalKeyFrames.begin();
// int lowerId = pKF->mnId;
// KeyFrame *pLowerKf;
// int secondLowerId = pKF->mnId;
// KeyFrame *pSecondLowerKF;
// for (; lit != lLocalKeyFrames.end(); lit++)
// {
// KeyFrame *pKFi = *lit;
// if (pKFi == pKF || pKFi->mnId == pMap->GetInitKFid())
// {
// continue;
// }
// if (pKFi->mnId < lowerId)
// {
// lowerId = pKFi->mnId;
// pLowerKf = pKFi;
// }
// else if (pKFi->mnId < secondLowerId)
// {
// secondLowerId = pKFi->mnId;
// pSecondLowerKF = pKFi;
// }
// }
// lFixedCameras.push_back(pLowerKf);
// lLocalKeyFrames.remove(pLowerKf);
// num_fixedKF++;
// if (num_fixedKF < 2)
// {
// lFixedCameras.push_back(pSecondLowerKF);
// lLocalKeyFrames.remove(pSecondLowerKF);
// num_fixedKF++;
// }
// }
2022-07-21 21:32:11 +08:00
if (num_fixedKF == 0)
2020-12-01 11:58:17 +08:00
{
2022-03-28 21:20:28 +08:00
Verbose::PrintMess("LM-LBA: There are 0 fixed KF in the optimizations, LBA aborted", Verbose::VERBOSITY_NORMAL);
2021-08-09 19:34:51 +08:00
return;
2020-12-01 11:58:17 +08:00
}
// Setup optimizer
2022-07-21 22:27:32 +08:00
// 步骤5构造g2o优化器
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolver_6_3::PoseMatrixType>();
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3 *solver_ptr = new g2o::BlockSolver_6_3(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2022-03-28 21:20:28 +08:00
if (pMap->IsInertial())
solver->setUserLambdaInit(100.0);
2020-12-01 11:58:17 +08:00
optimizer.setAlgorithm(solver);
optimizer.setVerbose(false);
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
2020-12-01 11:58:17 +08:00
optimizer.setForceStopFlag(pbStopFlag);
unsigned long maxKFid = 0;
2022-03-28 21:20:28 +08:00
// DEBUG LBA
pCurrentMap->msOptKFs.clear();
pCurrentMap->msFixedKFs.clear();
2020-12-01 11:58:17 +08:00
// Set Local KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 步骤6添加顶点Pose of Local KeyFrame
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator lit = lLocalKeyFrames.begin(), lend = lLocalKeyFrames.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = *lit;
g2o::VertexSE3Expmap *vSE3 = new g2o::VertexSE3Expmap();
2022-03-28 21:20:28 +08:00
Sophus::SE3<float> Tcw = pKFi->GetPose();
vSE3->setEstimate(g2o::SE3Quat(Tcw.unit_quaternion().cast<double>(), Tcw.translation().cast<double>()));
2020-12-01 11:58:17 +08:00
vSE3->setId(pKFi->mnId);
2022-07-21 21:32:11 +08:00
vSE3->setFixed(pKFi->mnId == pMap->GetInitKFid());
2020-12-01 11:58:17 +08:00
optimizer.addVertex(vSE3);
2022-07-21 21:32:11 +08:00
if (pKFi->mnId > maxKFid)
maxKFid = pKFi->mnId;
2022-03-28 21:20:28 +08:00
// DEBUG LBA
pCurrentMap->msOptKFs.insert(pKFi->mnId);
2020-12-01 11:58:17 +08:00
}
2022-03-28 21:20:28 +08:00
num_OptKF = lLocalKeyFrames.size();
2020-12-01 11:58:17 +08:00
// Set Fixed KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 步骤7添加顶点Pose of Fixed KeyFrame注意这里调用了vSE3->setFixed(true)。
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator lit = lFixedCameras.begin(), lend = lFixedCameras.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = *lit;
g2o::VertexSE3Expmap *vSE3 = new g2o::VertexSE3Expmap();
2022-03-28 21:20:28 +08:00
Sophus::SE3<float> Tcw = pKFi->GetPose();
2022-07-21 21:32:11 +08:00
vSE3->setEstimate(g2o::SE3Quat(Tcw.unit_quaternion().cast<double>(), Tcw.translation().cast<double>()));
2020-12-01 11:58:17 +08:00
vSE3->setId(pKFi->mnId);
vSE3->setFixed(true);
optimizer.addVertex(vSE3);
2022-07-21 21:32:11 +08:00
if (pKFi->mnId > maxKFid)
maxKFid = pKFi->mnId;
2022-03-28 21:20:28 +08:00
// DEBUG LBA
pCurrentMap->msFixedKFs.insert(pKFi->mnId);
2020-12-01 11:58:17 +08:00
}
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
// 步骤7添加3D顶点
// 存放的方式(举例)
// 边id: 1 2 3 4 5 6 7 8 9
// KFid: 1 2 3 4 1 2 3 2 3
// MPid: 1 1 1 1 2 2 2 3 3
// 所以这个个数大约是点数×帧数,实际肯定比这个要少
2022-07-21 21:32:11 +08:00
const int nExpectedSize = (lLocalKeyFrames.size() + lFixedCameras.size()) * lLocalMapPoints.size();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 存放单目时的边
2022-07-21 21:32:11 +08:00
vector<ORB_SLAM3::EdgeSE3ProjectXYZ *> vpEdgesMono;
2020-12-01 11:58:17 +08:00
vpEdgesMono.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放双目鱼眼时另一个相机的边
2022-07-21 21:32:11 +08:00
vector<ORB_SLAM3::EdgeSE3ProjectXYZToBody *> vpEdgesBody;
2020-12-01 11:58:17 +08:00
vpEdgesBody.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放单目时的KF
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFMono;
2020-12-01 11:58:17 +08:00
vpEdgeKFMono.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放单目时的MP
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 存放双目鱼眼时另一个相机的KF
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFBody;
2020-12-01 11:58:17 +08:00
vpEdgeKFBody.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放单目时的MP
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeMono;
2020-12-01 11:58:17 +08:00
vpMapPointEdgeMono.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放双目鱼眼时另一个相机的MP
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeBody;
2020-12-01 11:58:17 +08:00
vpMapPointEdgeBody.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放双目时的边
2022-07-21 21:32:11 +08:00
vector<g2o::EdgeStereoSE3ProjectXYZ *> vpEdgesStereo;
2020-12-01 11:58:17 +08:00
vpEdgesStereo.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放双目时的KF
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFStereo;
2020-12-01 11:58:17 +08:00
vpEdgeKFStereo.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// 存放双目时的MP
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeStereo;
2020-12-01 11:58:17 +08:00
vpMapPointEdgeStereo.reserve(nExpectedSize);
const float thHuberMono = sqrt(5.991);
const float thHuberStereo = sqrt(7.815);
int nPoints = 0;
2022-03-28 21:20:28 +08:00
int nEdges = 0;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 添加顶点MapPoint
2022-07-21 21:32:11 +08:00
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = *lit;
g2o::VertexSBAPointXYZ *vPoint = new g2o::VertexSBAPointXYZ();
2022-03-28 21:20:28 +08:00
vPoint->setEstimate(pMP->GetWorldPos().cast<double>());
2022-07-21 21:32:11 +08:00
int id = pMP->mnId + maxKFid + 1;
2020-12-01 11:58:17 +08:00
vPoint->setId(id);
2022-07-21 22:27:32 +08:00
// 这里的边缘化与滑动窗口不同而是为了加速稀疏矩阵的计算BlockSolver_6_3默认了6维度的不边缘化3自由度的三维点被边缘化所以所有三维点都设置边缘化
2020-12-01 11:58:17 +08:00
vPoint->setMarginalized(true);
optimizer.addVertex(vPoint);
nPoints++;
2022-07-21 21:32:11 +08:00
const map<KeyFrame *, tuple<int, int>> observations = pMP->GetObservations();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set edges
2022-07-21 22:27:32 +08:00
// 步骤8对每一对关联的MapPoint和KeyFrame构建边
2022-07-21 21:32:11 +08:00
for (map<KeyFrame *, tuple<int, int>>::const_iterator mit = observations.begin(), mend = observations.end(); mit != mend; mit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = mit->first;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pKFi->isBad() && pKFi->GetMap() == pCurrentMap)
2020-12-01 11:58:17 +08:00
{
2022-03-28 21:20:28 +08:00
const int leftIndex = get<0>(mit->second);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Monocular observation
2022-07-21 22:27:32 +08:00
// 单目
2022-07-21 21:32:11 +08:00
if (leftIndex != -1 && pKFi->mvuRight[get<0>(mit->second)] < 0)
2020-12-01 11:58:17 +08:00
{
2022-03-28 21:20:28 +08:00
const cv::KeyPoint &kpUn = pKFi->mvKeysUn[leftIndex];
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
2020-12-01 11:58:17 +08:00
obs << kpUn.pt.x, kpUn.pt.y;
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZ *e = new ORB_SLAM3::EdgeSE3ProjectXYZ();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
const float &invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave];
2022-07-21 21:32:11 +08:00
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2020-12-01 11:58:17 +08:00
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
e->pCamera = pKFi->mpCamera;
optimizer.addEdge(e);
vpEdgesMono.push_back(e);
vpEdgeKFMono.push_back(pKFi);
vpMapPointEdgeMono.push_back(pMP);
nEdges++;
}
2022-07-21 21:32:11 +08:00
else if (leftIndex != -1 && pKFi->mvuRight[get<0>(mit->second)] >= 0) // Stereo observation
2020-12-01 11:58:17 +08:00
{
2022-03-28 21:20:28 +08:00
const cv::KeyPoint &kpUn = pKFi->mvKeysUn[leftIndex];
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 3, 1> obs;
2022-03-28 21:20:28 +08:00
const float kp_ur = pKFi->mvuRight[get<0>(mit->second)];
2020-12-01 11:58:17 +08:00
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2022-07-21 21:32:11 +08:00
g2o::EdgeStereoSE3ProjectXYZ *e = new g2o::EdgeStereoSE3ProjectXYZ();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
const float &invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave];
2022-07-21 21:32:11 +08:00
Eigen::Matrix3d Info = Eigen::Matrix3d::Identity() * invSigma2;
2020-12-01 11:58:17 +08:00
e->setInformation(Info);
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2020-12-01 11:58:17 +08:00
e->setRobustKernel(rk);
rk->setDelta(thHuberStereo);
e->fx = pKFi->fx;
e->fy = pKFi->fy;
e->cx = pKFi->cx;
e->cy = pKFi->cy;
e->bf = pKFi->mbf;
optimizer.addEdge(e);
vpEdgesStereo.push_back(e);
vpEdgeKFStereo.push_back(pKFi);
vpMapPointEdgeStereo.push_back(pMP);
nEdges++;
}
2022-07-21 21:32:11 +08:00
if (pKFi->mpCamera2)
{
2020-12-01 11:58:17 +08:00
int rightIndex = get<1>(mit->second);
2022-07-21 21:32:11 +08:00
if (rightIndex != -1)
{
2020-12-01 11:58:17 +08:00
rightIndex -= pKFi->NLeft;
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
2020-12-01 11:58:17 +08:00
cv::KeyPoint kp = pKFi->mvKeysRight[rightIndex];
obs << kp.pt.x, kp.pt.y;
ORB_SLAM3::EdgeSE3ProjectXYZToBody *e = new ORB_SLAM3::EdgeSE3ProjectXYZToBody();
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
2020-12-01 11:58:17 +08:00
e->setMeasurement(obs);
const float &invSigma2 = pKFi->mvInvLevelSigma2[kp.octave];
2022-07-21 21:32:11 +08:00
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2020-12-01 11:58:17 +08:00
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
2022-07-21 21:32:11 +08:00
Sophus::SE3f Trl = pKFi->GetRelativePoseTrl();
2022-03-28 21:20:28 +08:00
e->mTrl = g2o::SE3Quat(Trl.unit_quaternion().cast<double>(), Trl.translation().cast<double>());
2020-12-01 11:58:17 +08:00
e->pCamera = pKFi->mpCamera2;
optimizer.addEdge(e);
vpEdgesBody.push_back(e);
vpEdgeKFBody.push_back(pKFi);
vpMapPointEdgeBody.push_back(pMP);
nEdges++;
}
}
}
}
}
2022-03-28 21:20:28 +08:00
num_edges = nEdges;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
if (*pbStopFlag)
2022-03-28 21:20:28 +08:00
return;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 步骤9开始优化
2020-12-01 11:58:17 +08:00
optimizer.initializeOptimization();
2022-03-28 21:20:28 +08:00
optimizer.optimize(10);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<pair<KeyFrame *, MapPoint *>> vToErase;
vToErase.reserve(vpEdgesMono.size() + vpEdgesBody.size() + vpEdgesStereo.size());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Check inlier observations
2022-07-21 22:27:32 +08:00
// 步骤10在优化后重新计算误差剔除连接误差比较大的关键帧和MapPoint
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZ *e = vpEdgesMono[i];
MapPoint *pMP = vpMapPointEdgeMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
if (e->chi2() > 5.991 || !e->isDepthPositive())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpEdgeKFMono[i];
vToErase.push_back(make_pair(pKFi, pMP));
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesBody.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZToBody *e = vpEdgesBody[i];
MapPoint *pMP = vpMapPointEdgeBody[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
if (e->chi2() > 5.991 || !e->isDepthPositive())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpEdgeKFBody[i];
vToErase.push_back(make_pair(pKFi, pMP));
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
g2o::EdgeStereoSE3ProjectXYZ *e = vpEdgesStereo[i];
MapPoint *pMP = vpMapPointEdgeStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
if (e->chi2() > 7.815 || !e->isDepthPositive())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpEdgeKFStereo[i];
vToErase.push_back(make_pair(pKFi, pMP));
2020-12-01 11:58:17 +08:00
}
}
// Get Map Mutex
2022-03-28 21:20:28 +08:00
unique_lock<mutex> lock(pMap->mMutexMapUpdate);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!vToErase.empty())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vToErase.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vToErase[i].first;
MapPoint *pMPi = vToErase[i].second;
2020-12-01 11:58:17 +08:00
pKFi->EraseMapPointMatch(pMPi);
pMPi->EraseObservation(pKFi);
}
}
// Recover optimized data
2022-07-21 21:32:11 +08:00
// Keyframes
2022-07-21 22:27:32 +08:00
bool bShowStats = false;
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator lit = lLocalKeyFrames.begin(), lend = lLocalKeyFrames.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = *lit;
g2o::VertexSE3Expmap *vSE3 = static_cast<g2o::VertexSE3Expmap *>(optimizer.vertex(pKFi->mnId));
2020-12-01 11:58:17 +08:00
g2o::SE3Quat SE3quat = vSE3->estimate();
2022-03-28 21:20:28 +08:00
Sophus::SE3f Tiw(SE3quat.rotation().cast<float>(), SE3quat.translation().cast<float>());
pKFi->SetPose(Tiw);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Points
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = *lit;
g2o::VertexSBAPointXYZ *vPoint = static_cast<g2o::VertexSBAPointXYZ *>(optimizer.vertex(pMP->mnId + maxKFid + 1));
2022-03-28 21:20:28 +08:00
pMP->SetWorldPos(vPoint->estimate().cast<float>());
2020-12-01 11:58:17 +08:00
pMP->UpdateNormalAndDepth();
}
2022-03-28 21:20:28 +08:00
pMap->IncreaseChangeIndex();
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
/**
* @brief BA LocalMapping IMU使imuLocalBundleAdjustment
*
* @param[in] pKF //关键帧
* @param[in] pbStopFlag //是否停止的标志
* @param[in] pMap //地图
* @param[in] num_fixedKF //固定不优化关键帧的数目
* @param[in] num_OptKF
* @param[in] num_MPs
* @param[in] num_edges
* @param[in] bLarge
* @param[in] bRecInit BA2false
*/
2022-07-21 21:32:11 +08:00
void Optimizer::LocalInertialBA(
KeyFrame *pKF, bool *pbStopFlag, Map *pMap, int &num_fixedKF, int &num_OptKF,
int &num_MPs, int &num_edges, bool bLarge, bool bRecInit)
{
2022-07-21 22:27:32 +08:00
// Step 1. 确定待优化的关键帧们
2022-07-21 21:32:11 +08:00
Map *pCurrentMap = pKF->GetMap();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
int maxOpt = 10; // 最大优化关键帧数目
int opt_it = 10; // 每次优化的迭代次数
2022-07-21 21:32:11 +08:00
if (bLarge)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
maxOpt = 25;
opt_it = 4;
}
2022-07-21 22:27:32 +08:00
// 预计待优化的关键帧数min函数是为了控制优化关键帧的数量
2022-07-21 21:32:11 +08:00
const int Nd = std::min((int)pCurrentMap->KeyFramesInMap() - 2, maxOpt);
const unsigned long maxKFid = pKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpOptimizableKFs;
const vector<KeyFrame *> vpNeighsKFs = pKF->GetVectorCovisibleKeyFrames();
list<KeyFrame *> lpOptVisKFs;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.reserve(Nd);
vpOptimizableKFs.push_back(pKF);
pKF->mnBALocalForKF = pKF->mnId;
for (int i = 1; i < Nd; i++)
{
if (vpOptimizableKFs.back()->mPrevKF)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.push_back(vpOptimizableKFs.back()->mPrevKF);
vpOptimizableKFs.back()->mnBALocalForKF = pKF->mnId;
2020-12-01 11:58:17 +08:00
}
else
2022-07-21 21:32:11 +08:00
break;
2021-12-08 22:09:39 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
int N = vpOptimizableKFs.size();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Optimizable points seen by temporal optimizable keyframes
2022-07-21 22:27:32 +08:00
// Step 2. 确定这些关键帧对应的地图点存入lLocalMapPoints
2022-07-21 21:32:11 +08:00
list<MapPoint *> lLocalMapPoints;
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMPs = vpOptimizableKFs[i]->GetMapPointMatches();
for (vector<MapPoint *>::iterator vit = vpMPs.begin(), vend = vpMPs.end(); vit != vend; vit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = *vit;
if (pMP)
if (!pMP->isBad())
if (pMP->mnBALocalForKF != pKF->mnId)
{
lLocalMapPoints.push_back(pMP);
pMP->mnBALocalForKF = pKF->mnId;
}
2021-12-08 22:09:39 +08:00
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Fixed Keyframe: First frame previous KF to optimization window)
2022-07-21 22:27:32 +08:00
// Step 3. 固定一帧为vpOptimizableKFs中最早的那一关键帧的上一关键帧如果没有上一关键帧了就用最早的那一帧毕竟目前得到的地图虽然有尺度但并不是绝对的位置
2022-07-21 21:32:11 +08:00
list<KeyFrame *> lFixedKeyFrames;
if (vpOptimizableKFs.back()->mPrevKF)
2021-12-08 22:09:39 +08:00
{
2022-07-21 21:32:11 +08:00
lFixedKeyFrames.push_back(vpOptimizableKFs.back()->mPrevKF);
vpOptimizableKFs.back()->mPrevKF->mnBAFixedForKF = pKF->mnId;
}
else
{
vpOptimizableKFs.back()->mnBALocalForKF = 0;
vpOptimizableKFs.back()->mnBAFixedForKF = pKF->mnId;
lFixedKeyFrames.push_back(vpOptimizableKFs.back());
vpOptimizableKFs.pop_back();
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Optimizable visual KFs
2022-07-21 22:27:32 +08:00
// 4. 做了一系列操作发现最后lpOptVisKFs为空。这段应该是调试遗留代码如果实现的话其实就是把共视图中在前面没有加过的关键帧们加进来
// 但作者可能发现之前就把共视图的全部帧加进来了,也有可能发现优化的效果不好浪费时间
// 获得与当前关键帧有共视关系的一些关键帧大于15个点排序为从小到大
2022-07-21 21:32:11 +08:00
const int maxCovKF = 0;
for (int i = 0, iend = vpNeighsKFs.size(); i < iend; i++)
{
if (lpOptVisKFs.size() >= maxCovKF)
break;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpNeighsKFs[i];
if (pKFi->mnBALocalForKF == pKF->mnId || pKFi->mnBAFixedForKF == pKF->mnId)
continue;
pKFi->mnBALocalForKF = pKF->mnId;
if (!pKFi->isBad() && pKFi->GetMap() == pCurrentMap)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
lpOptVisKFs.push_back(pKFi);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMPs = pKFi->GetMapPointMatches();
for (vector<MapPoint *>::iterator vit = vpMPs.begin(), vend = vpMPs.end(); vit != vend; vit++)
2021-12-08 22:09:39 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = *vit;
if (pMP)
if (!pMP->isBad())
if (pMP->mnBALocalForKF != pKF->mnId)
{
lLocalMapPoints.push_back(pMP);
pMP->mnBALocalForKF = pKF->mnId;
}
2021-12-08 22:09:39 +08:00
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Fixed KFs which are not covisible optimizable
2022-07-21 22:27:32 +08:00
// 5. 将所有mp点对应的关键帧除了前面加过的放入到固定组里面后面优化时不改变
2022-07-21 21:32:11 +08:00
const int maxFixKF = 200;
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
{
map<KeyFrame *, tuple<int, int>> observations = (*lit)->GetObservations();
for (map<KeyFrame *, tuple<int, int>>::iterator mit = observations.begin(), mend = observations.end(); mit != mend; mit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = mit->first;
if (pKFi->mnBALocalForKF != pKF->mnId && pKFi->mnBAFixedForKF != pKF->mnId)
2021-12-08 22:09:39 +08:00
{
2022-07-21 21:32:11 +08:00
pKFi->mnBAFixedForKF = pKF->mnId;
if (!pKFi->isBad())
2021-12-08 22:09:39 +08:00
{
2022-07-21 21:32:11 +08:00
lFixedKeyFrames.push_back(pKFi);
break;
2021-12-08 22:09:39 +08:00
}
}
}
2022-07-21 21:32:11 +08:00
if (lFixedKeyFrames.size() >= maxFixKF)
break;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
bool bNonFixed = (lFixedKeyFrames.size() == 0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Setup optimizer
2022-07-21 22:27:32 +08:00
// 6. 构造优化器,正式开始优化
2022-07-21 21:32:11 +08:00
g2o::SparseOptimizer optimizer;
g2o::BlockSolverX::LinearSolverType *linearSolver;
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolverX::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (bLarge)
{
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
solver->setUserLambdaInit(1e-2); // to avoid iterating for finding optimal lambda
optimizer.setAlgorithm(solver);
}
else
{
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
solver->setUserLambdaInit(1e0);
optimizer.setAlgorithm(solver);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Set Local temporal KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 7. 建立关于关键帧的节点,其中包括,位姿,速度,以及两个偏置
2022-07-21 21:32:11 +08:00
N = vpOptimizableKFs.size();
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpOptimizableKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexPose *VP = new VertexPose(pKFi);
VP->setId(pKFi->mnId);
VP->setFixed(false);
optimizer.addVertex(VP);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->bImu)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + 3 * (pKFi->mnId) + 1);
VV->setFixed(false);
optimizer.addVertex(VV);
VertexGyroBias *VG = new VertexGyroBias(pKFi);
VG->setId(maxKFid + 3 * (pKFi->mnId) + 2);
VG->setFixed(false);
optimizer.addVertex(VG);
VertexAccBias *VA = new VertexAccBias(pKFi);
VA->setId(maxKFid + 3 * (pKFi->mnId) + 3);
VA->setFixed(false);
optimizer.addVertex(VA);
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
// Set Local visual KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 8. 建立关于共视关键帧的节点,但这里为空
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator it = lpOptVisKFs.begin(), itEnd = lpOptVisKFs.end(); it != itEnd; it++)
{
KeyFrame *pKFi = *it;
VertexPose *VP = new VertexPose(pKFi);
VP->setId(pKFi->mnId);
VP->setFixed(false);
optimizer.addVertex(VP);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Fixed KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 9. 建立关于固定关键帧的节点,其中包括,位姿,速度,以及两个偏置
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator lit = lFixedKeyFrames.begin(), lend = lFixedKeyFrames.end(); lit != lend; lit++)
{
KeyFrame *pKFi = *lit;
VertexPose *VP = new VertexPose(pKFi);
VP->setId(pKFi->mnId);
VP->setFixed(true);
optimizer.addVertex(VP);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->bImu) // This should be done only for keyframe just before temporal window
{
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + 3 * (pKFi->mnId) + 1);
VV->setFixed(true);
optimizer.addVertex(VV);
VertexGyroBias *VG = new VertexGyroBias(pKFi);
VG->setId(maxKFid + 3 * (pKFi->mnId) + 2);
VG->setFixed(true);
optimizer.addVertex(VG);
VertexAccBias *VA = new VertexAccBias(pKFi);
VA->setId(maxKFid + 3 * (pKFi->mnId) + 3);
VA->setFixed(true);
optimizer.addVertex(VA);
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Create intertial constraints
2022-07-21 22:27:32 +08:00
// 暂时没看到有什么用
2022-07-21 21:32:11 +08:00
vector<EdgeInertial *> vei(N, (EdgeInertial *)NULL);
vector<EdgeGyroRW *> vegr(N, (EdgeGyroRW *)NULL);
vector<EdgeAccRW *> vear(N, (EdgeAccRW *)NULL);
2022-07-21 22:27:32 +08:00
// 10. 建立惯性边没有imu跳过
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpOptimizableKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pKFi->mPrevKF)
{
cout << "NOT INERTIAL LINK TO PREVIOUS FRAME!!!!" << endl;
continue;
}
if (pKFi->bImu && pKFi->mPrevKF->bImu && pKFi->mpImuPreintegrated)
{
pKFi->mpImuPreintegrated->SetNewBias(pKFi->mPrevKF->GetImuBias());
g2o::HyperGraph::Vertex *VP1 = optimizer.vertex(pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VV1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 1);
g2o::HyperGraph::Vertex *VG1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 2);
g2o::HyperGraph::Vertex *VA1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 3);
g2o::HyperGraph::Vertex *VP2 = optimizer.vertex(pKFi->mnId);
g2o::HyperGraph::Vertex *VV2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 1);
g2o::HyperGraph::Vertex *VG2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 2);
g2o::HyperGraph::Vertex *VA2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 3);
if (!VP1 || !VV1 || !VG1 || !VA1 || !VP2 || !VV2 || !VG2 || !VA2)
{
cerr << "Error " << VP1 << ", " << VV1 << ", " << VG1 << ", " << VA1 << ", " << VP2 << ", " << VV2 << ", " << VG2 << ", " << VA2 << endl;
continue;
}
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
vei[i] = new EdgeInertial(pKFi->mpImuPreintegrated);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vei[i]->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP1));
vei[i]->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV1));
vei[i]->setVertex(2, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG1));
vei[i]->setVertex(3, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA1));
vei[i]->setVertex(4, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP2));
vei[i]->setVertex(5, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV2));
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 到最早的一个可优化的关键帧或者地图没有ba2时添加鲁棒核函数
2022-07-21 21:32:11 +08:00
if (i == N - 1 || bRecInit)
{
// All inertial residuals are included without robust cost function, but not that one linking the
// last optimizable keyframe inside of the local window and the first fixed keyframe out. The
// information matrix for this measurement is also downweighted. This is done to avoid accumulating
// error due to fixing variables.
2022-07-21 22:27:32 +08:00
// 所有惯性残差都没有鲁棒核,但不包括窗口内最早一个可优化关键帧与第一个固定关键帧链接起来的惯性残差。
// 该度量的信息矩阵也被降权。这样做是为了避免由于固定变量而累积错误。
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rki = new g2o::RobustKernelHuber;
vei[i]->setRobustKernel(rki);
if (i == N - 1)
vei[i]->setInformation(vei[i]->information() * 1e-2);
rki->setDelta(sqrt(16.92));
}
optimizer.addEdge(vei[i]);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vegr[i] = new EdgeGyroRW();
vegr[i]->setVertex(0, VG1);
vegr[i]->setVertex(1, VG2);
Eigen::Matrix3d InfoG = pKFi->mpImuPreintegrated->C.block<3, 3>(9, 9).cast<double>().inverse();
vegr[i]->setInformation(InfoG);
optimizer.addEdge(vegr[i]);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vear[i] = new EdgeAccRW();
vear[i]->setVertex(0, VA1);
vear[i]->setVertex(1, VA2);
Eigen::Matrix3d InfoA = pKFi->mpImuPreintegrated->C.block<3, 3>(12, 12).cast<double>().inverse();
vear[i]->setInformation(InfoA);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(vear[i]);
}
else
cout << "ERROR building inertial edge" << endl;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Set MapPoint vertices
const int nExpectedSize = (N + lFixedKeyFrames.size()) * lLocalMapPoints.size();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Mono
vector<EdgeMono *> vpEdgesMono;
vpEdgesMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFMono;
vpEdgeKFMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeMono;
vpMapPointEdgeMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Stereo
vector<EdgeStereo *> vpEdgesStereo;
vpEdgesStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFStereo;
vpEdgeKFStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeStereo;
vpMapPointEdgeStereo.reserve(nExpectedSize);
2022-03-28 21:20:28 +08:00
2022-07-21 22:27:32 +08:00
// 11. 建立视觉边
2022-07-21 21:32:11 +08:00
const float thHuberMono = sqrt(5.991);
const float chi2Mono2 = 5.991;
const float thHuberStereo = sqrt(7.815);
const float chi2Stereo2 = 7.815;
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
const unsigned long iniMPid = maxKFid * 5;
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
map<int, int> mVisEdges;
for (int i = 0; i < N; i++)
{
KeyFrame *pKFi = vpOptimizableKFs[i];
mVisEdges[pKFi->mnId] = 0;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator lit = lFixedKeyFrames.begin(), lend = lFixedKeyFrames.end(); lit != lend; lit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
mVisEdges[(*lit)->mnId] = 0;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
{
MapPoint *pMP = *lit;
g2o::VertexSBAPointXYZ *vPoint = new g2o::VertexSBAPointXYZ();
vPoint->setEstimate(pMP->GetWorldPos().cast<double>());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
unsigned long id = pMP->mnId + iniMPid + 1;
vPoint->setId(id);
vPoint->setMarginalized(true);
optimizer.addVertex(vPoint);
const map<KeyFrame *, tuple<int, int>> observations = pMP->GetObservations();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Create visual constraints
for (map<KeyFrame *, tuple<int, int>>::const_iterator mit = observations.begin(), mend = observations.end(); mit != mend; mit++)
{
KeyFrame *pKFi = mit->first;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mnBALocalForKF != pKF->mnId && pKFi->mnBAFixedForKF != pKF->mnId)
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pKFi->isBad() && pKFi->GetMap() == pCurrentMap)
{
const int leftIndex = get<0>(mit->second);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
cv::KeyPoint kpUn;
2021-08-09 19:34:51 +08:00
2022-07-21 21:32:11 +08:00
// Monocular left observation
if (leftIndex != -1 && pKFi->mvuRight[leftIndex] < 0)
{
mVisEdges[pKFi->mnId]++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
kpUn = pKFi->mvKeysUn[leftIndex];
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeMono *e = new EdgeMono(0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
e->setMeasurement(obs);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
const float unc2 = pKFi->mpCamera->uncertainty2(obs);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float &invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave] / unc2;
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
vpEdgesMono.push_back(e);
vpEdgeKFMono.push_back(pKFi);
vpMapPointEdgeMono.push_back(pMP);
}
// Stereo-observation
else if (leftIndex != -1) // Stereo observation
{
kpUn = pKFi->mvKeysUn[leftIndex];
mVisEdges[pKFi->mnId]++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float kp_ur = pKFi->mvuRight[leftIndex];
Eigen::Matrix<double, 3, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeStereo *e = new EdgeStereo(0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
e->setMeasurement(obs);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
const float unc2 = pKFi->mpCamera->uncertainty2(obs.head(2));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float &invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave] / unc2;
e->setInformation(Eigen::Matrix3d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuberStereo);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
vpEdgesStereo.push_back(e);
vpEdgeKFStereo.push_back(pKFi);
vpMapPointEdgeStereo.push_back(pMP);
2022-03-28 21:20:28 +08:00
}
2022-07-21 21:32:11 +08:00
// Monocular right observation
if (pKFi->mpCamera2)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
int rightIndex = get<1>(mit->second);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (rightIndex != -1)
{
rightIndex -= pKFi->NLeft;
mVisEdges[pKFi->mnId]++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
cv::KeyPoint kp = pKFi->mvKeysRight[rightIndex];
obs << kp.pt.x, kp.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeMono *e = new EdgeMono(1);
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
e->setMeasurement(obs);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Add here uncerteinty
const float unc2 = pKFi->mpCamera->uncertainty2(obs);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float &invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave] / unc2;
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
vpEdgesMono.push_back(e);
vpEdgeKFMono.push_back(pKFi);
vpMapPointEdgeMono.push_back(pMP);
2022-03-28 21:20:28 +08:00
}
2020-12-01 11:58:17 +08:00
}
}
}
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// cout << "Total map points: " << lLocalMapPoints.size() << endl;
// TODO debug会报错先注释掉
for (map<int, int>::iterator mit = mVisEdges.begin(), mend = mVisEdges.end(); mit != mend; mit++)
{
assert(mit->second >= 3);
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 12. 开始优化
2020-12-01 11:58:17 +08:00
optimizer.initializeOptimization();
2022-07-21 21:32:11 +08:00
optimizer.computeActiveErrors();
2022-07-21 22:27:32 +08:00
2022-07-21 21:32:11 +08:00
float err = optimizer.activeRobustChi2();
optimizer.optimize(opt_it); // Originally to 2
float err_end = optimizer.activeRobustChi2();
if (pbStopFlag)
optimizer.setForceStopFlag(pbStopFlag);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<pair<KeyFrame *, MapPoint *>> vToErase;
vToErase.reserve(vpEdgesMono.size() + vpEdgesStereo.size());
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 13. 开始确认待删除的连接关系
2022-07-21 21:32:11 +08:00
// Check inlier observations
// Mono
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
EdgeMono *e = vpEdgesMono[i];
MapPoint *pMP = vpMapPointEdgeMono[i];
bool bClose = pMP->mTrackDepth < 10.f;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if ((e->chi2() > chi2Mono2 && !bClose) || (e->chi2() > 1.5f * chi2Mono2 && bClose) || !e->isDepthPositive())
{
KeyFrame *pKFi = vpEdgeKFMono[i];
vToErase.push_back(make_pair(pKFi, pMP));
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Stereo
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
EdgeStereo *e = vpEdgesStereo[i];
MapPoint *pMP = vpMapPointEdgeStereo[i];
if (pMP->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
if (e->chi2() > chi2Stereo2)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpEdgeKFStereo[i];
vToErase.push_back(make_pair(pKFi, pMP));
2022-03-28 21:20:28 +08:00
}
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Get Map Mutex and erase outliers
unique_lock<mutex> lock(pMap->mMutexMapUpdate);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// TODO: Some convergence problems have been detected here
if ((2 * err < err_end || isnan(err) || isnan(err_end)) && !bLarge) // bGN)
{
cout << "FAIL LOCAL-INERTIAL BA!!!!" << endl;
return;
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 14. 删除连接关系
2022-07-21 21:32:11 +08:00
if (!vToErase.empty())
{
for (size_t i = 0; i < vToErase.size(); i++)
{
KeyFrame *pKFi = vToErase[i].first;
MapPoint *pMPi = vToErase[i].second;
pKFi->EraseMapPointMatch(pMPi);
pMPi->EraseObservation(pKFi);
2022-03-28 21:20:28 +08:00
}
2022-07-21 21:32:11 +08:00
}
for (list<KeyFrame *>::iterator lit = lFixedKeyFrames.begin(), lend = lFixedKeyFrames.end(); lit != lend; lit++)
(*lit)->mnBAFixedForKF = 0;
2022-07-21 22:27:32 +08:00
// 15. 取出结果
2022-07-21 21:32:11 +08:00
// Recover optimized data
// Local temporal Keyframes
N = vpOptimizableKFs.size();
for (int i = 0; i < N; i++)
{
KeyFrame *pKFi = vpOptimizableKFs[i];
VertexPose *VP = static_cast<VertexPose *>(optimizer.vertex(pKFi->mnId));
Sophus::SE3f Tcw(VP->estimate().Rcw[0].cast<float>(), VP->estimate().tcw[0].cast<float>());
pKFi->SetPose(Tcw);
pKFi->mnBALocalForKF = 0;
if (pKFi->bImu)
2021-12-08 22:09:39 +08:00
{
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = static_cast<VertexVelocity *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 1));
pKFi->SetVelocity(VV->estimate().cast<float>());
VertexGyroBias *VG = static_cast<VertexGyroBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 2));
VertexAccBias *VA = static_cast<VertexAccBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 3));
Vector6d b;
b << VG->estimate(), VA->estimate();
pKFi->SetNewBias(IMU::Bias(b[3], b[4], b[5], b[0], b[1], b[2]));
2021-12-08 22:09:39 +08:00
}
2022-07-21 21:32:11 +08:00
}
// Local visual KeyFrame
2022-07-21 22:27:32 +08:00
// 空
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator it = lpOptVisKFs.begin(), itEnd = lpOptVisKFs.end(); it != itEnd; it++)
{
KeyFrame *pKFi = *it;
VertexPose *VP = static_cast<VertexPose *>(optimizer.vertex(pKFi->mnId));
Sophus::SE3f Tcw(VP->estimate().Rcw[0].cast<float>(), VP->estimate().tcw[0].cast<float>());
pKFi->SetPose(Tcw);
pKFi->mnBALocalForKF = 0;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Points
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
{
MapPoint *pMP = *lit;
g2o::VertexSBAPointXYZ *vPoint = static_cast<g2o::VertexSBAPointXYZ *>(optimizer.vertex(pMP->mnId + iniMPid + 1));
pMP->SetWorldPos(vPoint->estimate().cast<float>());
pMP->UpdateNormalAndDepth();
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
pMap->IncreaseChangeIndex();
}
/**************************************以下为全局优化**************************************************************/
2022-07-21 22:27:32 +08:00
/**
* @brief BA pMapMapPointsbundle adjustment
* BA使
* 1CreateInitialMapMonocular
* 2RunGlobalBundleAdjustment
* @param[in] pMap
* @param[in] nIterations
* @param[in] pbStopFlag BA
* @param[in] nLoopKF id
* @param[in] bRobust 使
*/
void Optimizer::GlobalBundleAdjustemnt(Map *pMap, int nIterations, bool *pbStopFlag, const unsigned long nLoopKF, const bool bRobust)
2022-07-21 21:32:11 +08:00
{
2022-07-21 22:27:32 +08:00
// 获取地图中的所有关键帧
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpKFs = pMap->GetAllKeyFrames();
2022-07-21 22:27:32 +08:00
// 获取地图中的所有地图点
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMP = pMap->GetAllMapPoints();
2022-07-21 22:27:32 +08:00
// 调用GBA
2022-07-21 21:32:11 +08:00
BundleAdjustment(vpKFs, vpMP, nIterations, pbStopFlag, nLoopKF, bRobust);
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
/**
* @brief bundle adjustment
* @param[in] vpKFs BA
* @param[in] vpMP BA
* @param[in] nIterations
* @param[in] pbStopFlag BA
* @param[in] nLoopKF id
* @param[in] bRobust 使
*/
2022-07-21 21:32:11 +08:00
void Optimizer::BundleAdjustment(
const vector<KeyFrame *> &vpKFs, const vector<MapPoint *> &vpMP,
int nIterations, bool *pbStopFlag, const unsigned long nLoopKF, const bool bRobust)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 不参与优化的地图点,下面会用到
2022-07-21 21:32:11 +08:00
vector<bool> vbNotIncludedMP;
vbNotIncludedMP.resize(vpMP.size());
Map *pMap = vpKFs[0]->GetMap();
2022-07-21 22:27:32 +08:00
// Step 1 初始化g2o优化器
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolver_6_3::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3 *solver_ptr = new g2o::BlockSolver_6_3(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 使用LM算法优化
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2022-03-28 21:20:28 +08:00
optimizer.setAlgorithm(solver);
2022-07-21 21:32:11 +08:00
optimizer.setVerbose(false);
2022-07-21 22:27:32 +08:00
// 如果这个时候外部请求终止,那就结束
// 注意这句执行之后外部再请求结束BA就结束不了了
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
optimizer.setForceStopFlag(pbStopFlag);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 记录添加到优化器中的顶点的最大关键帧id
2022-07-21 21:32:11 +08:00
long unsigned int maxKFid = 0;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nExpectedSize = (vpKFs.size()) * vpMP.size();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<ORB_SLAM3::EdgeSE3ProjectXYZ *> vpEdgesMono;
vpEdgesMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<ORB_SLAM3::EdgeSE3ProjectXYZToBody *> vpEdgesBody;
vpEdgesBody.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFMono;
vpEdgeKFMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFBody;
vpEdgeKFBody.reserve(nExpectedSize);
vector<MapPoint *> vpMapPointEdgeMono;
vpMapPointEdgeMono.reserve(nExpectedSize);
vector<MapPoint *> vpMapPointEdgeBody;
vpMapPointEdgeBody.reserve(nExpectedSize);
vector<g2o::EdgeStereoSE3ProjectXYZ *> vpEdgesStereo;
vpEdgesStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFStereo;
vpEdgeKFStereo.reserve(nExpectedSize);
vector<MapPoint *> vpMapPointEdgeStereo;
vpMapPointEdgeStereo.reserve(nExpectedSize);
2022-07-21 22:27:32 +08:00
// Step 2 向优化器添加顶点
2022-07-21 21:32:11 +08:00
// Set KeyFrame vertices
2022-07-21 22:27:32 +08:00
// Step 2.1 :向优化器添加关键帧位姿顶点
// 对于当前地图中的所有关键帧
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = vpKFs[i];
2022-07-21 22:27:32 +08:00
// 去除无效的
2022-07-21 21:32:11 +08:00
if (pKF->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 22:27:32 +08:00
// 对于每一个能用的关键帧构造SE3顶点,其实就是当前关键帧的位姿
2022-07-21 21:32:11 +08:00
g2o::VertexSE3Expmap *vSE3 = new g2o::VertexSE3Expmap();
Sophus::SE3<float> Tcw = pKF->GetPose();
vSE3->setEstimate(g2o::SE3Quat(Tcw.unit_quaternion().cast<double>(), Tcw.translation().cast<double>()));
vSE3->setId(pKF->mnId);
2022-07-21 22:27:32 +08:00
// 只有第0帧关键帧不优化参考基准
2022-07-21 21:32:11 +08:00
vSE3->setFixed(pKF->mnId == pMap->GetInitKFid());
2022-07-21 22:27:32 +08:00
// 向优化器中添加顶点并且更新maxKFid
2022-07-21 21:32:11 +08:00
optimizer.addVertex(vSE3);
if (pKF->mnId > maxKFid)
maxKFid = pKF->mnId;
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 卡方分布 95% 以上可信度的时候的阈值
const float thHuber2D = sqrt(5.99); // 自由度为2
const float thHuber3D = sqrt(7.815); // 自由度为3
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
// Step 2.2向优化器添加MapPoints顶点
// 遍历地图中的所有地图点
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpMP.size(); i++)
{
MapPoint *pMP = vpMP[i];
2022-07-21 22:27:32 +08:00
// 跳过无效地图点
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2022-07-21 22:27:32 +08:00
// 创建顶点
2022-07-21 21:32:11 +08:00
g2o::VertexSBAPointXYZ *vPoint = new g2o::VertexSBAPointXYZ();
vPoint->setEstimate(pMP->GetWorldPos().cast<double>());
2022-07-21 22:27:32 +08:00
// 前面记录maxKFid 是在这里使用的
2022-07-21 21:32:11 +08:00
const int id = pMP->mnId + maxKFid + 1;
vPoint->setId(id);
2022-07-21 22:27:32 +08:00
// g2o在做BA的优化时必须将其所有地图点全部schur掉否则会出错。
// 原因是使用了g2o::LinearSolver<BalBlockSolver::PoseMatrixType>这个类型来指定linearsolver,
// 其中模板参数当中的位姿矩阵类型在程序中为相机姿态参数的维度于是BA当中schur消元后解得线性方程组必须是只含有相机姿态变量。
// Ceres库则没有这样的限制
2022-07-21 21:32:11 +08:00
vPoint->setMarginalized(true);
optimizer.addVertex(vPoint);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 边的关系,其实就是点和关键帧之间观测的关系
2022-07-21 21:32:11 +08:00
const map<KeyFrame *, tuple<int, int>> observations = pMP->GetObservations();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 边计数
2022-07-21 21:32:11 +08:00
int nEdges = 0;
// SET EDGES
2022-07-21 22:27:32 +08:00
// Step 3向优化器添加投影边是在遍历地图点、添加地图点的顶点的时候顺便添加的
// 遍历观察到当前地图点的所有关键帧
2022-07-21 21:32:11 +08:00
for (map<KeyFrame *, tuple<int, int>>::const_iterator mit = observations.begin(); mit != observations.end(); mit++)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = mit->first;
2022-07-21 22:27:32 +08:00
// 滤出不合法的关键帧
2022-07-21 21:32:11 +08:00
if (pKF->isBad() || pKF->mnId > maxKFid)
2022-03-28 21:20:28 +08:00
continue;
2022-07-21 21:32:11 +08:00
if (optimizer.vertex(id) == NULL || optimizer.vertex(pKF->mnId) == NULL)
continue;
nEdges++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int leftIndex = get<0>(mit->second);
if (leftIndex != -1 && pKF->mvuRight[get<0>(mit->second)] < 0)
2022-03-28 21:20:28 +08:00
{
2022-07-21 22:27:32 +08:00
// 如果是单目相机按照下面操作
2022-07-21 21:32:11 +08:00
const cv::KeyPoint &kpUn = pKF->mvKeysUn[leftIndex];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 创建边
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZ *e = new ORB_SLAM3::EdgeSE3ProjectXYZ();
2022-07-21 22:27:32 +08:00
// 填充数据,构造约束关系
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKF->mnId)));
e->setMeasurement(obs);
2022-07-21 22:27:32 +08:00
// 信息矩阵也是协方差表明了这个约束的观测在各个维度x,y上的可信程度在我们这里对于具体的一个点两个坐标的可信程度都是相同的
// 其可信程度受到特征点在图像金字塔中的图层有关,图层越高,可信度越差
// 为了避免出现信息矩阵中元素为负数的情况这里使用的是sigma^(-2)
2022-07-21 21:32:11 +08:00
const float &invSigma2 = pKF->mvInvLevelSigma2[kpUn.octave];
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 如果要使用鲁棒核函数
2022-07-21 21:32:11 +08:00
if (bRobust)
{
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
2022-07-21 22:27:32 +08:00
// 这里的重投影误差自由度为2所以这里设置为卡方分布中自由度为2的阈值如果重投影的误差大约大于1个像素的时候就认为不太靠谱的点了
// 核函数是为了避免其误差的平方项出现数值上过大的增长
2022-07-21 21:32:11 +08:00
rk->setDelta(thHuber2D);
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 设置相机内参
2022-07-21 21:32:11 +08:00
e->pCamera = pKF->mpCamera;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesMono.push_back(e);
vpEdgeKFMono.push_back(pKF);
vpMapPointEdgeMono.push_back(pMP);
}
else if (leftIndex != -1 && pKF->mvuRight[leftIndex] >= 0) // Stereo observation
{
2022-07-21 22:27:32 +08:00
// 双目或RGBD相机按照下面操作
// 双目相机的观测数据则是由三个部分组成投影点的x坐标投影点的y坐标以及投影点在右目中的x坐标默认y方向上已经对齐了
2022-07-21 21:32:11 +08:00
const cv::KeyPoint &kpUn = pKF->mvKeysUn[leftIndex];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 3, 1> obs;
const float kp_ur = pKF->mvuRight[get<0>(mit->second)];
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 对于双目输入g2o也有专门的误差边
2022-07-21 21:32:11 +08:00
g2o::EdgeStereoSE3ProjectXYZ *e = new g2o::EdgeStereoSE3ProjectXYZ();
2022-07-21 22:27:32 +08:00
// 填充
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKF->mnId)));
e->setMeasurement(obs);
2022-07-21 22:27:32 +08:00
// 信息矩阵这里是相同的,考虑的是左目特征点的所在图层
2022-07-21 21:32:11 +08:00
const float &invSigma2 = pKF->mvInvLevelSigma2[kpUn.octave];
Eigen::Matrix3d Info = Eigen::Matrix3d::Identity() * invSigma2;
e->setInformation(Info);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 如果要使用鲁棒核函数
2022-07-21 21:32:11 +08:00
if (bRobust)
{
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
2022-07-21 22:27:32 +08:00
// 由于现在的观测有三个值重投影误差会有三个平方项的和组成因此对应的卡方分布的自由度为3所以这里设置的也是自由度为3的时候的阈值
2022-07-21 21:32:11 +08:00
rk->setDelta(thHuber3D);
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 填充相机的基本参数
2022-07-21 21:32:11 +08:00
e->fx = pKF->fx;
e->fy = pKF->fy;
e->cx = pKF->cx;
e->cy = pKF->cy;
e->bf = pKF->mbf;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesStereo.push_back(e);
vpEdgeKFStereo.push_back(pKF);
vpMapPointEdgeStereo.push_back(pMP);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKF->mpCamera2)
{
int rightIndex = get<1>(mit->second);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (rightIndex != -1 && rightIndex < pKF->mvKeysRight.size())
{
rightIndex -= pKF->NLeft;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
cv::KeyPoint kp = pKF->mvKeysRight[rightIndex];
obs << kp.pt.x, kp.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZToBody *e = new ORB_SLAM3::EdgeSE3ProjectXYZToBody();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKF->mnId)));
e->setMeasurement(obs);
const float &invSigma2 = pKF->mvInvLevelSigma2[kp.octave];
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuber2D);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Sophus::SE3f Trl = pKF->GetRelativePoseTrl();
e->mTrl = g2o::SE3Quat(Trl.unit_quaternion().cast<double>(), Trl.translation().cast<double>());
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
e->pCamera = pKF->mpCamera2;
optimizer.addEdge(e);
vpEdgesBody.push_back(e);
vpEdgeKFBody.push_back(pKF);
vpMapPointEdgeBody.push_back(pMP);
}
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 22:27:32 +08:00
// 如果因为一些特殊原因,实际上并没有任何关键帧观测到当前的这个地图点,那么就删除掉这个顶点,并且这个地图点也就不参与优化
2022-07-21 21:32:11 +08:00
if (nEdges == 0)
{
optimizer.removeVertex(vPoint);
vbNotIncludedMP[i] = true;
}
else
{
vbNotIncludedMP[i] = false;
}
2022-03-28 21:20:28 +08:00
}
2021-08-09 19:34:51 +08:00
2022-07-21 21:32:11 +08:00
// Optimize!
2022-07-21 22:27:32 +08:00
// Step 4开始优化
2022-07-21 21:32:11 +08:00
optimizer.setVerbose(false);
2022-03-28 21:20:28 +08:00
optimizer.initializeOptimization();
2022-07-21 21:32:11 +08:00
optimizer.optimize(nIterations);
Verbose::PrintMess("BA: End of the optimization", Verbose::VERBOSITY_NORMAL);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Recover optimized data
2022-07-21 22:27:32 +08:00
// Step 5得到优化的结果
// Step 5.1 Keyframes
// 遍历所有的关键帧
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = vpKFs[i];
if (pKF->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 22:27:32 +08:00
// 获取到优化结果
2022-07-21 21:32:11 +08:00
g2o::VertexSE3Expmap *vSE3 = static_cast<g2o::VertexSE3Expmap *>(optimizer.vertex(pKF->mnId));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::SE3Quat SE3quat = vSE3->estimate();
2022-07-21 22:27:32 +08:00
2022-07-21 21:32:11 +08:00
if (nLoopKF == pMap->GetOriginKF()->mnId)
{
2022-07-21 22:27:32 +08:00
// 原则上来讲不会出现"当前闭环关键帧是第0帧"的情况,如果这种情况出现,只能够说明是在创建初始地图点的时候调用的这个全局BA函数.
// 这个时候,地图中就只有两个关键帧,其中优化后的位姿数据可以直接写入到帧的成员变量中
// 老白:视觉初始化时
2022-07-21 21:32:11 +08:00
pKF->SetPose(Sophus::SE3f(SE3quat.rotation().cast<float>(), SE3quat.translation().cast<float>()));
2022-03-28 21:20:28 +08:00
}
2022-07-21 21:32:11 +08:00
else
{
2022-07-21 22:27:32 +08:00
// 正常的操作,先把优化后的位姿写入到帧的一个专门的成员变量mTcwGBA中备用
2022-07-21 21:32:11 +08:00
pKF->mTcwGBA = Sophus::SE3d(SE3quat.rotation(), SE3quat.translation()).cast<float>();
2022-07-21 22:27:32 +08:00
pKF->mnBAGlobalForKF = nLoopKF; // 标记这个关键帧参与了这次全局优化
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 下面都是一些调试操作,计算优化前后的位移
2022-07-21 21:32:11 +08:00
Sophus::SE3f mTwc = pKF->GetPoseInverse();
Sophus::SE3f mTcGBA_c = pKF->mTcwGBA * mTwc;
Eigen::Vector3f vector_dist = mTcGBA_c.translation();
double dist = vector_dist.norm();
if (dist > 1)
{
int numMonoBadPoints = 0, numMonoOptPoints = 0;
int numStereoBadPoints = 0, numStereoOptPoints = 0;
vector<MapPoint *> vpMonoMPsOpt, vpStereoMPsOpt;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (size_t i2 = 0, iend = vpEdgesMono.size(); i2 < iend; i2++)
{
ORB_SLAM3::EdgeSE3ProjectXYZ *e = vpEdgesMono[i2];
MapPoint *pMP = vpMapPointEdgeMono[i2];
KeyFrame *pKFedge = vpEdgeKFMono[i2];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKF != pKFedge)
{
continue;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
if (e->chi2() > 5.991 || !e->isDepthPositive())
{
numMonoBadPoints++;
}
else
{
numMonoOptPoints++;
vpMonoMPsOpt.push_back(pMP);
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (size_t i2 = 0, iend = vpEdgesStereo.size(); i2 < iend; i2++)
{
g2o::EdgeStereoSE3ProjectXYZ *e = vpEdgesStereo[i2];
MapPoint *pMP = vpMapPointEdgeStereo[i2];
KeyFrame *pKFedge = vpEdgeKFMono[i2];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKF != pKFedge)
{
continue;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (e->chi2() > 7.815 || !e->isDepthPositive())
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
numStereoBadPoints++;
}
else
{
numStereoOptPoints++;
vpStereoMPsOpt.push_back(pMP);
2022-03-28 21:20:28 +08:00
}
2022-07-21 21:32:11 +08:00
}
}
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 22:27:32 +08:00
// Step 5.2 遍历所有地图点,去除其中没有参与优化过程的地图点
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpMP.size(); i++)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
if (vbNotIncludedMP[i])
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
MapPoint *pMP = vpMP[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 22:27:32 +08:00
// 获取优化之后的地图点的位置
2022-07-21 21:32:11 +08:00
g2o::VertexSBAPointXYZ *vPoint = static_cast<g2o::VertexSBAPointXYZ *>(optimizer.vertex(pMP->mnId + maxKFid + 1));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (nLoopKF == pMap->GetOriginKF()->mnId)
{
2022-07-21 22:27:32 +08:00
// 如果这个GBA是在创建初始地图的时候调用的话,那么地图点的位姿也可以直接写入
2022-07-21 21:32:11 +08:00
pMP->SetWorldPos(vPoint->estimate().cast<float>());
pMP->UpdateNormalAndDepth();
2021-12-08 22:09:39 +08:00
}
2022-07-21 21:32:11 +08:00
else
2021-12-08 22:09:39 +08:00
{
2022-07-21 22:27:32 +08:00
// 反之,如果是正常的闭环过程调用,就先临时保存一下
2022-07-21 21:32:11 +08:00
pMP->mPosGBA = vPoint->estimate().cast<float>();
pMP->mnBAGlobalForKF = nLoopKF;
2021-12-08 22:09:39 +08:00
}
2022-03-28 21:20:28 +08:00
}
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief imuLocalMapping::InitializeIMU使 LoopClosing::RunGlobalBundleAdjustment
* BAimuGlobalBundleAdjustemnt
* @param pMap
* @param its
* @param bFixLocal false
* @param nLoopId id
* @param pbStopFlag
* @param bInit priorGtrue0
* false使0
* @param priorG bInittrue使
* @param priorA
* @param vSingVal
* @param bHess
*/
2022-07-21 21:32:11 +08:00
void Optimizer::FullInertialBA(
Map *pMap, int its, const bool bFixLocal, const long unsigned int nLoopId, bool *pbStopFlag,
bool bInit, float priorG, float priorA, Eigen::VectorXd *vSingVal, bool *bHess)
{
2022-07-21 22:27:32 +08:00
// 获取地图里所有mp与kf以及最大kf的id
2022-07-21 21:32:11 +08:00
long unsigned int maxKFid = pMap->GetMaxKFid();
const vector<KeyFrame *> vpKFs = pMap->GetAllKeyFrames();
const vector<MapPoint *> vpMPs = pMap->GetAllMapPoints();
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Setup optimizer
2022-07-21 22:27:32 +08:00
// 1. 很经典的一套设置优化器流程
2022-03-28 21:20:28 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX::LinearSolverType *linearSolver;
2022-03-28 21:20:28 +08:00
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolverX::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
solver->setUserLambdaInit(1e-5);
optimizer.setAlgorithm(solver);
optimizer.setVerbose(false);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
optimizer.setForceStopFlag(pbStopFlag);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
int nNonFixed = 0;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 2. 设置关键帧与偏置节点
2022-07-21 21:32:11 +08:00
// Set KeyFrame vertices
2022-07-21 22:27:32 +08:00
KeyFrame *pIncKF; // vpKFs中最后一个id符合要求的关键帧
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
{
KeyFrame *pKFi = vpKFs[i];
if (pKFi->mnId > maxKFid)
continue;
VertexPose *VP = new VertexPose(pKFi);
2022-03-28 21:20:28 +08:00
VP->setId(pKFi->mnId);
2022-07-21 21:32:11 +08:00
pIncKF = pKFi;
bool bFixed = false;
if (bFixLocal)
{
bFixed = (pKFi->mnBALocalForKF >= (maxKFid - 1)) || (pKFi->mnBAFixedForKF >= (maxKFid - 1));
if (!bFixed)
nNonFixed++;
2022-07-21 22:27:32 +08:00
VP->setFixed(bFixed); // 固定,这里可能跟回环有关
2022-07-21 21:32:11 +08:00
}
2022-03-28 21:20:28 +08:00
optimizer.addVertex(VP);
2022-07-21 22:27:32 +08:00
// 如果是初始化的那几个及后面的关键帧,加入速度节点
2022-07-21 21:32:11 +08:00
if (pKFi->bImu)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + 3 * (pKFi->mnId) + 1);
VV->setFixed(bFixed);
2022-03-28 21:20:28 +08:00
optimizer.addVertex(VV);
2022-07-21 22:27:32 +08:00
// priorA==0.f 时 bInit为false也就是又加入了偏置节点
2022-07-21 21:32:11 +08:00
if (!bInit)
{
VertexGyroBias *VG = new VertexGyroBias(pKFi);
VG->setId(maxKFid + 3 * (pKFi->mnId) + 2);
VG->setFixed(bFixed);
optimizer.addVertex(VG);
VertexAccBias *VA = new VertexAccBias(pKFi);
VA->setId(maxKFid + 3 * (pKFi->mnId) + 3);
VA->setFixed(bFixed);
optimizer.addVertex(VA);
}
2020-12-01 11:58:17 +08:00
}
2021-12-08 22:09:39 +08:00
}
2022-07-21 22:27:32 +08:00
// priorA!=0.f 时 bInit为true加入了偏置节点
2022-07-21 21:32:11 +08:00
if (bInit)
2021-12-08 22:09:39 +08:00
{
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG = new VertexGyroBias(pIncKF);
VG->setId(4 * maxKFid + 2);
VG->setFixed(false);
optimizer.addVertex(VG);
VertexAccBias *VA = new VertexAccBias(pIncKF);
VA->setId(4 * maxKFid + 3);
VA->setFixed(false);
optimizer.addVertex(VA);
2022-03-28 21:20:28 +08:00
}
2022-07-21 22:27:32 +08:00
// false
2022-07-21 21:32:11 +08:00
if (bFixLocal)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
if (nNonFixed < 3)
return;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 3. 添加关于imu的边
2022-07-21 21:32:11 +08:00
// IMU links
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
2022-07-21 22:27:32 +08:00
// 必须有对应的上一个关键帧,感觉跟下面的判定冲突了
2022-07-21 21:32:11 +08:00
if (!pKFi->mPrevKF)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("NOT INERTIAL LINK TO PREVIOUS FRAME!", Verbose::VERBOSITY_NORMAL);
2020-12-01 11:58:17 +08:00
continue;
2021-12-08 22:09:39 +08:00
}
2022-07-21 21:32:11 +08:00
if (pKFi->mPrevKF && pKFi->mnId <= maxKFid)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pKFi->isBad() || pKFi->mPrevKF->mnId > maxKFid)
2021-12-08 22:09:39 +08:00
continue;
2022-07-21 22:27:32 +08:00
// 这两个都必须为初始化后的关键帧
2022-07-21 21:32:11 +08:00
if (pKFi->bImu && pKFi->mPrevKF->bImu)
2021-12-08 22:09:39 +08:00
{
2022-07-21 22:27:32 +08:00
// 3.1 根据上一帧的偏置设定当前帧的新偏置
2022-07-21 21:32:11 +08:00
pKFi->mpImuPreintegrated->SetNewBias(pKFi->mPrevKF->GetImuBias());
2022-07-21 22:27:32 +08:00
// 3.2 提取节点
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VP1 = optimizer.vertex(pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VV1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VG1;
g2o::HyperGraph::Vertex *VA1;
g2o::HyperGraph::Vertex *VG2;
g2o::HyperGraph::Vertex *VA2;
2022-07-21 22:27:32 +08:00
// 根据不同输入配置相应的偏置节点
2022-07-21 21:32:11 +08:00
if (!bInit)
{
VG1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 2);
VA1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 3);
VG2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 2);
VA2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 3);
}
else
{
VG1 = optimizer.vertex(4 * maxKFid + 2);
VA1 = optimizer.vertex(4 * maxKFid + 3);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VP2 = optimizer.vertex(pKFi->mnId);
g2o::HyperGraph::Vertex *VV2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!bInit)
{
if (!VP1 || !VV1 || !VG1 || !VA1 || !VP2 || !VV2 || !VG2 || !VA2)
{
cout << "Error" << VP1 << ", " << VV1 << ", " << VG1 << ", " << VA1 << ", " << VP2 << ", " << VV2 << ", " << VG2 << ", " << VA2 << endl;
continue;
}
}
else
{
if (!VP1 || !VV1 || !VG1 || !VA1 || !VP2 || !VV2)
{
cout << "Error" << VP1 << ", " << VV1 << ", " << VG1 << ", " << VA1 << ", " << VP2 << ", " << VV2 << endl;
continue;
}
}
2022-07-21 22:27:32 +08:00
// 3.3 设置边
2022-07-21 21:32:11 +08:00
EdgeInertial *ei = new EdgeInertial(pKFi->mpImuPreintegrated);
ei->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP1));
ei->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV1));
ei->setVertex(2, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG1));
ei->setVertex(3, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA1));
ei->setVertex(4, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP2));
ei->setVertex(5, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV2));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rki = new g2o::RobustKernelHuber;
ei->setRobustKernel(rki);
2022-07-21 22:27:32 +08:00
// 9个自由度的卡方检验0.05
2022-07-21 21:32:11 +08:00
rki->setDelta(sqrt(16.92));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(ei);
2022-07-21 22:27:32 +08:00
// 加了每一个关键帧的偏置时,还要优化两帧之间偏置的误差
2022-07-21 21:32:11 +08:00
if (!bInit)
{
EdgeGyroRW *egr = new EdgeGyroRW();
egr->setVertex(0, VG1);
egr->setVertex(1, VG2);
Eigen::Matrix3d InfoG = pKFi->mpImuPreintegrated->C.block<3, 3>(9, 9).cast<double>().inverse();
egr->setInformation(InfoG);
egr->computeError();
optimizer.addEdge(egr);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeAccRW *ear = new EdgeAccRW();
ear->setVertex(0, VA1);
ear->setVertex(1, VA2);
Eigen::Matrix3d InfoA = pKFi->mpImuPreintegrated->C.block<3, 3>(12, 12).cast<double>().inverse();
ear->setInformation(InfoA);
ear->computeError();
optimizer.addEdge(ear);
}
}
else
cout << pKFi->mnId << " or " << pKFi->mPrevKF->mnId << " no imu" << endl;
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 只加入pIncKF帧的偏置优化偏置到0
2022-07-21 21:32:11 +08:00
if (bInit)
{
g2o::HyperGraph::Vertex *VG = optimizer.vertex(4 * maxKFid + 2);
g2o::HyperGraph::Vertex *VA = optimizer.vertex(4 * maxKFid + 3);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Add prior to comon biases
Eigen::Vector3f bprior;
bprior.setZero();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgePriorAcc *epa = new EdgePriorAcc(bprior);
epa->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA));
double infoPriorA = priorA; //
epa->setInformation(infoPriorA * Eigen::Matrix3d::Identity());
optimizer.addEdge(epa);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgePriorGyro *epg = new EdgePriorGyro(bprior);
epg->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG));
double infoPriorG = priorG; //
epg->setInformation(infoPriorG * Eigen::Matrix3d::Identity());
optimizer.addEdge(epg);
}
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
const float thHuberMono = sqrt(5.991);
const float thHuberStereo = sqrt(7.815);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const unsigned long iniMPid = maxKFid * 5;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<bool> vbNotIncludedMP(vpMPs.size(), false);
2022-07-21 22:27:32 +08:00
// 5. 添加关于mp的节点与边这段比较好理解很传统的视觉上的重投影误差
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpMPs.size(); i++)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = vpMPs[i];
g2o::VertexSBAPointXYZ *vPoint = new g2o::VertexSBAPointXYZ();
2022-03-28 21:20:28 +08:00
vPoint->setEstimate(pMP->GetWorldPos().cast<double>());
2022-07-21 21:32:11 +08:00
unsigned long id = pMP->mnId + iniMPid + 1;
2022-03-28 21:20:28 +08:00
vPoint->setId(id);
vPoint->setMarginalized(true);
optimizer.addVertex(vPoint);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const map<KeyFrame *, tuple<int, int>> observations = pMP->GetObservations();
bool bAllFixed = true;
// Set edges
2022-07-21 22:27:32 +08:00
// 遍历所有能观测到这个点的关键帧
2022-07-21 21:32:11 +08:00
for (map<KeyFrame *, tuple<int, int>>::const_iterator mit = observations.begin(), mend = observations.end(); mit != mend; mit++)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = mit->first;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mnId > maxKFid)
2022-03-28 21:20:28 +08:00
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pKFi->isBad())
2022-03-28 21:20:28 +08:00
{
const int leftIndex = get<0>(mit->second);
cv::KeyPoint kpUn;
2022-07-21 22:27:32 +08:00
// 添加边
2022-07-21 21:32:11 +08:00
if (leftIndex != -1 && pKFi->mvuRight[get<0>(mit->second)] < 0) // Monocular observation
2022-03-28 21:20:28 +08:00
{
kpUn = pKFi->mvKeysUn[leftIndex];
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
2022-03-28 21:20:28 +08:00
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeMono *e = new EdgeMono(0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizableGraph::Vertex *VP = dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId));
if (bAllFixed)
if (!VP->fixed())
bAllFixed = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, VP);
e->setMeasurement(obs);
const float invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2022-03-28 21:20:28 +08:00
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
optimizer.addEdge(e);
}
2022-07-21 21:32:11 +08:00
else if (leftIndex != -1 && pKFi->mvuRight[leftIndex] >= 0) // stereo observation
2022-03-28 21:20:28 +08:00
{
kpUn = pKFi->mvKeysUn[leftIndex];
const float kp_ur = pKFi->mvuRight[leftIndex];
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 3, 1> obs;
2022-03-28 21:20:28 +08:00
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeStereo *e = new EdgeStereo(0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizableGraph::Vertex *VP = dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId));
if (bAllFixed)
if (!VP->fixed())
bAllFixed = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, VP);
e->setMeasurement(obs);
const float invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setInformation(Eigen::Matrix3d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2022-03-28 21:20:28 +08:00
e->setRobustKernel(rk);
rk->setDelta(thHuberStereo);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
optimizer.addEdge(e);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mpCamera2)
{ // Monocular right observation
2022-03-28 21:20:28 +08:00
int rightIndex = get<1>(mit->second);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (rightIndex != -1 && rightIndex < pKFi->mvKeysRight.size())
{
2022-03-28 21:20:28 +08:00
rightIndex -= pKFi->NLeft;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
kpUn = pKFi->mvKeysRight[rightIndex];
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeMono *e = new EdgeMono(1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizableGraph::Vertex *VP = dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId));
if (bAllFixed)
if (!VP->fixed())
bAllFixed = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, VP);
e->setMeasurement(obs);
const float invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave];
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2022-03-28 21:20:28 +08:00
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
optimizer.addEdge(e);
}
2021-12-08 22:09:39 +08:00
}
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// false
2022-07-21 21:32:11 +08:00
if (bAllFixed)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
optimizer.removeVertex(vPoint);
vbNotIncludedMP[i] = true;
2020-12-01 11:58:17 +08:00
}
2021-12-08 22:09:39 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
if (*pbStopFlag)
return;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization();
optimizer.optimize(its);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 5. 取出优化结果,对应的值赋值
2022-07-21 21:32:11 +08:00
// Recover optimized data
// Keyframes
for (size_t i = 0; i < vpKFs.size(); i++)
{
KeyFrame *pKFi = vpKFs[i];
if (pKFi->mnId > maxKFid)
2021-12-08 22:09:39 +08:00
continue;
2022-07-21 21:32:11 +08:00
VertexPose *VP = static_cast<VertexPose *>(optimizer.vertex(pKFi->mnId));
if (nLoopId == 0)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
Sophus::SE3f Tcw(VP->estimate().Rcw[0].cast<float>(), VP->estimate().tcw[0].cast<float>());
pKFi->SetPose(Tcw);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
else
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
pKFi->mTcwGBA = Sophus::SE3f(VP->estimate().Rcw[0].cast<float>(), VP->estimate().tcw[0].cast<float>());
pKFi->mnBAGlobalForKF = nLoopId;
2022-03-28 21:20:28 +08:00
}
2022-07-21 21:32:11 +08:00
if (pKFi->bImu)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = static_cast<VertexVelocity *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 1));
if (nLoopId == 0)
{
pKFi->SetVelocity(VV->estimate().cast<float>());
}
else
{
pKFi->mVwbGBA = VV->estimate().cast<float>();
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG;
VertexAccBias *VA;
if (!bInit)
{
VG = static_cast<VertexGyroBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 2));
VA = static_cast<VertexAccBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 3));
}
else
{
VG = static_cast<VertexGyroBias *>(optimizer.vertex(4 * maxKFid + 2));
VA = static_cast<VertexAccBias *>(optimizer.vertex(4 * maxKFid + 3));
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Vector6d vb;
vb << VG->estimate(), VA->estimate();
IMU::Bias b(vb[3], vb[4], vb[5], vb[0], vb[1], vb[2]);
if (nLoopId == 0)
{
pKFi->SetNewBias(b);
}
else
{
pKFi->mBiasGBA = b;
}
}
2021-12-08 22:09:39 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Points
for (size_t i = 0; i < vpMPs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (vbNotIncludedMP[i])
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
MapPoint *pMP = vpMPs[i];
g2o::VertexSBAPointXYZ *vPoint = static_cast<g2o::VertexSBAPointXYZ *>(optimizer.vertex(pMP->mnId + iniMPid + 1));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (nLoopId == 0)
{
pMP->SetWorldPos(vPoint->estimate().cast<float>());
pMP->UpdateNormalAndDepth();
}
else
{
pMP->mPosGBA = vPoint->estimate().cast<float>();
pMP->mnBAGlobalForKF = nLoopId;
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
pMap->IncreaseChangeIndex();
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
/**************************************以下为尺度与重力优化**************************************************************/
2022-07-21 22:27:32 +08:00
/**
* @brief imuLocalMapping::InitializeIMU使kf姿
*
* @param pMap
* @param Rwg
* @param scale cout
* @param bg cout
* @param ba cout
* @param bMono
* @param covInertial (9*90)
* @param bFixedVel false
* @param bGauss false
* @param priorG
* @param priorA
*/
2022-07-21 21:32:11 +08:00
void Optimizer::InertialOptimization(
Map *pMap, Eigen::Matrix3d &Rwg, double &scale, Eigen::Vector3d &bg, Eigen::Vector3d &ba, bool bMono,
Eigen::MatrixXd &covInertial, bool bFixedVel, bool bGauss, float priorG, float priorA)
2020-12-01 11:58:17 +08:00
{
2022-03-28 21:20:28 +08:00
Verbose::PrintMess("inertial optimization", Verbose::VERBOSITY_NORMAL);
2021-08-09 19:34:51 +08:00
int its = 200;
2022-03-28 21:20:28 +08:00
long unsigned int maxKFid = pMap->GetMaxKFid();
2022-07-21 22:27:32 +08:00
const vector<KeyFrame *> vpKFs = pMap->GetAllKeyFrames(); // 获取所有关键帧
2020-12-01 11:58:17 +08:00
// Setup optimizer
2022-07-21 22:27:32 +08:00
// 1. 构建优化器
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolverX::PoseMatrixType>();
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (priorG != 0.f)
2022-03-28 21:20:28 +08:00
solver->setUserLambdaInit(1e3);
2020-12-01 11:58:17 +08:00
optimizer.setAlgorithm(solver);
// Set KeyFrame vertices (fixed poses and optimizable velocities)
2022-07-21 22:27:32 +08:00
// 2. 确定关键帧节点(锁住的位姿及可优化的速度)
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
2022-07-21 22:27:32 +08:00
// 跳过id大于当前地图最大id的关键帧
2022-07-21 21:32:11 +08:00
if (pKFi->mnId > maxKFid)
2022-03-28 21:20:28 +08:00
continue;
2022-07-21 22:27:32 +08:00
VertexPose *VP = new VertexPose(pKFi); // 继承于public g2o::BaseVertex<6, ImuCamPose>
2020-12-01 11:58:17 +08:00
VP->setId(pKFi->mnId);
VP->setFixed(true);
optimizer.addVertex(VP);
2022-07-21 22:27:32 +08:00
VertexVelocity *VV = new VertexVelocity(pKFi); // 继承于public g2o::BaseVertex<3, Eigen::Vector3d>
2022-07-21 21:32:11 +08:00
VV->setId(maxKFid + (pKFi->mnId) + 1);
2022-03-28 21:20:28 +08:00
if (bFixedVel)
VV->setFixed(true);
else
2021-12-08 22:09:39 +08:00
VV->setFixed(false);
2020-12-01 11:58:17 +08:00
optimizer.addVertex(VV);
}
// Biases
2022-07-21 22:27:32 +08:00
// 3. 确定偏置节点,陀螺仪与加速度计
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG = new VertexGyroBias(vpKFs.front());
VG->setId(maxKFid * 2 + 2);
2022-03-28 21:20:28 +08:00
if (bFixedVel)
VG->setFixed(true);
else
VG->setFixed(false);
2020-12-01 11:58:17 +08:00
optimizer.addVertex(VG);
2022-07-21 21:32:11 +08:00
VertexAccBias *VA = new VertexAccBias(vpKFs.front());
VA->setId(maxKFid * 2 + 3);
2022-03-28 21:20:28 +08:00
if (bFixedVel)
VA->setFixed(true);
else
VA->setFixed(false);
2020-12-01 11:58:17 +08:00
optimizer.addVertex(VA);
2022-07-21 22:27:32 +08:00
2020-12-01 11:58:17 +08:00
// prior acc bias
2022-03-28 21:20:28 +08:00
Eigen::Vector3f bprior;
bprior.setZero();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 4. 添加关于加速度计与陀螺仪偏置的边这两个边加入是保证第一帧的偏置为0
2022-07-21 21:32:11 +08:00
EdgePriorAcc *epa = new EdgePriorAcc(bprior);
epa->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA));
2020-12-01 11:58:17 +08:00
double infoPriorA = priorA;
2022-07-21 21:32:11 +08:00
epa->setInformation(infoPriorA * Eigen::Matrix3d::Identity());
2020-12-01 11:58:17 +08:00
optimizer.addEdge(epa);
2022-07-21 21:32:11 +08:00
EdgePriorGyro *epg = new EdgePriorGyro(bprior);
epg->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG));
2020-12-01 11:58:17 +08:00
double infoPriorG = priorG;
2022-07-21 21:32:11 +08:00
epg->setInformation(infoPriorG * Eigen::Matrix3d::Identity());
2020-12-01 11:58:17 +08:00
optimizer.addEdge(epg);
// Gravity and scale
2022-07-21 22:27:32 +08:00
// 5. 添加关于重力方向与尺度的节点
2022-07-21 21:32:11 +08:00
VertexGDir *VGDir = new VertexGDir(Rwg);
VGDir->setId(maxKFid * 2 + 4);
2022-03-28 21:20:28 +08:00
VGDir->setFixed(false);
2020-12-01 11:58:17 +08:00
optimizer.addVertex(VGDir);
2022-07-21 21:32:11 +08:00
VertexScale *VS = new VertexScale(scale);
VS->setId(maxKFid * 2 + 5);
2022-03-28 21:20:28 +08:00
VS->setFixed(!bMono); // Fixed for stereo case
2020-12-01 11:58:17 +08:00
optimizer.addVertex(VS);
// Graph edges
// IMU links with gravity and scale
2022-07-21 22:27:32 +08:00
// 6. imu信息链接重力方向与尺度信息
vector<EdgeInertialGS *> vpei; // 后面虽然加入了边,但是没有用到,应该调试用的
2020-12-01 11:58:17 +08:00
vpei.reserve(vpKFs.size());
2022-07-21 21:32:11 +08:00
vector<pair<KeyFrame *, KeyFrame *>> vppUsedKF;
2022-07-21 22:27:32 +08:00
vppUsedKF.reserve(vpKFs.size()); // 后面虽然加入了关键帧,但是没有用到,应该调试用的
2022-07-21 21:32:11 +08:00
// std::cout << "build optimization graph" << std::endl;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mPrevKF && pKFi->mnId <= maxKFid)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pKFi->isBad() || pKFi->mPrevKF->mnId > maxKFid)
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
if (!pKFi->mpImuPreintegrated)
2022-03-28 21:20:28 +08:00
std::cout << "Not preintegrated measurement" << std::endl;
2022-07-21 22:27:32 +08:00
// 到这里的条件是pKFi是好的并且它有上一个关键帧且他们的id要小于最大id
// 6.1 检查节点指针是否为空
// 将pKFi偏置设定为上一关键帧的偏置
2020-12-01 11:58:17 +08:00
pKFi->mpImuPreintegrated->SetNewBias(pKFi->mPrevKF->GetImuBias());
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VP1 = optimizer.vertex(pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VV1 = optimizer.vertex(maxKFid + (pKFi->mPrevKF->mnId) + 1);
g2o::HyperGraph::Vertex *VP2 = optimizer.vertex(pKFi->mnId);
g2o::HyperGraph::Vertex *VV2 = optimizer.vertex(maxKFid + (pKFi->mnId) + 1);
g2o::HyperGraph::Vertex *VG = optimizer.vertex(maxKFid * 2 + 2);
g2o::HyperGraph::Vertex *VA = optimizer.vertex(maxKFid * 2 + 3);
g2o::HyperGraph::Vertex *VGDir = optimizer.vertex(maxKFid * 2 + 4);
g2o::HyperGraph::Vertex *VS = optimizer.vertex(maxKFid * 2 + 5);
if (!VP1 || !VV1 || !VG || !VA || !VP2 || !VV2 || !VGDir || !VS)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
cout << "Error" << VP1 << ", " << VV1 << ", " << VG << ", " << VA << ", " << VP2 << ", " << VV2 << ", " << VGDir << ", " << VS << endl;
2020-12-01 11:58:17 +08:00
continue;
}
2022-07-21 22:27:32 +08:00
// 6.2 这是一个大边。。。。包含了上面所有信息,注意到前面的两个偏置也做了两个一元边加入
2022-07-21 21:32:11 +08:00
EdgeInertialGS *ei = new EdgeInertialGS(pKFi->mpImuPreintegrated);
ei->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP1));
ei->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV1));
ei->setVertex(2, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG));
ei->setVertex(3, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA));
ei->setVertex(4, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP2));
ei->setVertex(5, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV2));
ei->setVertex(6, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VGDir));
ei->setVertex(7, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VS));
2020-12-01 11:58:17 +08:00
vpei.push_back(ei);
2022-07-21 21:32:11 +08:00
vppUsedKF.push_back(make_pair(pKFi->mPrevKF, pKFi));
2020-12-01 11:58:17 +08:00
optimizer.addEdge(ei);
}
}
// Compute error for different scales
2022-07-21 21:32:11 +08:00
std::set<g2o::HyperGraph::Edge *> setEdges = optimizer.edges();
2020-12-01 11:58:17 +08:00
optimizer.setVerbose(false);
optimizer.initializeOptimization();
optimizer.optimize(its);
2022-07-21 22:27:32 +08:00
// 7. 取数
2022-03-28 21:20:28 +08:00
scale = VS->estimate();
2020-12-01 11:58:17 +08:00
// Recover optimized data
// Biases
2022-07-21 21:32:11 +08:00
VG = static_cast<VertexGyroBias *>(optimizer.vertex(maxKFid * 2 + 2));
VA = static_cast<VertexAccBias *>(optimizer.vertex(maxKFid * 2 + 3));
2020-12-01 11:58:17 +08:00
Vector6d vb;
vb << VG->estimate(), VA->estimate();
bg << VG->estimate();
ba << VA->estimate();
scale = VS->estimate();
2022-07-21 21:32:11 +08:00
IMU::Bias b(vb[3], vb[4], vb[5], vb[0], vb[1], vb[2]);
2022-03-28 21:20:28 +08:00
Rwg = VGDir->estimate().Rwg;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Keyframes velocities and biases
2022-03-28 21:20:28 +08:00
const int N = vpKFs.size();
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
if (pKFi->mnId > maxKFid)
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = static_cast<VertexVelocity *>(optimizer.vertex(maxKFid + (pKFi->mnId) + 1));
2022-03-28 21:20:28 +08:00
Eigen::Vector3d Vw = VV->estimate(); // Velocity is scaled after
pKFi->SetVelocity(Vw.cast<float>());
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
if ((pKFi->GetGyroBias() - bg.cast<float>()).norm() > 0.01)
2020-12-01 11:58:17 +08:00
{
2022-03-28 21:20:28 +08:00
pKFi->SetNewBias(b);
if (pKFi->mpImuPreintegrated)
pKFi->mpImuPreintegrated->Reintegrate();
}
else
pKFi->SetNewBias(b);
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief LoopClosing::MergeLocal2 使
*
*
* @param pMap
* @param bg
* @param ba
* @param priorG
* @param priorA
*/
2022-03-28 21:20:28 +08:00
void Optimizer::InertialOptimization(Map *pMap, Eigen::Vector3d &bg, Eigen::Vector3d &ba, float priorG, float priorA)
{
int its = 200; // Check number of iterations
long unsigned int maxKFid = pMap->GetMaxKFid();
2022-07-21 21:32:11 +08:00
const vector<KeyFrame *> vpKFs = pMap->GetAllKeyFrames();
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Setup optimizer
2022-07-21 22:27:32 +08:00
// 1. 构建优化器
2022-03-28 21:20:28 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolverX::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2022-03-28 21:20:28 +08:00
solver->setUserLambdaInit(1e3);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
optimizer.setAlgorithm(solver);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Set KeyFrame vertices (fixed poses and optimizable velocities)
2022-07-21 22:27:32 +08:00
// 2. 构建节点固定rt
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
if (pKFi->mnId > maxKFid)
2022-03-28 21:20:28 +08:00
continue;
2022-07-21 21:32:11 +08:00
VertexPose *VP = new VertexPose(pKFi);
2022-03-28 21:20:28 +08:00
VP->setId(pKFi->mnId);
VP->setFixed(true);
optimizer.addVertex(VP);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + (pKFi->mnId) + 1);
2022-03-28 21:20:28 +08:00
VV->setFixed(false);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
optimizer.addVertex(VV);
2020-12-01 11:58:17 +08:00
}
2022-03-28 21:20:28 +08:00
// Biases
2022-07-21 22:27:32 +08:00
// 3. 第一个关键帧的偏置
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG = new VertexGyroBias(vpKFs.front());
VG->setId(maxKFid * 2 + 2);
2022-03-28 21:20:28 +08:00
VG->setFixed(false);
optimizer.addVertex(VG);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexAccBias *VA = new VertexAccBias(vpKFs.front());
VA->setId(maxKFid * 2 + 3);
2022-03-28 21:20:28 +08:00
VA->setFixed(false);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
optimizer.addVertex(VA);
// prior acc bias
Eigen::Vector3f bprior;
bprior.setZero();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 4. 先验边让偏置趋向于0
2022-07-21 21:32:11 +08:00
EdgePriorAcc *epa = new EdgePriorAcc(bprior);
epa->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA));
2022-03-28 21:20:28 +08:00
double infoPriorA = priorA;
2022-07-21 21:32:11 +08:00
epa->setInformation(infoPriorA * Eigen::Matrix3d::Identity());
2022-03-28 21:20:28 +08:00
optimizer.addEdge(epa);
2022-07-21 21:32:11 +08:00
EdgePriorGyro *epg = new EdgePriorGyro(bprior);
epg->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG));
2022-03-28 21:20:28 +08:00
double infoPriorG = priorG;
2022-07-21 21:32:11 +08:00
epg->setInformation(infoPriorG * Eigen::Matrix3d::Identity());
2022-03-28 21:20:28 +08:00
optimizer.addEdge(epg);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Gravity and scale
2022-07-21 22:27:32 +08:00
// 5. 注意这里固定了尺度与重力方向,所以只优化了偏置与速度
2022-07-21 21:32:11 +08:00
VertexGDir *VGDir = new VertexGDir(Eigen::Matrix3d::Identity());
VGDir->setId(maxKFid * 2 + 4);
2022-03-28 21:20:28 +08:00
VGDir->setFixed(true);
optimizer.addVertex(VGDir);
2022-07-21 21:32:11 +08:00
VertexScale *VS = new VertexScale(1.0);
VS->setId(maxKFid * 2 + 5);
2022-03-28 21:20:28 +08:00
VS->setFixed(true); // Fixed since scale is obtained from already well initialized map
optimizer.addVertex(VS);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Graph edges
// IMU links with gravity and scale
2022-07-21 21:32:11 +08:00
vector<EdgeInertialGS *> vpei;
2022-03-28 21:20:28 +08:00
vpei.reserve(vpKFs.size());
2022-07-21 21:32:11 +08:00
vector<pair<KeyFrame *, KeyFrame *>> vppUsedKF;
2022-03-28 21:20:28 +08:00
vppUsedKF.reserve(vpKFs.size());
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 6. 设置残差边
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mPrevKF && pKFi->mnId <= maxKFid)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pKFi->isBad() || pKFi->mPrevKF->mnId > maxKFid)
2020-12-01 11:58:17 +08:00
continue;
2022-03-28 21:20:28 +08:00
pKFi->mpImuPreintegrated->SetNewBias(pKFi->mPrevKF->GetImuBias());
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VP1 = optimizer.vertex(pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VV1 = optimizer.vertex(maxKFid + (pKFi->mPrevKF->mnId) + 1);
g2o::HyperGraph::Vertex *VP2 = optimizer.vertex(pKFi->mnId);
g2o::HyperGraph::Vertex *VV2 = optimizer.vertex(maxKFid + (pKFi->mnId) + 1);
g2o::HyperGraph::Vertex *VG = optimizer.vertex(maxKFid * 2 + 2);
g2o::HyperGraph::Vertex *VA = optimizer.vertex(maxKFid * 2 + 3);
g2o::HyperGraph::Vertex *VGDir = optimizer.vertex(maxKFid * 2 + 4);
g2o::HyperGraph::Vertex *VS = optimizer.vertex(maxKFid * 2 + 5);
if (!VP1 || !VV1 || !VG || !VA || !VP2 || !VV2 || !VGDir || !VS)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
cout << "Error" << VP1 << ", " << VV1 << ", " << VG << ", " << VA << ", " << VP2 << ", " << VV2 << ", " << VGDir << ", " << VS << endl;
2020-12-01 11:58:17 +08:00
continue;
}
2022-07-21 21:32:11 +08:00
EdgeInertialGS *ei = new EdgeInertialGS(pKFi->mpImuPreintegrated);
ei->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP1));
ei->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV1));
ei->setVertex(2, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG));
ei->setVertex(3, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA));
ei->setVertex(4, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP2));
ei->setVertex(5, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV2));
ei->setVertex(6, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VGDir));
ei->setVertex(7, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VS));
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
vpei.push_back(ei);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vppUsedKF.push_back(make_pair(pKFi->mPrevKF, pKFi));
2022-03-28 21:20:28 +08:00
optimizer.addEdge(ei);
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 22:27:32 +08:00
// 7. 优化
2022-03-28 21:20:28 +08:00
// Compute error for different scales
optimizer.setVerbose(false);
optimizer.initializeOptimization();
optimizer.optimize(its);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 8. 取数
2020-12-01 11:58:17 +08:00
// Recover optimized data
2022-03-28 21:20:28 +08:00
// Biases
2022-07-21 21:32:11 +08:00
VG = static_cast<VertexGyroBias *>(optimizer.vertex(maxKFid * 2 + 2));
VA = static_cast<VertexAccBias *>(optimizer.vertex(maxKFid * 2 + 3));
2022-03-28 21:20:28 +08:00
Vector6d vb;
vb << VG->estimate(), VA->estimate();
bg << VG->estimate();
ba << VA->estimate();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
IMU::Bias b(vb[3], vb[4], vb[5], vb[0], vb[1], vb[2]);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Keyframes velocities and biases
2022-03-28 21:20:28 +08:00
const int N = vpKFs.size();
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
if (pKFi->mnId > maxKFid)
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = static_cast<VertexVelocity *>(optimizer.vertex(maxKFid + (pKFi->mnId) + 1));
2022-03-28 21:20:28 +08:00
Eigen::Vector3d Vw = VV->estimate();
pKFi->SetVelocity(Vw.cast<float>());
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
if ((pKFi->GetGyroBias() - bg.cast<float>()).norm() > 0.01)
2020-12-01 11:58:17 +08:00
{
2022-03-28 21:20:28 +08:00
pKFi->SetNewBias(b);
if (pKFi->mpImuPreintegrated)
pKFi->mpImuPreintegrated->Reintegrate();
2020-12-01 11:58:17 +08:00
}
2022-03-28 21:20:28 +08:00
else
pKFi->SetNewBias(b);
2020-12-01 11:58:17 +08:00
}
2022-03-28 21:20:28 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief LocalMapping::ScaleRefinement()使
*
* @param pMap
* @param Rwg
* @param scale
*/
2022-03-28 21:20:28 +08:00
void Optimizer::InertialOptimization(Map *pMap, Eigen::Matrix3d &Rwg, double &scale)
{
int its = 10;
long unsigned int maxKFid = pMap->GetMaxKFid();
2022-07-21 21:32:11 +08:00
const vector<KeyFrame *> vpKFs = pMap->GetAllKeyFrames();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 1. 构建优化器
2022-03-28 21:20:28 +08:00
// Setup optimizer
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX::LinearSolverType *linearSolver;
2022-03-28 21:20:28 +08:00
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolverX::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmGaussNewton *solver = new g2o::OptimizationAlgorithmGaussNewton(solver_ptr);
2022-03-28 21:20:28 +08:00
optimizer.setAlgorithm(solver);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Set KeyFrame vertices (all variables are fixed)
2022-07-21 22:27:32 +08:00
// 2. 添加帧节点,其中包括位姿,速度,两个偏置
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
if (pKFi->mnId > maxKFid)
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
VertexPose *VP = new VertexPose(pKFi);
2022-03-28 21:20:28 +08:00
VP->setId(pKFi->mnId);
VP->setFixed(true);
optimizer.addVertex(VP);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + 1 + (pKFi->mnId));
2022-03-28 21:20:28 +08:00
VV->setFixed(true);
optimizer.addVertex(VV);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
// Vertex of fixed biases
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG = new VertexGyroBias(vpKFs.front());
VG->setId(2 * (maxKFid + 1) + (pKFi->mnId));
2022-03-28 21:20:28 +08:00
VG->setFixed(true);
optimizer.addVertex(VG);
2022-07-21 21:32:11 +08:00
VertexAccBias *VA = new VertexAccBias(vpKFs.front());
VA->setId(3 * (maxKFid + 1) + (pKFi->mnId));
2022-03-28 21:20:28 +08:00
VA->setFixed(true);
optimizer.addVertex(VA);
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 3. 添加重力方向与尺度的节点,为优化对象
2022-03-28 21:20:28 +08:00
// Gravity and scale
2022-07-21 21:32:11 +08:00
VertexGDir *VGDir = new VertexGDir(Rwg);
VGDir->setId(4 * (maxKFid + 1));
2022-03-28 21:20:28 +08:00
VGDir->setFixed(false);
optimizer.addVertex(VGDir);
2022-07-21 21:32:11 +08:00
VertexScale *VS = new VertexScale(scale);
VS->setId(4 * (maxKFid + 1) + 1);
2022-03-28 21:20:28 +08:00
VS->setFixed(false);
optimizer.addVertex(VS);
2021-12-08 22:09:39 +08:00
2022-03-28 21:20:28 +08:00
// Graph edges
2022-07-21 22:27:32 +08:00
// 4. 添加边
2022-03-28 21:20:28 +08:00
int count_edges = 0;
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mPrevKF && pKFi->mnId <= maxKFid)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
if (pKFi->isBad() || pKFi->mPrevKF->mnId > maxKFid)
2022-03-28 21:20:28 +08:00
continue;
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VP1 = optimizer.vertex(pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VV1 = optimizer.vertex((maxKFid + 1) + pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VP2 = optimizer.vertex(pKFi->mnId);
g2o::HyperGraph::Vertex *VV2 = optimizer.vertex((maxKFid + 1) + pKFi->mnId);
g2o::HyperGraph::Vertex *VG = optimizer.vertex(2 * (maxKFid + 1) + pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VA = optimizer.vertex(3 * (maxKFid + 1) + pKFi->mPrevKF->mnId);
g2o::HyperGraph::Vertex *VGDir = optimizer.vertex(4 * (maxKFid + 1));
g2o::HyperGraph::Vertex *VS = optimizer.vertex(4 * (maxKFid + 1) + 1);
if (!VP1 || !VV1 || !VG || !VA || !VP2 || !VV2 || !VGDir || !VS)
2022-03-28 21:20:28 +08:00
{
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("Error" + to_string(VP1->id()) + ", " + to_string(VV1->id()) + ", " + to_string(VG->id()) + ", " + to_string(VA->id()) + ", " + to_string(VP2->id()) + ", " + to_string(VV2->id()) + ", " + to_string(VGDir->id()) + ", " + to_string(VS->id()), Verbose::VERBOSITY_NORMAL);
2020-12-01 11:58:17 +08:00
2022-03-28 21:20:28 +08:00
continue;
}
count_edges++;
2022-07-21 21:32:11 +08:00
EdgeInertialGS *ei = new EdgeInertialGS(pKFi->mpImuPreintegrated);
ei->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP1));
ei->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV1));
ei->setVertex(2, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG));
ei->setVertex(3, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA));
ei->setVertex(4, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP2));
ei->setVertex(5, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV2));
ei->setVertex(6, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VGDir));
ei->setVertex(7, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VS));
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
2022-03-28 21:20:28 +08:00
ei->setRobustKernel(rk);
rk->setDelta(1.f);
optimizer.addEdge(ei);
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 5. 优化
2022-03-28 21:20:28 +08:00
// Compute error for different scales
optimizer.setVerbose(false);
optimizer.initializeOptimization();
optimizer.computeActiveErrors();
float err = optimizer.activeRobustChi2();
optimizer.optimize(its);
optimizer.computeActiveErrors();
float err_end = optimizer.activeRobustChi2();
// Recover optimized data
2022-07-21 22:27:32 +08:00
// 6. 取数
2022-03-28 21:20:28 +08:00
scale = VS->estimate();
Rwg = VGDir->estimate().Rwg;
2020-12-01 11:58:17 +08:00
}
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
/**************************************以下为sim3优化**************************************************************/
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief LoopClosing::DetectAndReffineSim3FromLastKF使
* 12 21 g2oS12
* @param pKF1
* @param pKF2
* @param vpMatches1 MPNULL
* @param g2oS12
* @param th2
* @param bFixScale imu3false
* @param mAcumHessian
* @param bAllPoints true
*/
2022-07-21 21:32:11 +08:00
int Optimizer::OptimizeSim3(
KeyFrame *pKF1, KeyFrame *pKF2, vector<MapPoint *> &vpMatches1, g2o::Sim3 &g2oS12, const float th2,
const bool bFixScale, Eigen::Matrix<double, 7, 7> &mAcumHessian, const bool bAllPoints)
{
2022-07-21 22:27:32 +08:00
// 1. 初始化g2o优化器
// 先构造求解器
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 22:27:32 +08:00
// 构造线性方程求解器Hx = -b的求解器
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX::LinearSolverType *linearSolver;
2022-07-21 22:27:32 +08:00
// 使用dense的求解器常见非dense求解器有cholmod线性求解器和shur补线性求解器
2022-07-21 21:32:11 +08:00
linearSolver = new g2o::LinearSolverDense<g2o::BlockSolverX::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2022-07-21 22:27:32 +08:00
// 使用L-M迭代
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
optimizer.setAlgorithm(solver);
2022-07-21 21:32:11 +08:00
// Camera poses
2022-07-21 22:27:32 +08:00
// 2.1 添加Sim3顶点
2022-07-21 21:32:11 +08:00
const Eigen::Matrix3f R1w = pKF1->GetRotation();
const Eigen::Vector3f t1w = pKF1->GetTranslation();
const Eigen::Matrix3f R2w = pKF2->GetRotation();
const Eigen::Vector3f t2w = pKF2->GetTranslation();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Sim3 vertex
ORB_SLAM3::VertexSim3Expmap *vSim3 = new ORB_SLAM3::VertexSim3Expmap();
vSim3->_fix_scale = bFixScale;
vSim3->setEstimate(g2oS12);
vSim3->setId(0);
vSim3->setFixed(false);
vSim3->pCamera1 = pKF1->mpCamera;
vSim3->pCamera2 = pKF2->mpCamera;
optimizer.addVertex(vSim3);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
// 2.1 添加MP顶点
2022-07-21 21:32:11 +08:00
const int N = vpMatches1.size();
const vector<MapPoint *> vpMapPoints1 = pKF1->GetMapPointMatches();
2022-07-21 22:27:32 +08:00
vector<ORB_SLAM3::EdgeSim3ProjectXYZ *> vpEdges12; // pKF2对应的MapPoints到pKF1的投影
vector<ORB_SLAM3::EdgeInverseSim3ProjectXYZ *> vpEdges21; // pKF1对应的MapPoints到pKF2的投影
2022-07-21 21:32:11 +08:00
vector<size_t> vnIndexEdge;
vector<bool> vbIsInKF2;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vnIndexEdge.reserve(2 * N);
vpEdges12.reserve(2 * N);
vpEdges21.reserve(2 * N);
vbIsInKF2.reserve(2 * N);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float deltaHuber = sqrt(th2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
int nCorrespondences = 0;
2022-07-21 22:27:32 +08:00
int nBadMPs = 0; // 没有实际用处,没有输出信息
int nInKF2 = 0; // 输出信息用
int nOutKF2 = 0; // 输出信息用
int nMatchWithoutMP = 0; // 输出信息用
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<int> vIdsOnlyInKF2;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 2.2 遍历当前关键帧的所有MP点
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (!vpMatches1[i])
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 22:27:32 +08:00
// pMP1和pMP2是匹配的MapPointspMP1表示当前帧正常对应的mppMP2表示对应的回环的mp
2022-07-21 21:32:11 +08:00
MapPoint *pMP1 = vpMapPoints1[i];
MapPoint *pMP2 = vpMatches1[i];
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// (1, 2) (3, 4) (5, 6)
2022-07-21 21:32:11 +08:00
const int id1 = 2 * i + 1;
const int id2 = 2 * (i + 1);
2022-07-21 22:27:32 +08:00
// 返回这个点在pKF2关键帧中对应的特征点id
2022-07-21 21:32:11 +08:00
const int i2 = get<0>(pMP2->GetIndexInKeyFrame(pKF2));
2022-07-21 22:27:32 +08:00
Eigen::Vector3f P3D1c; // 点1在当前关键帧相机坐标系下的坐标
Eigen::Vector3f P3D2c; // 点2在候选关键帧相机坐标系下的坐标
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP1 && pMP2)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (!pMP1->isBad() && !pMP2->isBad())
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 2.3 添加PointXYZ顶点 且设为了固定
2022-07-21 21:32:11 +08:00
g2o::VertexSBAPointXYZ *vPoint1 = new g2o::VertexSBAPointXYZ();
Eigen::Vector3f P3D1w = pMP1->GetWorldPos();
P3D1c = R1w * P3D1w + t1w;
2022-07-21 22:27:32 +08:00
vPoint1->setEstimate(P3D1c.cast<double>()); // 点1在当前关键帧下的三维点坐标
2022-07-21 21:32:11 +08:00
vPoint1->setId(id1);
vPoint1->setFixed(true);
optimizer.addVertex(vPoint1);
g2o::VertexSBAPointXYZ *vPoint2 = new g2o::VertexSBAPointXYZ();
Eigen::Vector3f P3D2w = pMP2->GetWorldPos();
P3D2c = R2w * P3D2w + t2w;
2022-07-21 22:27:32 +08:00
vPoint2->setEstimate(P3D2c.cast<double>()); // 点2在候选关键帧下的三维点坐标
2022-07-21 21:32:11 +08:00
vPoint2->setId(id2);
vPoint2->setFixed(true);
optimizer.addVertex(vPoint2);
}
else
{
nBadMPs++;
continue;
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
else
{
nMatchWithoutMP++;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// The 3D position in KF1 doesn't exist
2022-07-21 21:32:11 +08:00
if (!pMP2->isBad())
{
2022-07-21 22:27:32 +08:00
// 执行到这里意味着特征点没有对应的原始MP却有回环MP将其投到候选帧里面
2022-07-21 21:32:11 +08:00
g2o::VertexSBAPointXYZ *vPoint2 = new g2o::VertexSBAPointXYZ();
Eigen::Vector3f P3D2w = pMP2->GetWorldPos();
P3D2c = R2w * P3D2w + t2w;
vPoint2->setEstimate(P3D2c.cast<double>());
vPoint2->setId(id2);
vPoint2->setFixed(true);
optimizer.addVertex(vPoint2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vIdsOnlyInKF2.push_back(id2);
}
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (i2 < 0 && !bAllPoints)
{
Verbose::PrintMess(" Remove point -> i2: " + to_string(i2) + "; bAllPoints: " + to_string(bAllPoints), Verbose::VERBOSITY_DEBUG);
continue;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (P3D2c(2) < 0)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("Sim3: Z coordinate is negative", Verbose::VERBOSITY_DEBUG);
continue;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
nCorrespondences++;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 2.4 添加两个顶点3D点到相机投影的边
2022-07-21 21:32:11 +08:00
// Set edge x1 = S12*X2
Eigen::Matrix<double, 2, 1> obs1;
const cv::KeyPoint &kpUn1 = pKF1->mvKeysUn[i];
obs1 << kpUn1.pt.x, kpUn1.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 这个边的误差计算方式
// 1. 将点2通过g2oS12计算到当前关键帧下
// 2. 点2在当前关键帧下投影到图像上与观测求误差
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSim3ProjectXYZ *e12 = new ORB_SLAM3::EdgeSim3ProjectXYZ();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
e12->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id2))); // 2相机坐标系下的三维点
e12->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(0))); // g2oS12
2022-07-21 21:32:11 +08:00
e12->setMeasurement(obs1);
const float &invSigmaSquare1 = pKF1->mvInvLevelSigma2[kpUn1.octave];
e12->setInformation(Eigen::Matrix2d::Identity() * invSigmaSquare1);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk1 = new g2o::RobustKernelHuber;
e12->setRobustKernel(rk1);
rk1->setDelta(deltaHuber);
optimizer.addEdge(e12);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set edge x2 = S21*X1
2022-07-21 22:27:32 +08:00
// 2.5 另一个边
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs2;
cv::KeyPoint kpUn2;
bool inKF2;
2022-07-21 22:27:32 +08:00
// 投之前要确定下这个点的像素坐标
2022-07-21 21:32:11 +08:00
if (i2 >= 0)
{
kpUn2 = pKF2->mvKeysUn[i2];
obs2 << kpUn2.pt.x, kpUn2.pt.y;
inKF2 = true;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
nInKF2++; // 输出信息表示在kf2中找到MP2的点数
2022-07-21 21:32:11 +08:00
}
2022-07-21 22:27:32 +08:00
else //!BUG 如果没找到使用三维点投影到KF2中表示并没有特征点与之对应把这个结果当做obs2是不是会带来一些误差而且还不通过内参吗重大bug
2022-07-21 21:32:11 +08:00
{
float invz = 1 / P3D2c(2);
float x = P3D2c(0) * invz;
float y = P3D2c(1) * invz;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// float u = pKF2->fx * x + pKF2->cx;
// float v = pKF2->fy * y + pKF2->cy;
// obs2 << u, v;
// kpUn2 = cv::KeyPoint(cv::Point2f(u, v), pMP2->mnTrackScaleLevel);
2022-07-21 21:32:11 +08:00
obs2 << x, y;
kpUn2 = cv::KeyPoint(cv::Point2f(x, y), pMP2->mnTrackScaleLevel);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
inKF2 = false;
nOutKF2++;
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 1相机坐标系下的三维点经过g2oS12投影到kf2下计算重投影误差
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeInverseSim3ProjectXYZ *e21 = new ORB_SLAM3::EdgeInverseSim3ProjectXYZ();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e21->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id1)));
e21->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(0)));
e21->setMeasurement(obs2);
float invSigmaSquare2 = pKF2->mvInvLevelSigma2[kpUn2.octave];
e21->setInformation(Eigen::Matrix2d::Identity() * invSigmaSquare2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk2 = new g2o::RobustKernelHuber;
e21->setRobustKernel(rk2);
rk2->setDelta(deltaHuber);
optimizer.addEdge(e21);
vpEdges12.push_back(e12);
vpEdges21.push_back(e21);
vnIndexEdge.push_back(i);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vbIsInKF2.push_back(inKF2);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Optimize!
2022-07-21 22:27:32 +08:00
// 3. 开始优化
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization();
optimizer.optimize(5);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Check inliers
2022-07-21 22:27:32 +08:00
// 4.剔除一些误差大的边因为e12与e21对应的是同一个三维点所以只要有一个误差太大就直接搞掉
// Check inliers
// 进行卡方检验,大于阈值的边剔除,同时删除鲁棒核函数
2022-07-21 21:32:11 +08:00
int nBad = 0;
int nBadOutKF2 = 0;
for (size_t i = 0; i < vpEdges12.size(); i++)
{
ORB_SLAM3::EdgeSim3ProjectXYZ *e12 = vpEdges12[i];
ORB_SLAM3::EdgeInverseSim3ProjectXYZ *e21 = vpEdges21[i];
if (!e12 || !e21)
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (e12->chi2() > th2 || e21->chi2() > th2)
{
size_t idx = vnIndexEdge[i];
vpMatches1[idx] = static_cast<MapPoint *>(NULL);
optimizer.removeEdge(e12);
optimizer.removeEdge(e21);
vpEdges12[i] = static_cast<ORB_SLAM3::EdgeSim3ProjectXYZ *>(NULL);
vpEdges21[i] = static_cast<ORB_SLAM3::EdgeInverseSim3ProjectXYZ *>(NULL);
nBad++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!vbIsInKF2[i])
{
nBadOutKF2++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
continue;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Check if remove the robust adjustment improve the result
e12->setRobustKernel(0);
e21->setRobustKernel(0);
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 如果有坏点,迭代次数更多
2022-07-21 21:32:11 +08:00
int nMoreIterations;
if (nBad > 0)
nMoreIterations = 10;
else
nMoreIterations = 5;
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
if (nCorrespondences - nBad < 10)
return 0;
// Optimize again only with inliers
2022-07-21 22:27:32 +08:00
// 5. 再一次优化
2020-12-01 11:58:17 +08:00
optimizer.initializeOptimization();
2022-07-21 21:32:11 +08:00
optimizer.optimize(nMoreIterations);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
int nIn = 0;
mAcumHessian = Eigen::MatrixXd::Zero(7, 7);
2022-07-21 22:27:32 +08:00
// 更新vpMatches1删除外点统计内点数量
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpEdges12.size(); i++)
{
ORB_SLAM3::EdgeSim3ProjectXYZ *e12 = vpEdges12[i];
ORB_SLAM3::EdgeInverseSim3ProjectXYZ *e21 = vpEdges21[i];
if (!e12 || !e21)
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e12->computeError();
e21->computeError();
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
if (e12->chi2() > th2 || e21->chi2() > th2)
{
size_t idx = vnIndexEdge[i];
vpMatches1[idx] = static_cast<MapPoint *>(NULL);
}
else
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
nIn++;
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// Recover optimized Sim3、
// 6.得到优化后的结果
2022-07-21 21:32:11 +08:00
g2o::VertexSim3Expmap *vSim3_recov = static_cast<g2o::VertexSim3Expmap *>(optimizer.vertex(0));
g2oS12 = vSim3_recov->estimate();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
return nIn;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
/**************************************以下为地图回环优化**************************************************************/
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief LoopClosing::CorrectLoop() 使
* MP
* @param pMap map
* @param pLoopKF mpLoopMatchedKF mpCurrentKF
* @param pCurKF mpCurrentKF
* @param NonCorrectedSim3 pKFi->GetPose()NonCorrectedSim3姿 mpCurrentKF
* @param CorrectedSim3 mg2oLoopScwCorrectedSim3 mpCurrentKF
* @param LoopConnections key pCurKF value
* @param bFixScale imuimufalse
*/
2022-07-21 21:32:11 +08:00
void Optimizer::OptimizeEssentialGraph(
Map *pMap, KeyFrame *pLoopKF, KeyFrame *pCurKF,
const LoopClosing::KeyFrameAndPose &NonCorrectedSim3,
const LoopClosing::KeyFrameAndPose &CorrectedSim3,
const map<KeyFrame *, set<KeyFrame *>> &LoopConnections, const bool &bFixScale)
{
// Setup optimizer
2022-07-21 22:27:32 +08:00
// Step 1构造优化器
2022-07-21 21:32:11 +08:00
g2o::SparseOptimizer optimizer;
optimizer.setVerbose(false);
2022-07-21 22:27:32 +08:00
// 指定线性方程求解器使用Eigen的块求解器
// 7表示位姿是sim3 3表示三维点坐标维度
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_7_3::LinearSolverType *linearSolver =
new g2o::LinearSolverEigen<g2o::BlockSolver_7_3::PoseMatrixType>();
2022-07-21 22:27:32 +08:00
// 构造线性求解器
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_7_3 *solver_ptr = new g2o::BlockSolver_7_3(linearSolver);
2022-07-21 22:27:32 +08:00
// 使用LM算法进行非线性迭代
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 第一次迭代的初始lambda值如未指定会自动计算一个合适的值
2022-07-21 21:32:11 +08:00
solver->setUserLambdaInit(1e-16);
optimizer.setAlgorithm(solver);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 获取当前地图中的所有关键帧 和地图点
2022-07-21 21:32:11 +08:00
const vector<KeyFrame *> vpKFs = pMap->GetAllKeyFrames();
const vector<MapPoint *> vpMPs = pMap->GetAllMapPoints();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 最大关键帧id用于添加顶点时使用
2022-07-21 21:32:11 +08:00
const unsigned int nMaxKFid = pMap->GetMaxKFid();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 记录所有优化前关键帧的位姿优先使用在闭环时通过Sim3传播调整过的Sim3位姿
vector<g2o::Sim3, Eigen::aligned_allocator<g2o::Sim3>> vScw(nMaxKFid + 1); // 存放每一帧优化前的sim3
// 记录所有关键帧经过本次本质图优化过的位姿
vector<g2o::Sim3, Eigen::aligned_allocator<g2o::Sim3>> vCorrectedSwc(nMaxKFid + 1); // 存放每一帧优化后的sim3修正mp位姿用
// 这个变量没有用
vector<g2o::VertexSim3Expmap *> vpVertices(nMaxKFid + 1); // 存放节点,没用,还占地方
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 调试用,暂时不去管
2022-07-21 21:32:11 +08:00
vector<Eigen::Vector3d> vZvectors(nMaxKFid + 1); // For debugging
Eigen::Vector3d z_vec;
z_vec << 0.0, 0.0, 1.0;
2022-07-21 22:27:32 +08:00
// 两个关键帧之间共视关系的权重也就是共视点的数目单目x1双目/rgbd x2的最小值
const int minFeat = 100; // MODIFICATION originally was set to 100
2022-07-21 21:32:11 +08:00
// Set KeyFrame vertices
2022-07-21 22:27:32 +08:00
// Step 2将地图中所有关键帧的pose作为顶点添加到优化器
// 尽可能使用经过Sim3调整的位姿
// 遍历全局地图中的所有的关键帧
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpKFs.size(); i < iend; i++)
{
KeyFrame *pKF = vpKFs[i];
if (pKF->isBad())
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
g2o::VertexSim3Expmap *VSim3 = new g2o::VertexSim3Expmap();
2022-07-21 22:27:32 +08:00
// 关键帧在所有关键帧中的id用来设置为顶点的id
2022-07-21 21:32:11 +08:00
const int nIDi = pKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator it = CorrectedSim3.find(pKF);
if (it != CorrectedSim3.end())
{
2022-07-21 22:27:32 +08:00
// 如果该关键帧在闭环时通过Sim3传播调整过优先用调整后的Sim3位姿
2022-07-21 21:32:11 +08:00
vScw[nIDi] = it->second;
VSim3->setEstimate(it->second);
}
else
{
2022-07-21 22:27:32 +08:00
// 如果该关键帧在闭环时没有通过Sim3传播调整过用跟踪时的位姿
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tcw = pKF->GetPose().cast<double>();
g2o::Sim3 Siw(Tcw.unit_quaternion(), Tcw.translation(), 1.0);
vScw[nIDi] = Siw;
VSim3->setEstimate(Siw);
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 固定第一帧
2022-07-21 21:32:11 +08:00
if (pKF->mnId == pMap->GetInitKFid())
VSim3->setFixed(true);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VSim3->setId(nIDi);
VSim3->setMarginalized(false);
2022-07-21 22:27:32 +08:00
// 和当前系统的传感器有关如果是RGBD或者是双目那么就不需要优化sim3的缩放系数保持为1即可
2022-07-21 21:32:11 +08:00
VSim3->_fix_scale = bFixScale;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addVertex(VSim3);
vZvectors[nIDi] = vScw[nIDi].rotation() * z_vec; // For debugging
2022-07-21 22:27:32 +08:00
// 优化前的pose顶点后面代码中没有使用
2022-07-21 21:32:11 +08:00
vpVertices[nIDi] = VSim3;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 保存由于闭环后优化sim3而出现的新的关键帧和关键帧之间的连接关系,因为回环而新建立的连接关系其中id比较小的关键帧在前,id比较大的关键帧在后
2022-07-21 21:32:11 +08:00
set<pair<long unsigned int, long unsigned int>> sInsertedEdges;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const Eigen::Matrix<double, 7, 7> matLambda = Eigen::Matrix<double, 7, 7>::Identity();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Loop edges
2022-07-21 22:27:32 +08:00
// Step 3添加第1种边LoopConnections是闭环时因为MapPoints调整而出现的新关键帧连接关系包括当前帧与闭环匹配帧之间的连接关系
2022-07-21 21:32:11 +08:00
int count_loop = 0;
for (map<KeyFrame *, set<KeyFrame *>>::const_iterator mit = LoopConnections.begin(), mend = LoopConnections.end(); mit != mend; mit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 3.1 取出帧与帧们
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = mit->first;
const long unsigned int nIDi = pKF->mnId;
2022-07-21 22:27:32 +08:00
// 和pKF 有连接关系的关键帧
2022-07-21 21:32:11 +08:00
const set<KeyFrame *> &spConnections = mit->second;
2022-07-21 22:27:32 +08:00
const g2o::Sim3 Siw = vScw[nIDi]; // 优化前的位姿
2022-07-21 21:32:11 +08:00
const g2o::Sim3 Swi = Siw.inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 对于当前关键帧nIDi而言遍历每一个新添加的关键帧nIDj链接关系
2022-07-21 21:32:11 +08:00
for (set<KeyFrame *>::const_iterator sit = spConnections.begin(), send = spConnections.end(); sit != send; sit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
const long unsigned int nIDj = (*sit)->mnId;
2022-07-21 22:27:32 +08:00
// 这里的约束有点意思对于每一个连接只要是存在pCurKF或者pLoopKF 那这个连接不管共视了多少MP都优化
// 反之没有的话共视度要大于100 构建本质图
2022-07-21 21:32:11 +08:00
if ((nIDi != pCurKF->mnId || nIDj != pLoopKF->mnId) && pKF->GetWeight(*sit) < minFeat)
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 22:27:32 +08:00
// 通过上面考验的帧有两种情况:
// 得到两个pose间的Sim3变换个人认为这里好像有些问题假设说一个当前帧的共视帧他在vScw中保存的位姿是更新后的
// 如果与之相连的关键帧没有更新,那么是不是两个相对位姿的边有问题,先留个记号,可以调试看看
2022-07-21 21:32:11 +08:00
const g2o::Sim3 Sjw = vScw[nIDj];
2022-07-21 22:27:32 +08:00
// 得到两个pose间的Sim3变换
const g2o::Sim3 Sji = Sjw * Swi; // 优化前他们的相对位姿
2022-07-21 21:32:11 +08:00
g2o::EdgeSim3 *e = new g2o::EdgeSim3();
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDj)));
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
2022-07-21 22:27:32 +08:00
// Sji内部是经过了Sim调整的观测
2022-07-21 21:32:11 +08:00
e->setMeasurement(Sji);
2022-07-21 22:27:32 +08:00
// 信息矩阵是单位阵,说明这类新增加的边对总误差的贡献也都是一样大的
2022-07-21 21:32:11 +08:00
e->information() = matLambda;
optimizer.addEdge(e);
count_loop++;
2022-07-21 22:27:32 +08:00
// 保证id小的在前,大的在后
2022-07-21 21:32:11 +08:00
sInsertedEdges.insert(make_pair(min(nIDi, nIDj), max(nIDi, nIDj)));
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
// Set normal edges
2022-07-21 22:27:32 +08:00
// 4. 添加跟踪时形成的边、闭环匹配成功形成的边
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpKFs.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = vpKFs[i];
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
g2o::Sim3 Swi; // 校正前的sim3
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator iti = NonCorrectedSim3.find(pKF);
2022-07-21 22:27:32 +08:00
// 找到的话说明是关键帧的共视帧没找到表示非共视帧非共视帧vScw[nIDi]里面装的都是矫正前的
// 所以不管怎样说 Swi都是校正前的
2022-07-21 21:32:11 +08:00
if (iti != NonCorrectedSim3.end())
Swi = (iti->second).inverse();
else
Swi = vScw[nIDi].inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
KeyFrame *pParentKF = pKF->GetParent();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Spanning tree edge
2022-07-21 22:27:32 +08:00
// 4.1 只添加扩展树的边(有父关键帧)
2022-07-21 21:32:11 +08:00
if (pParentKF)
{
int nIDj = pParentKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sjw;
LoopClosing::KeyFrameAndPose::const_iterator itj = NonCorrectedSim3.find(pParentKF);
if (itj != NonCorrectedSim3.end())
Sjw = itj->second;
2020-12-01 11:58:17 +08:00
else
2022-07-21 21:32:11 +08:00
Sjw = vScw[nIDj];
2022-07-21 22:27:32 +08:00
// 又是未校正的结果作为观测值
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sji = Sjw * Swi;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::EdgeSim3 *e = new g2o::EdgeSim3();
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDj)));
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
e->setMeasurement(Sji);
e->information() = matLambda;
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Loop edges
2022-07-21 22:27:32 +08:00
// 4.2 添加在CorrectLoop函数中AddLoopEdge函数添加的闭环连接边当前帧与闭环匹配帧之间的连接关系
// 使用经过Sim3调整前关键帧之间的相对关系作为边
2022-07-21 21:32:11 +08:00
const set<KeyFrame *> sLoopEdges = pKF->GetLoopEdges();
for (set<KeyFrame *>::const_iterator sit = sLoopEdges.begin(), send = sLoopEdges.end(); sit != send; sit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pLKF = *sit;
if (pLKF->mnId < pKF->mnId)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
g2o::Sim3 Slw;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator itl = NonCorrectedSim3.find(pLKF);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (itl != NonCorrectedSim3.end())
Slw = itl->second;
else
Slw = vScw[pLKF->mnId];
g2o::Sim3 Sli = Slw * Swi;
g2o::EdgeSim3 *el = new g2o::EdgeSim3();
el->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pLKF->mnId)));
el->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
el->setMeasurement(Sli);
el->information() = matLambda;
optimizer.addEdge(el);
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
// Covisibility graph edges
2022-07-21 22:27:32 +08:00
// 4.3 对有很好共视关系的关键帧也作为边进行优化
// 使用经过Sim3调整前关键帧之间的相对关系作为边
2022-07-21 21:32:11 +08:00
const vector<KeyFrame *> vpConnectedKFs = pKF->GetCovisiblesByWeight(minFeat);
for (vector<KeyFrame *>::const_iterator vit = vpConnectedKFs.begin(); vit != vpConnectedKFs.end(); vit++)
{
KeyFrame *pKFn = *vit;
if (pKFn && pKFn != pParentKF && !pKF->hasChild(pKFn) /*&& !sLoopEdges.count(pKFn)*/)
{
if (!pKFn->isBad() && pKFn->mnId < pKF->mnId)
{
if (sInsertedEdges.count(make_pair(min(pKF->mnId, pKFn->mnId), max(pKF->mnId, pKFn->mnId))))
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Snw;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator itn = NonCorrectedSim3.find(pKFn);
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
if (itn != NonCorrectedSim3.end())
Snw = itn->second;
else
Snw = vScw[pKFn->mnId];
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sni = Snw * Swi;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::EdgeSim3 *en = new g2o::EdgeSim3();
en->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFn->mnId)));
en->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
en->setMeasurement(Sni);
en->information() = matLambda;
optimizer.addEdge(en);
}
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Inertial edges if inertial
2022-07-21 22:27:32 +08:00
// 如果是imu的话还会找前一帧做优化
2022-07-21 21:32:11 +08:00
if (pKF->bImu && pKF->mPrevKF)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
g2o::Sim3 Spw;
LoopClosing::KeyFrameAndPose::const_iterator itp = NonCorrectedSim3.find(pKF->mPrevKF);
if (itp != NonCorrectedSim3.end())
Spw = itp->second;
else
Spw = vScw[pKF->mPrevKF->mnId];
g2o::Sim3 Spi = Spw * Swi;
g2o::EdgeSim3 *ep = new g2o::EdgeSim3();
ep->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKF->mPrevKF->mnId)));
ep->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
ep->setMeasurement(Spi);
ep->information() = matLambda;
optimizer.addEdge(ep);
2020-12-01 11:58:17 +08:00
}
}
2022-03-28 21:20:28 +08:00
2022-07-21 22:27:32 +08:00
// Optimize!
// 5. 开始g2o优化
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization();
optimizer.computeActiveErrors();
optimizer.optimize(20);
optimizer.computeActiveErrors();
unique_lock<mutex> lock(pMap->mMutexMapUpdate);
// SE3 Pose Recovering. Sim3:[sR t;0 1] -> SE3:[R t/s;0 1]
2022-07-21 22:27:32 +08:00
// 6. 设定优化后的位姿
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::VertexSim3Expmap *VSim3 = static_cast<g2o::VertexSim3Expmap *>(optimizer.vertex(nIDi));
g2o::Sim3 CorrectedSiw = VSim3->estimate();
vCorrectedSwc[nIDi] = CorrectedSiw.inverse();
double s = CorrectedSiw.scale();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Sophus::SE3f Tiw(CorrectedSiw.rotation().cast<float>(), CorrectedSiw.translation().cast<float>() / s);
pKFi->SetPose(Tiw);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Correct points. Transform to "non-optimized" reference keyframe pose and transform back with optimized pose
2022-07-21 22:27:32 +08:00
// 7. 步骤5和步骤6优化得到关键帧的位姿后MapPoints根据参考帧优化前后的相对关系调整自己的位置
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpMPs.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = vpMPs[i];
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
int nIDr;
2022-07-21 22:27:32 +08:00
// 该MapPoint经过Sim3调整过(LoopClosing.cppCorrectLoop函数步骤2.2_
2022-07-21 21:32:11 +08:00
if (pMP->mnCorrectedByKF == pCurKF->mnId)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
nIDr = pMP->mnCorrectedReference;
2020-12-01 11:58:17 +08:00
}
else
{
2022-07-21 22:27:32 +08:00
// 通过情况下MapPoint的参考关键帧就是创建该MapPoint的那个关键帧
2022-07-21 21:32:11 +08:00
KeyFrame *pRefKF = pMP->GetReferenceKeyFrame();
nIDr = pRefKF->mnId;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 得到MapPoint参考关键帧步骤5优化前的位姿
2022-07-21 21:32:11 +08:00
g2o::Sim3 Srw = vScw[nIDr];
2022-07-21 22:27:32 +08:00
// 得到MapPoint参考关键帧优化后的位姿
2022-07-21 21:32:11 +08:00
g2o::Sim3 correctedSwr = vCorrectedSwc[nIDr];
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 更新前坐标
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 3, 1> eigP3Dw = pMP->GetWorldPos().cast<double>();
2022-07-21 22:27:32 +08:00
// 更新后坐标
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 3, 1> eigCorrectedP3Dw = correctedSwr.map(Srw.map(eigP3Dw));
pMP->SetWorldPos(eigCorrectedP3Dw.cast<float>());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
pMP->UpdateNormalAndDepth();
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// TODO Check this changeindex
pMap->IncreaseChangeIndex();
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief LoopClosing::CorrectLoop() 使IMU OptimizeEssentialGraph BUG
* MP
* @param pMap map
* @param pLoopKF mpLoopMatchedKF mpCurrentKF
* @param pCurKF mpCurrentKF
* @param NonCorrectedSim3 pKFi->GetPose()NonCorrectedSim3姿 mpCurrentKF
* @param CorrectedSim3 mg2oLoopScwCorrectedSim3 mpCurrentKF
* @param LoopConnections key pCurKF
*/
2022-07-21 21:32:11 +08:00
void Optimizer::OptimizeEssentialGraph4DoF(
Map *pMap, KeyFrame *pLoopKF, KeyFrame *pCurKF,
const LoopClosing::KeyFrameAndPose &NonCorrectedSim3,
const LoopClosing::KeyFrameAndPose &CorrectedSim3,
const map<KeyFrame *, set<KeyFrame *>> &LoopConnections)
{
typedef g2o::BlockSolver<g2o::BlockSolverTraits<4, 4>> BlockSolver_4_4;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Setup optimizer
2022-07-21 22:27:32 +08:00
// 1. 构建优化器
2022-07-21 21:32:11 +08:00
g2o::SparseOptimizer optimizer;
optimizer.setVerbose(false);
g2o::BlockSolverX::LinearSolverType *linearSolver =
new g2o::LinearSolverEigen<g2o::BlockSolverX::PoseMatrixType>();
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
optimizer.setAlgorithm(solver);
2022-07-21 22:27:32 +08:00
const vector<KeyFrame *> vpKFs = pMap->GetAllKeyFrames(); // 所有关键帧
const vector<MapPoint *> vpMPs = pMap->GetAllMapPoints(); // 所有mp
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const unsigned int nMaxKFid = pMap->GetMaxKFid();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
vector<g2o::Sim3, Eigen::aligned_allocator<g2o::Sim3>> vScw(nMaxKFid + 1); // 存放每一帧优化前的sim3
vector<g2o::Sim3, Eigen::aligned_allocator<g2o::Sim3>> vCorrectedSwc(nMaxKFid + 1); // 存放每一帧优化后的sim3修正mp位姿用
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<VertexPose4DoF *> vpVertices(nMaxKFid + 1);
2022-07-21 22:27:32 +08:00
const int minFeat = 100; // 100 本质图的权重
2022-07-21 21:32:11 +08:00
// Set KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 2. 关键帧节点
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpKFs.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = vpKFs[i];
if (pKF->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 自定义的一个优化4自由度的节点
2022-07-21 21:32:11 +08:00
VertexPose4DoF *V4DoF;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator it = CorrectedSim3.find(pKF);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 找到了表示与当前关键帧共视,使用其他函数更新后的位姿
2022-07-21 21:32:11 +08:00
if (it != CorrectedSim3.end())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
vScw[nIDi] = it->second;
const g2o::Sim3 Swc = it->second.inverse();
Eigen::Matrix3d Rwc = Swc.rotation().toRotationMatrix();
Eigen::Vector3d twc = Swc.translation();
V4DoF = new VertexPose4DoF(Rwc, twc, pKF);
}
else
{
2022-07-21 22:27:32 +08:00
// 没有在CorrectedSim3里面找到表示与pCurKF并不关联也就是离得远并没有经过计算得到一个初始值这里直接使用原始的位置
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tcw = pKF->GetPose().cast<double>();
g2o::Sim3 Siw(Tcw.unit_quaternion(), Tcw.translation(), 1.0);
vScw[nIDi] = Siw;
V4DoF = new VertexPose4DoF(pKF);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
2022-07-21 22:27:32 +08:00
// 固定回环帧
2022-07-21 21:32:11 +08:00
if (pKF == pLoopKF)
V4DoF->setFixed(true);
V4DoF->setId(nIDi);
V4DoF->setMarginalized(false);
optimizer.addVertex(V4DoF);
vpVertices[nIDi] = V4DoF;
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
2022-07-21 21:32:11 +08:00
set<pair<long unsigned int, long unsigned int>> sInsertedEdges;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Edge used in posegraph has still 6Dof, even if updates of camera poses are just in 4DoF
Eigen::Matrix<double, 6, 6> matLambda = Eigen::Matrix<double, 6, 6>::Identity();
matLambda(0, 0) = 1e3;
matLambda(1, 1) = 1e3;
matLambda(0, 0) = 1e3;
// Set Loop edges
2022-07-21 22:27:32 +08:00
// 3. 添加边LoopConnections是闭环时因为MapPoints调整而出现的新关键帧连接关系包括当前帧与闭环匹配帧之间的连接关系
2022-07-21 21:32:11 +08:00
Edge4DoF *e_loop;
for (map<KeyFrame *, set<KeyFrame *>>::const_iterator mit = LoopConnections.begin(), mend = LoopConnections.end(); mit != mend; mit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 3.1 取出帧与帧们
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = mit->first;
const long unsigned int nIDi = pKF->mnId;
const set<KeyFrame *> &spConnections = mit->second;
2022-07-21 22:27:32 +08:00
const g2o::Sim3 Siw = vScw[nIDi]; // 优化前的位姿
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (set<KeyFrame *>::const_iterator sit = spConnections.begin(), send = spConnections.end(); sit != send; sit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
const long unsigned int nIDj = (*sit)->mnId;
2022-07-21 22:27:32 +08:00
// 这里的约束有点意思对于每一个连接只要是存在pCurKF或者pLoopKF 那这个连接不管共视了多少MP都优化
// 反之没有的话共视度要大于100 构建本质图
2022-07-21 21:32:11 +08:00
if ((nIDi != pCurKF->mnId || nIDj != pLoopKF->mnId) && pKF->GetWeight(*sit) < minFeat)
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
const g2o::Sim3 Sjw = vScw[nIDj];
2022-07-21 22:27:32 +08:00
// 得到两个pose间的Sim3变换个人认为这里好像有些问题假设说一个当前帧的共视帧他在vScw中保存的位姿是更新后的
// 如果与之相连的关键帧没有更新,那么是不是两个相对位姿的边有问题,先留个记号,可以调试看看
2022-07-21 21:32:11 +08:00
const g2o::Sim3 Sij = Siw * Sjw.inverse();
Eigen::Matrix4d Tij;
Tij.block<3, 3>(0, 0) = Sij.rotation().toRotationMatrix();
Tij.block<3, 1>(0, 3) = Sij.translation();
Tij(3, 3) = 1.;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 认为相对位姿会比较准,那这个当一个约束
2022-07-21 21:32:11 +08:00
Edge4DoF *e = new Edge4DoF(Tij);
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDj)));
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->information() = matLambda;
e_loop = e;
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
sInsertedEdges.insert(make_pair(min(nIDi, nIDj), max(nIDi, nIDj)));
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
// 1. Set normal edges
2022-07-21 22:27:32 +08:00
// 4. 添加跟踪时形成的边、闭环匹配成功形成的边
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpKFs.size(); i < iend; i++)
{
KeyFrame *pKF = vpKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Siw;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Use noncorrected poses for posegraph edges
LoopClosing::KeyFrameAndPose::const_iterator iti = NonCorrectedSim3.find(pKF);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 找到的话说明是关键帧的共视帧没找到表示非共视帧非共视帧vScw[nIDi]里面装的都是矫正前的
// 所以不管怎样说 Swi都是校正前的
2022-07-21 21:32:11 +08:00
if (iti != NonCorrectedSim3.end())
Siw = iti->second;
else
Siw = vScw[nIDi];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// 1.1.0 Spanning tree edge
2022-07-21 22:27:32 +08:00
// 4.1 只添加扩展树的边(有父关键帧) 这里并没有父帧,这段没执行到
2022-07-21 21:32:11 +08:00
KeyFrame *pParentKF = static_cast<KeyFrame *>(NULL);
if (pParentKF)
{
int nIDj = pParentKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Swj;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator itj = NonCorrectedSim3.find(pParentKF);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (itj != NonCorrectedSim3.end())
Swj = (itj->second).inverse();
else
Swj = vScw[nIDj].inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sij = Siw * Swj;
Eigen::Matrix4d Tij;
Tij.block<3, 3>(0, 0) = Sij.rotation().toRotationMatrix();
Tij.block<3, 1>(0, 3) = Sij.translation();
Tij(3, 3) = 1.;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Edge4DoF *e = new Edge4DoF(Tij);
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDj)));
e->information() = matLambda;
optimizer.addEdge(e);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// 1.1.1 Inertial edges
2022-07-21 22:27:32 +08:00
// 代替父帧的是利用mPrevKF流程与上面一样
2022-07-21 21:32:11 +08:00
KeyFrame *prevKF = pKF->mPrevKF;
if (prevKF)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
int nIDj = prevKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Swj;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator itj = NonCorrectedSim3.find(prevKF);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (itj != NonCorrectedSim3.end())
Swj = (itj->second).inverse();
else
Swj = vScw[nIDj].inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sij = Siw * Swj;
Eigen::Matrix4d Tij;
Tij.block<3, 3>(0, 0) = Sij.rotation().toRotationMatrix();
Tij.block<3, 1>(0, 3) = Sij.translation();
Tij(3, 3) = 1.;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Edge4DoF *e = new Edge4DoF(Tij);
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDj)));
e->information() = matLambda;
optimizer.addEdge(e);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// 1.2 Loop edges
2022-07-21 22:27:32 +08:00
// 4.2 添加在CorrectLoop函数中AddLoopEdge函数添加的闭环连接边当前帧与闭环匹配帧之间的连接关系
// 使用经过Sim3调整前关键帧之间的相对关系作为边
2022-07-21 21:32:11 +08:00
const set<KeyFrame *> sLoopEdges = pKF->GetLoopEdges();
for (set<KeyFrame *>::const_iterator sit = sLoopEdges.begin(), send = sLoopEdges.end(); sit != send; sit++)
{
KeyFrame *pLKF = *sit;
if (pLKF->mnId < pKF->mnId)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
g2o::Sim3 Swl;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator itl = NonCorrectedSim3.find(pLKF);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (itl != NonCorrectedSim3.end())
Swl = itl->second.inverse();
else
Swl = vScw[pLKF->mnId].inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sil = Siw * Swl;
Eigen::Matrix4d Til;
Til.block<3, 3>(0, 0) = Sil.rotation().toRotationMatrix();
Til.block<3, 1>(0, 3) = Sil.translation();
Til(3, 3) = 1.;
2022-07-21 22:27:32 +08:00
// 同样,认为相对位姿比较准
2022-07-21 21:32:11 +08:00
Edge4DoF *e = new Edge4DoF(Til);
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pLKF->mnId)));
e->information() = matLambda;
optimizer.addEdge(e);
}
}
// 1.3 Covisibility graph edges
2022-07-21 22:27:32 +08:00
// 4.3 最有很好共视关系的关键帧也作为边进行优化
// 使用经过Sim3调整前关键帧之间的相对关系作为边
2022-07-21 21:32:11 +08:00
const vector<KeyFrame *> vpConnectedKFs = pKF->GetCovisiblesByWeight(minFeat);
for (vector<KeyFrame *>::const_iterator vit = vpConnectedKFs.begin(); vit != vpConnectedKFs.end(); vit++)
{
KeyFrame *pKFn = *vit;
2022-07-21 22:27:32 +08:00
// 在之前没有添加过
2022-07-21 21:32:11 +08:00
if (pKFn && pKFn != pParentKF && pKFn != prevKF && pKFn != pKF->mNextKF && !pKF->hasChild(pKFn) && !sLoopEdges.count(pKFn))
{
if (!pKFn->isBad() && pKFn->mnId < pKF->mnId)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (sInsertedEdges.count(make_pair(min(pKF->mnId, pKFn->mnId), max(pKF->mnId, pKFn->mnId))))
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Swn;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
LoopClosing::KeyFrameAndPose::const_iterator itn = NonCorrectedSim3.find(pKFn);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (itn != NonCorrectedSim3.end())
Swn = itn->second.inverse();
else
Swn = vScw[pKFn->mnId].inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sin = Siw * Swn;
Eigen::Matrix4d Tin;
Tin.block<3, 3>(0, 0) = Sin.rotation().toRotationMatrix();
Tin.block<3, 1>(0, 3) = Sin.translation();
Tin(3, 3) = 1.;
Edge4DoF *e = new Edge4DoF(Tin);
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFn->mnId)));
e->information() = matLambda;
2020-12-01 11:58:17 +08:00
optimizer.addEdge(e);
}
}
}
}
2022-07-21 22:27:32 +08:00
// 5. 开始g2o优化
2022-03-28 21:20:28 +08:00
optimizer.initializeOptimization();
2022-07-21 21:32:11 +08:00
optimizer.computeActiveErrors();
optimizer.optimize(20);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
unique_lock<mutex> lock(pMap->mMutexMapUpdate);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// SE3 Pose Recovering. Sim3:[sR t;0 1] -> SE3:[R t/s;0 1]
2022-07-21 22:27:32 +08:00
// 6. 设定优化后的位姿
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vpKFs.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexPose4DoF *Vi = static_cast<VertexPose4DoF *>(optimizer.vertex(nIDi));
Eigen::Matrix3d Ri = Vi->estimate().Rcw[0];
Eigen::Vector3d ti = Vi->estimate().tcw[0];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 CorrectedSiw = g2o::Sim3(Ri, ti, 1.);
vCorrectedSwc[nIDi] = CorrectedSiw.inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tiw(CorrectedSiw.rotation(), CorrectedSiw.translation());
pKFi->SetPose(Tiw.cast<float>());
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Correct points. Transform to "non-optimized" reference keyframe pose and transform back with optimized pose
2022-07-21 22:27:32 +08:00
// 7. 步骤5和步骤6优化得到关键帧的位姿后MapPoints根据参考帧优化前后的相对关系调整自己的位置
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpMPs.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
MapPoint *pMP = vpMPs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
int nIDr;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
KeyFrame *pRefKF = pMP->GetReferenceKeyFrame();
nIDr = pRefKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 得到MapPoint参考关键帧步骤5优化前的位姿
2022-07-21 21:32:11 +08:00
g2o::Sim3 Srw = vScw[nIDr];
2022-07-21 22:27:32 +08:00
// 得到MapPoint参考关键帧优化后的位姿
2022-07-21 21:32:11 +08:00
g2o::Sim3 correctedSwr = vCorrectedSwc[nIDr];
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 更新的过程就是先将他通过原始位姿转到相机坐标系下,再通过新的位姿转到更新后的世界坐标
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 3, 1> eigP3Dw = pMP->GetWorldPos().cast<double>();
Eigen::Matrix<double, 3, 1> eigCorrectedP3Dw = correctedSwr.map(Srw.map(eigP3Dw));
pMP->SetWorldPos(eigCorrectedP3Dw.cast<float>());
2020-12-01 11:58:17 +08:00
pMP->UpdateNormalAndDepth();
}
pMap->IncreaseChangeIndex();
}
2022-07-21 21:32:11 +08:00
/**************************************以下为地图融合优化**************************************************************/
2022-07-21 22:27:32 +08:00
/**
* @brief Local Bundle Adjustment LoopClosing::MergeLocal() 使
* 1. vpAdjustKF; 2.vpAdjustKFvpFixedKFMP
* ,
* @param pMainKF mpCurrentKF
* @param vpAdjustKF vpLocalCurrentWindowKFs KF
* @param vpFixedKF vpMergeConnectedKFs KF
* @param pbStopFlag false
*/
2022-07-21 21:32:11 +08:00
void Optimizer::LocalBundleAdjustment(
KeyFrame *pMainKF, vector<KeyFrame *> vpAdjustKF, vector<KeyFrame *> vpFixedKF, bool *pbStopFlag)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
bool bShowImages = false;
vector<MapPoint *> vpMPs;
2022-07-21 22:27:32 +08:00
// 1. 构建g2o优化器
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3::LinearSolverType *linearSolver;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolver_6_3::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolver_6_3 *solver_ptr = new g2o::BlockSolver_6_3(linearSolver);
2021-09-03 14:24:01 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
optimizer.setAlgorithm(solver);
2022-07-21 21:32:11 +08:00
optimizer.setVerbose(false);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
optimizer.setForceStopFlag(pbStopFlag);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
long unsigned int maxKFid = 0;
2022-07-21 22:27:32 +08:00
set<KeyFrame *> spKeyFrameBA; // 存放关键帧,包含固定的与不固定的
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Map *pCurrentMap = pMainKF->GetMap();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set fixed KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 2. 构建固定关键帧的节点并储存对应的MP
2022-07-21 21:32:11 +08:00
int numInsertedPoints = 0;
for (KeyFrame *pKFi : vpFixedKF)
{
if (pKFi->isBad() || pKFi->GetMap() != pCurrentMap)
{
Verbose::PrintMess("ERROR LBA: KF is bad or is not in the current map", Verbose::VERBOSITY_NORMAL);
continue;
}
2022-07-21 22:27:32 +08:00
pKFi->mnBALocalForMerge = pMainKF->mnId; // 防止重复添加
2022-07-21 21:32:11 +08:00
g2o::VertexSE3Expmap *vSE3 = new g2o::VertexSE3Expmap();
Sophus::SE3<float> Tcw = pKFi->GetPose();
vSE3->setEstimate(g2o::SE3Quat(Tcw.unit_quaternion().cast<double>(), Tcw.translation().cast<double>()));
vSE3->setId(pKFi->mnId);
vSE3->setFixed(true);
optimizer.addVertex(vSE3);
if (pKFi->mnId > maxKFid)
maxKFid = pKFi->mnId;
set<MapPoint *> spViewMPs = pKFi->GetMapPoints();
for (MapPoint *pMPi : spViewMPs)
{
if (pMPi)
if (!pMPi->isBad() && pMPi->GetMap() == pCurrentMap)
if (pMPi->mnBALocalForMerge != pMainKF->mnId)
{
vpMPs.push_back(pMPi);
pMPi->mnBALocalForMerge = pMainKF->mnId;
numInsertedPoints++;
}
}
spKeyFrameBA.insert(pKFi);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set non fixed Keyframe vertices
2022-07-21 22:27:32 +08:00
// 3. 构建不固定关键帧的节点并储存对应的MP
2022-07-21 21:32:11 +08:00
set<KeyFrame *> spAdjustKF(vpAdjustKF.begin(), vpAdjustKF.end());
numInsertedPoints = 0;
for (KeyFrame *pKFi : vpAdjustKF)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pKFi->isBad() || pKFi->GetMap() != pCurrentMap)
continue;
2022-07-21 22:27:32 +08:00
pKFi->mnBALocalForMerge = pMainKF->mnId; // 防止重复添加
2022-07-21 21:32:11 +08:00
g2o::VertexSE3Expmap *vSE3 = new g2o::VertexSE3Expmap();
Sophus::SE3<float> Tcw = pKFi->GetPose();
vSE3->setEstimate(g2o::SE3Quat(Tcw.unit_quaternion().cast<double>(), Tcw.translation().cast<double>()));
vSE3->setId(pKFi->mnId);
optimizer.addVertex(vSE3);
if (pKFi->mnId > maxKFid)
maxKFid = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
set<MapPoint *> spViewMPs = pKFi->GetMapPoints();
for (MapPoint *pMPi : spViewMPs)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pMPi)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (!pMPi->isBad() && pMPi->GetMap() == pCurrentMap)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pMPi->mnBALocalForMerge != pMainKF->mnId)
{
vpMPs.push_back(pMPi);
pMPi->mnBALocalForMerge = pMainKF->mnId;
numInsertedPoints++;
}
}
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
spKeyFrameBA.insert(pKFi);
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 准备存放边的vector
2022-07-21 21:32:11 +08:00
const int nExpectedSize = (vpAdjustKF.size() + vpFixedKF.size()) * vpMPs.size();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<ORB_SLAM3::EdgeSE3ProjectXYZ *> vpEdgesMono;
vpEdgesMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFMono;
vpEdgeKFMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeMono;
vpMapPointEdgeMono.reserve(nExpectedSize);
vector<g2o::EdgeStereoSE3ProjectXYZ *> vpEdgesStereo;
vpEdgesStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFStereo;
vpEdgeKFStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeStereo;
vpMapPointEdgeStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float thHuber2D = sqrt(5.99);
const float thHuber3D = sqrt(7.815);
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
map<KeyFrame *, int> mpObsKFs; // 统计每个关键帧对应的MP点数调试输出用
map<KeyFrame *, int> mpObsFinalKFs; // 统计每个MP对应的关键帧数调试输出用
map<MapPoint *, int> mpObsMPs; // 统计每个MP被观测的图片数双目就是两个调试输出用
// 4. 确定MP节点与边的连接
2022-07-21 21:32:11 +08:00
for (unsigned int i = 0; i < vpMPs.size(); ++i)
{
MapPoint *pMPi = vpMPs[i];
if (pMPi->isBad())
continue;
g2o::VertexSBAPointXYZ *vPoint = new g2o::VertexSBAPointXYZ();
vPoint->setEstimate(pMPi->GetWorldPos().cast<double>());
const int id = pMPi->mnId + maxKFid + 1;
vPoint->setId(id);
vPoint->setMarginalized(true);
optimizer.addVertex(vPoint);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const map<KeyFrame *, tuple<int, int>> observations = pMPi->GetObservations();
int nEdges = 0;
// SET EDGES
for (map<KeyFrame *, tuple<int, int>>::const_iterator mit = observations.begin(); mit != observations.end(); mit++)
{
KeyFrame *pKF = mit->first;
2022-07-21 22:27:32 +08:00
// 跳过的条件
// 1. 帧坏了
// 2. 帧靠后
// 3. 不在参与优化帧的里面
// 4. 在左相机上不存在这个三维点
2022-07-21 21:32:11 +08:00
if (pKF->isBad() || pKF->mnId > maxKFid || pKF->mnBALocalForMerge != pMainKF->mnId || !pKF->GetMapPoint(get<0>(mit->second)))
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
nEdges++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const cv::KeyPoint &kpUn = pKF->mvKeysUn[get<0>(mit->second)];
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 注意这里没有考虑相机2
2022-07-21 21:32:11 +08:00
if (pKF->mvuRight[get<0>(mit->second)] < 0) // Monocular
{
mpObsMPs[pMPi]++;
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZ *e = new ORB_SLAM3::EdgeSE3ProjectXYZ();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKF->mnId)));
e->setMeasurement(obs);
const float &invSigma2 = pKF->mvInvLevelSigma2[kpUn.octave];
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuber2D);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->pCamera = pKF->mpCamera;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesMono.push_back(e);
vpEdgeKFMono.push_back(pKF);
vpMapPointEdgeMono.push_back(pMPi);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
mpObsKFs[pKF]++;
}
else // RGBD or Stereo
{
mpObsMPs[pMPi] += 2;
Eigen::Matrix<double, 3, 1> obs;
const float kp_ur = pKF->mvuRight[get<0>(mit->second)];
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::EdgeStereoSE3ProjectXYZ *e = new g2o::EdgeStereoSE3ProjectXYZ();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKF->mnId)));
e->setMeasurement(obs);
const float &invSigma2 = pKF->mvInvLevelSigma2[kpUn.octave];
Eigen::Matrix3d Info = Eigen::Matrix3d::Identity() * invSigma2;
e->setInformation(Info);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuber3D);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->fx = pKF->fx;
e->fy = pKF->fy;
e->cx = pKF->cx;
e->cy = pKF->cy;
e->bf = pKF->mbf;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpEdgesStereo.push_back(e);
vpEdgeKFStereo.push_back(pKF);
vpMapPointEdgeStereo.push_back(pMPi);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
mpObsKFs[pKF]++;
2020-12-01 11:58:17 +08:00
}
}
}
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
if (*pbStopFlag)
return;
2022-07-21 22:27:32 +08:00
// 5. 优化
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization();
optimizer.optimize(5);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
bool bDoMore = true;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
if (*pbStopFlag)
bDoMore = false;
2022-07-21 22:27:32 +08:00
// 6. 剔除误差大的边
2022-07-21 21:32:11 +08:00
map<unsigned long int, int> mWrongObsKF;
if (bDoMore)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
// Check inlier observations
int badMonoMP = 0, badStereoMP = 0;
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
ORB_SLAM3::EdgeSE3ProjectXYZ *e = vpEdgesMono[i];
MapPoint *pMP = vpMapPointEdgeMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (e->chi2() > 5.991 || !e->isDepthPositive())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
e->setLevel(1);
badMonoMP++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
e->setRobustKernel(0);
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
g2o::EdgeStereoSE3ProjectXYZ *e = vpEdgesStereo[i];
MapPoint *pMP = vpMapPointEdgeStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
if (e->chi2() > 7.815 || !e->isDepthPositive())
2020-12-01 11:58:17 +08:00
{
e->setLevel(1);
2022-07-21 21:32:11 +08:00
badStereoMP++;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
e->setRobustKernel(0);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("[BA]: First optimization(Huber), there are " + to_string(badMonoMP) + " monocular and " + to_string(badStereoMP) + " stereo bad edges", Verbose::VERBOSITY_DEBUG);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization(0);
optimizer.optimize(10);
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 7. 删除误差大的点与帧的连接关系
2022-07-21 21:32:11 +08:00
vector<pair<KeyFrame *, MapPoint *>> vToErase;
vToErase.reserve(vpEdgesMono.size() + vpEdgesStereo.size());
set<MapPoint *> spErasedMPs;
set<KeyFrame *> spErasedKFs;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Check inlier observations
int badMonoMP = 0, badStereoMP = 0;
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
{
ORB_SLAM3::EdgeSE3ProjectXYZ *e = vpEdgesMono[i];
MapPoint *pMP = vpMapPointEdgeMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (e->chi2() > 5.991 || !e->isDepthPositive())
{
KeyFrame *pKFi = vpEdgeKFMono[i];
vToErase.push_back(make_pair(pKFi, pMP));
mWrongObsKF[pKFi->mnId]++;
badMonoMP++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
spErasedMPs.insert(pMP);
spErasedKFs.insert(pKFi);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
g2o::EdgeStereoSE3ProjectXYZ *e = vpEdgesStereo[i];
MapPoint *pMP = vpMapPointEdgeStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
if (e->chi2() > 7.815 || !e->isDepthPositive())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpEdgeKFStereo[i];
vToErase.push_back(make_pair(pKFi, pMP));
mWrongObsKF[pKFi->mnId]++;
badStereoMP++;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
spErasedMPs.insert(pMP);
spErasedKFs.insert(pKFi);
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("[BA]: Second optimization, there are " + to_string(badMonoMP) + " monocular and " + to_string(badStereoMP) + " sterero bad edges", Verbose::VERBOSITY_DEBUG);
// Get Map Mutex
unique_lock<mutex> lock(pMainKF->GetMap()->mMutexMapUpdate);
if (!vToErase.empty())
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 剔除链接关系,其他均为调试
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vToErase.size(); i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vToErase[i].first;
MapPoint *pMPi = vToErase[i].second;
pKFi->EraseMapPointMatch(pMPi);
pMPi->EraseObservation(pKFi);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
}
2022-07-21 22:27:32 +08:00
// 没用,调试的
2022-07-21 21:32:11 +08:00
for (unsigned int i = 0; i < vpMPs.size(); ++i)
{
MapPoint *pMPi = vpMPs[i];
if (pMPi->isBad())
continue;
const map<KeyFrame *, tuple<int, int>> observations = pMPi->GetObservations();
for (map<KeyFrame *, tuple<int, int>>::const_iterator mit = observations.begin(); mit != observations.end(); mit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKF = mit->first;
if (pKF->isBad() || pKF->mnId > maxKFid || pKF->mnBALocalForKF != pMainKF->mnId || !pKF->GetMapPoint(get<0>(mit->second)))
continue;
if (pKF->mvuRight[get<0>(mit->second)] < 0) // Monocular
{
mpObsFinalKFs[pKF]++;
}
else // RGBD or Stereo
{
mpObsFinalKFs[pKF]++;
}
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
// Recover optimized data
2022-07-21 22:27:32 +08:00
// 8. 取出结果
2022-07-21 21:32:11 +08:00
// Keyframes
for (KeyFrame *pKFi : vpAdjustKF)
{
if (pKFi->isBad())
continue;
2022-07-21 22:27:32 +08:00
// 8.1 取出对应位姿
2022-07-21 21:32:11 +08:00
g2o::VertexSE3Expmap *vSE3 = static_cast<g2o::VertexSE3Expmap *>(optimizer.vertex(pKFi->mnId));
g2o::SE3Quat SE3quat = vSE3->estimate();
Sophus::SE3f Tiw(SE3quat.rotation().cast<float>(), SE3quat.translation().cast<float>());
2022-07-21 22:27:32 +08:00
// 统计调试用
2022-07-21 21:32:11 +08:00
int numMonoBadPoints = 0, numMonoOptPoints = 0;
int numStereoBadPoints = 0, numStereoOptPoints = 0;
2022-07-21 22:27:32 +08:00
vector<MapPoint *> vpMonoMPsOpt, vpStereoMPsOpt; // 存放mp内点
vector<MapPoint *> vpMonoMPsBad, vpStereoMPsBad; // 存放mp外点
// 8.2 卡方检验,调试用的貌似没别的作用
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
{
ORB_SLAM3::EdgeSE3ProjectXYZ *e = vpEdgesMono[i];
MapPoint *pMP = vpMapPointEdgeMono[i];
KeyFrame *pKFedge = vpEdgeKFMono[i];
if (pKFi != pKFedge)
{
continue;
}
if (pMP->isBad())
continue;
if (e->chi2() > 5.991 || !e->isDepthPositive())
{
numMonoBadPoints++;
vpMonoMPsBad.push_back(pMP);
}
else
{
numMonoOptPoints++;
vpMonoMPsOpt.push_back(pMP);
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
g2o::EdgeStereoSE3ProjectXYZ *e = vpEdgesStereo[i];
MapPoint *pMP = vpMapPointEdgeStereo[i];
KeyFrame *pKFedge = vpEdgeKFMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi != pKFedge)
{
continue;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (e->chi2() > 7.815 || !e->isDepthPositive())
{
numStereoBadPoints++;
vpStereoMPsBad.push_back(pMP);
}
else
{
numStereoOptPoints++;
vpStereoMPsOpt.push_back(pMP);
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
pKFi->SetPose(Tiw);
2020-12-01 11:58:17 +08:00
}
2022-07-21 22:27:32 +08:00
// 更新点的坐标
2022-07-21 21:32:11 +08:00
for (MapPoint *pMPi : vpMPs)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (pMPi->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::VertexSBAPointXYZ *vPoint = static_cast<g2o::VertexSBAPointXYZ *>(optimizer.vertex(pMPi->mnId + maxKFid + 1));
pMPi->SetWorldPos(vPoint->estimate().cast<float>());
pMPi->UpdateNormalAndDepth();
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 22:27:32 +08:00
/**
* @brief LoopClosing::MergeLocal() 使
* 1. vpNonFixedKFs; 2.vpNonCorrectedMPs
* @param pCurKF mpCurrentKF
* @param vpFixedKFs vpMergeConnectedKFs vpFixedKF
* @param vpFixedCorrectedKFs vpLocalCurrentWindowKFs Optimizer::LocalBundleAdjustmentvpAdjustKF
* @param vpNonFixedKFs vpCurrentMapKFs
* @param vpNonCorrectedMPs vpCurrentMapMPs MP
*/
2022-07-21 21:32:11 +08:00
void Optimizer::OptimizeEssentialGraph(
KeyFrame *pCurKF, vector<KeyFrame *> &vpFixedKFs, vector<KeyFrame *> &vpFixedCorrectedKFs,
vector<KeyFrame *> &vpNonFixedKFs, vector<MapPoint *> &vpNonCorrectedMPs)
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 1. 优化器构建
2020-12-01 11:58:17 +08:00
g2o::SparseOptimizer optimizer;
2022-07-21 21:32:11 +08:00
optimizer.setVerbose(false);
g2o::BlockSolver_7_3::LinearSolverType *linearSolver =
new g2o::LinearSolverEigen<g2o::BlockSolver_7_3::PoseMatrixType>();
g2o::BlockSolver_7_3 *solver_ptr = new g2o::BlockSolver_7_3(linearSolver);
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
solver->setUserLambdaInit(1e-16);
optimizer.setAlgorithm(solver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Map *pMap = pCurKF->GetMap();
const unsigned int nMaxKFid = pMap->GetMaxKFid();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
vector<g2o::Sim3, Eigen::aligned_allocator<g2o::Sim3>> vScw(nMaxKFid + 1); // 存放每一帧优化前的sim3
vector<g2o::Sim3, Eigen::aligned_allocator<g2o::Sim3>> vCorrectedSwc(nMaxKFid + 1); // 存放每一帧优化后的sim3调试输出用没有实际作用
vector<g2o::VertexSim3Expmap *> vpVertices(nMaxKFid + 1); // 存放节点,没用,还占地方
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<bool> vpGoodPose(nMaxKFid + 1);
vector<bool> vpBadPose(nMaxKFid + 1);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
const int minFeat = 100; // pKFi->GetCovisiblesByWeight(minFeat); essentialgraph 阈值就是共视大于100
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 2. 确定固定关键帧的节点
// vpMergeConnectedKFs 融合地图中的关键帧
2022-07-21 21:32:11 +08:00
for (KeyFrame *pKFi : vpFixedKFs)
{
if (pKFi->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::VertexSim3Expmap *VSim3 = new g2o::VertexSim3Expmap();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tcw = pKFi->GetPose().cast<double>();
g2o::Sim3 Siw(Tcw.unit_quaternion(), Tcw.translation(), 1.0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vCorrectedSwc[nIDi] = Siw.inverse();
VSim3->setEstimate(Siw);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VSim3->setFixed(true);
2022-03-28 21:20:28 +08:00
2022-07-21 21:32:11 +08:00
VSim3->setId(nIDi);
VSim3->setMarginalized(false);
VSim3->_fix_scale = true;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addVertex(VSim3);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpVertices[nIDi] = VSim3;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpGoodPose[nIDi] = true;
vpBadPose[nIDi] = false;
}
Verbose::PrintMess("Opt_Essential: vpFixedKFs loaded", Verbose::VERBOSITY_DEBUG);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
set<unsigned long> sIdKF;
2022-07-21 22:27:32 +08:00
// vpLocalCurrentWindowKFs 当前地图中经过矫正的关键帧
2022-07-21 21:32:11 +08:00
for (KeyFrame *pKFi : vpFixedCorrectedKFs)
{
if (pKFi->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::VertexSim3Expmap *VSim3 = new g2o::VertexSim3Expmap();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tcw = pKFi->GetPose().cast<double>();
g2o::Sim3 Siw(Tcw.unit_quaternion(), Tcw.translation(), 1.0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vCorrectedSwc[nIDi] = Siw.inverse();
VSim3->setEstimate(Siw);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tcw_bef = pKFi->mTcwBefMerge.cast<double>();
vScw[nIDi] = g2o::Sim3(Tcw_bef.unit_quaternion(), Tcw_bef.translation(), 1.0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VSim3->setFixed(true);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VSim3->setId(nIDi);
VSim3->setMarginalized(false);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addVertex(VSim3);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpVertices[nIDi] = VSim3;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
sIdKF.insert(nIDi);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vpGoodPose[nIDi] = true;
vpBadPose[nIDi] = true;
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 3. 确定待优化的关键帧节点
2022-07-21 21:32:11 +08:00
for (KeyFrame *pKFi : vpNonFixedKFs)
{
if (pKFi->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (sIdKF.count(nIDi)) // It has already added in the corrected merge KFs
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::VertexSim3Expmap *VSim3 = new g2o::VertexSim3Expmap();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tcw = pKFi->GetPose().cast<double>();
g2o::Sim3 Siw(Tcw.unit_quaternion(), Tcw.translation(), 1.0);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vScw[nIDi] = Siw;
VSim3->setEstimate(Siw);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VSim3->setFixed(false);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VSim3->setId(nIDi);
VSim3->setMarginalized(false);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.addVertex(VSim3);
vpVertices[nIDi] = VSim3;
sIdKF.insert(nIDi);
vpGoodPose[nIDi] = false;
vpBadPose[nIDi] = true;
2020-12-01 11:58:17 +08:00
}
2021-09-03 14:24:01 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpKFs;
vpKFs.reserve(vpFixedKFs.size() + vpFixedCorrectedKFs.size() + vpNonFixedKFs.size());
vpKFs.insert(vpKFs.end(), vpFixedKFs.begin(), vpFixedKFs.end());
vpKFs.insert(vpKFs.end(), vpFixedCorrectedKFs.begin(), vpFixedCorrectedKFs.end());
vpKFs.insert(vpKFs.end(), vpNonFixedKFs.begin(), vpNonFixedKFs.end());
set<KeyFrame *> spKFs(vpKFs.begin(), vpKFs.end());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const Eigen::Matrix<double, 7, 7> matLambda = Eigen::Matrix<double, 7, 7>::Identity();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 4. 遍历所有帧
2022-07-21 21:32:11 +08:00
for (KeyFrame *pKFi : vpKFs)
{
2022-07-21 22:27:32 +08:00
int num_connections = 0; // 统计与pKFi连接的数量
2022-07-21 21:32:11 +08:00
const int nIDi = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 correctedSwi;
g2o::Sim3 Swi;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (vpGoodPose[nIDi])
correctedSwi = vCorrectedSwc[nIDi];
if (vpBadPose[nIDi])
Swi = vScw[nIDi].inverse();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
KeyFrame *pParentKFi = pKFi->GetParent();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Spanning tree edge
2022-07-21 22:27:32 +08:00
// 4.1 找到pKFi的父帧且在这批关键帧里面添加与其关联的sim3边相对约束
2022-07-21 21:32:11 +08:00
if (pParentKFi && spKFs.find(pParentKFi) != spKFs.end())
{
int nIDj = pParentKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Sjw;
bool bHasRelation = false;
if (vpGoodPose[nIDi] && vpGoodPose[nIDj])
{
Sjw = vCorrectedSwc[nIDj].inverse();
bHasRelation = true;
}
else if (vpBadPose[nIDi] && vpBadPose[nIDj])
{
Sjw = vScw[nIDj];
bHasRelation = true;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (bHasRelation)
{
g2o::Sim3 Sji = Sjw * Swi;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::EdgeSim3 *e = new g2o::EdgeSim3();
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDj)));
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
e->setMeasurement(Sji);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->information() = matLambda;
optimizer.addEdge(e);
num_connections++;
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Loop edges
2022-07-21 22:27:32 +08:00
// 4.2 添加回环的边
2022-07-21 21:32:11 +08:00
const set<KeyFrame *> sLoopEdges = pKFi->GetLoopEdges();
for (set<KeyFrame *>::const_iterator sit = sLoopEdges.begin(), send = sLoopEdges.end(); sit != send; sit++)
{
KeyFrame *pLKF = *sit;
if (spKFs.find(pLKF) != spKFs.end() && pLKF->mnId < pKFi->mnId)
{
g2o::Sim3 Slw;
bool bHasRelation = false;
if (vpGoodPose[nIDi] && vpGoodPose[pLKF->mnId])
{
Slw = vCorrectedSwc[pLKF->mnId].inverse();
bHasRelation = true;
}
else if (vpBadPose[nIDi] && vpBadPose[pLKF->mnId])
{
Slw = vScw[pLKF->mnId];
bHasRelation = true;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (bHasRelation)
{
g2o::Sim3 Sli = Slw * Swi;
g2o::EdgeSim3 *el = new g2o::EdgeSim3();
el->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pLKF->mnId)));
el->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
el->setMeasurement(Sli);
el->information() = matLambda;
optimizer.addEdge(el);
num_connections++;
}
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Covisibility graph edges
2022-07-21 22:27:32 +08:00
// 4.3 建立essentialgraph共视边
2022-07-21 21:32:11 +08:00
const vector<KeyFrame *> vpConnectedKFs = pKFi->GetCovisiblesByWeight(minFeat);
for (vector<KeyFrame *>::const_iterator vit = vpConnectedKFs.begin(); vit != vpConnectedKFs.end(); vit++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFn = *vit;
2022-07-21 22:27:32 +08:00
// 1.这个帧存在且不是pKFi的父帧防止重复添加
// 2.pKFn不为pKFi的子帧
// 3.pKFn不为回环帧
// 4.pKFn要在这批关键帧里面
// 防止重复添加
2022-07-21 21:32:11 +08:00
if (pKFn && pKFn != pParentKFi && !pKFi->hasChild(pKFn) && !sLoopEdges.count(pKFn) && spKFs.find(pKFn) != spKFs.end())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (!pKFn->isBad() && pKFn->mnId < pKFi->mnId)
{
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::Sim3 Snw = vScw[pKFn->mnId];
bool bHasRelation = false;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (vpGoodPose[nIDi] && vpGoodPose[pKFn->mnId])
{
Snw = vCorrectedSwc[pKFn->mnId].inverse();
bHasRelation = true;
}
else if (vpBadPose[nIDi] && vpBadPose[pKFn->mnId])
{
Snw = vScw[pKFn->mnId];
bHasRelation = true;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (bHasRelation)
{
g2o::Sim3 Sni = Snw * Swi;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::EdgeSim3 *en = new g2o::EdgeSim3();
en->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFn->mnId)));
en->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(nIDi)));
en->setMeasurement(Sni);
en->information() = matLambda;
optimizer.addEdge(en);
num_connections++;
}
}
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
if (num_connections == 0)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("Opt_Essential: KF " + to_string(pKFi->mnId) + " has 0 connections", Verbose::VERBOSITY_DEBUG);
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Optimize!
2022-07-21 22:27:32 +08:00
// 5. 开始优化
2022-07-21 21:32:11 +08:00
optimizer.initializeOptimization();
optimizer.optimize(20);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
unique_lock<mutex> lock(pMap->mMutexMapUpdate);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// SE3 Pose Recovering. Sim3:[sR t;0 1] -> SE3:[R t/s;0 1]
2022-07-21 22:27:32 +08:00
// 6. 取出结果
2022-07-21 21:32:11 +08:00
for (KeyFrame *pKFi : vpNonFixedKFs)
{
if (pKFi->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const int nIDi = pKFi->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::VertexSim3Expmap *VSim3 = static_cast<g2o::VertexSim3Expmap *>(optimizer.vertex(nIDi));
g2o::Sim3 CorrectedSiw = VSim3->estimate();
vCorrectedSwc[nIDi] = CorrectedSiw.inverse();
double s = CorrectedSiw.scale();
Sophus::SE3d Tiw(CorrectedSiw.rotation(), CorrectedSiw.translation() / s);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
pKFi->mTcwBefMerge = pKFi->GetPose();
pKFi->mTwcBefMerge = pKFi->GetPoseInverse();
pKFi->SetPose(Tiw.cast<float>());
}
// Correct points. Transform to "non-optimized" reference keyframe pose and transform back with optimized pose
for (MapPoint *pMPi : vpNonCorrectedMPs)
{
if (pMPi->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
KeyFrame *pRefKF = pMPi->GetReferenceKeyFrame();
while (pRefKF->isBad())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
if (!pRefKF)
{
Verbose::PrintMess("MP " + to_string(pMPi->mnId) + " without a valid reference KF", Verbose::VERBOSITY_DEBUG);
break;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
pMPi->EraseObservation(pRefKF);
pRefKF = pMPi->GetReferenceKeyFrame();
}
2021-12-08 22:09:39 +08:00
2022-07-21 21:32:11 +08:00
if (vpBadPose[pRefKF->mnId])
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 流程就是转到相机坐标系在用新的rt转到世界
2022-07-21 21:32:11 +08:00
Sophus::SE3f TNonCorrectedwr = pRefKF->mTwcBefMerge;
Sophus::SE3f Twr = pRefKF->GetPoseInverse();
Eigen::Vector3f eigCorrectedP3Dw = Twr * TNonCorrectedwr.inverse() * pMPi->GetWorldPos();
pMPi->SetWorldPos(eigCorrectedP3Dw);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
pMPi->UpdateNormalAndDepth();
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
else
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
cout << "ERROR: MapPoint has a reference KF from another map" << endl;
2020-12-01 11:58:17 +08:00
}
}
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
/**
* @brief visual inertial ba
* LoopClosing::MergeLocal2
* 姿
* @param[in] pCurrKF
* @param[in] pMergeKF
* @param[in] pbStopFlag
* @param[in] pMap
* @param[out] corrPoses Sim3
*/
2022-07-21 21:32:11 +08:00
void Optimizer::MergeInertialBA(
KeyFrame *pCurrKF, KeyFrame *pMergeKF, bool *pbStopFlag, Map *pMap, LoopClosing::KeyFrameAndPose &corrPoses)
{
const int Nd = 6;
const unsigned long maxKFid = pCurrKF->mnId;
2022-07-21 22:27:32 +08:00
// 1. 准备所有被优化的关键帧, 完全固定的帧
// 被优化的帧, 当前帧和融合匹配帧加起来一共12个
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpOptimizableKFs;
vpOptimizableKFs.reserve(2 * Nd);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// For cov KFS, inertial parameters are not optimized
2022-07-21 22:27:32 +08:00
// 共视帧, 只优化位姿,不优化速度与偏置
2022-07-21 21:32:11 +08:00
const int maxCovKF = 30;
vector<KeyFrame *> vpOptimizableCovKFs;
vpOptimizableCovKFs.reserve(maxCovKF);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Add sliding window for current KF
2022-07-21 22:27:32 +08:00
// 当前关键帧先加到容器中
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.push_back(pCurrKF);
2022-07-21 22:27:32 +08:00
// 后面用这个变量避免重复
2022-07-21 21:32:11 +08:00
pCurrKF->mnBALocalForKF = pCurrKF->mnId;
2022-07-21 22:27:32 +08:00
// 添加5个与当前关键帧相连的时序上相连的关键帧进容器
// 1.1 一直放一直放一直放到没有上一个关键帧这里面包含了pCurrKF最近的6帧从晚到早排列不过有可能存不满
2022-07-21 21:32:11 +08:00
for (int i = 1; i < Nd; i++)
{
if (vpOptimizableKFs.back()->mPrevKF)
{
2022-07-21 22:27:32 +08:00
// 用mPrevKF访问时序上的上一个关键帧
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.push_back(vpOptimizableKFs.back()->mPrevKF);
vpOptimizableKFs.back()->mnBALocalForKF = pCurrKF->mnId;
}
else
break;
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 1.2 如果 vpOptimizableKFs 中最早的一帧前面还有,往不更新惯导参数的序列中添加
// 否则把最后一个取出来放到不更新惯导参数的序列中
2022-07-21 21:32:11 +08:00
if (vpOptimizableKFs.back()->mPrevKF)
{
vpOptimizableCovKFs.push_back(vpOptimizableKFs.back()->mPrevKF);
vpOptimizableKFs.back()->mPrevKF->mnBALocalForKF = pCurrKF->mnId;
}
else
2020-12-01 11:58:17 +08:00
{
2022-07-21 22:27:32 +08:00
// 如果没找到时序相连的帧,把被优化的窗口缩减一个给到固定的变量
2022-07-21 21:32:11 +08:00
vpOptimizableCovKFs.push_back(vpOptimizableKFs.back());
vpOptimizableKFs.pop_back();
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Add temporal neighbours to merge KF (previous and next KFs)
2022-07-21 22:27:32 +08:00
// 2. 同样, 对于融合帧也把它和时序上的几个邻居加到可优化的容器里
// 2.1 把匹配的融合关键帧也放进来准备一起优化
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.push_back(pMergeKF);
pMergeKF->mnBALocalForKF = pCurrKF->mnId;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Previous KFs
2022-07-21 22:27:32 +08:00
// 把融合帧时序上的邻居添加到可优化的容器里, 因为融合帧左右都有时序上的邻居,所以这里先取一半 Nd/2
// 2.2 再放进来3个pMergeKF之前的关键帧有可能放不满
2022-07-21 21:32:11 +08:00
for (int i = 1; i < (Nd / 2); i++)
{
if (vpOptimizableKFs.back()->mPrevKF)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.push_back(vpOptimizableKFs.back()->mPrevKF);
vpOptimizableKFs.back()->mnBALocalForKF = pCurrKF->mnId;
2020-12-01 11:58:17 +08:00
}
else
2022-07-21 21:32:11 +08:00
break;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// We fix just once the old map
2022-07-21 22:27:32 +08:00
// 记录与融合帧窗口时序上紧邻的帧为完全固定的帧
// 2.3 类似于上面的做法如果有前一个关键帧放入lFixedKeyFrames否则从vpOptimizableKFs取出注意这里防止重复添加的标识又多了一个变量
// 记录完全固定的帧
list<KeyFrame *> lFixedKeyFrames;
2022-07-21 21:32:11 +08:00
if (vpOptimizableKFs.back()->mPrevKF)
{
lFixedKeyFrames.push_back(vpOptimizableKFs.back()->mPrevKF);
vpOptimizableKFs.back()->mPrevKF->mnBAFixedForKF = pCurrKF->mnId;
}
2022-07-21 22:27:32 +08:00
// 如果没找到,则从窗口内拿出一帧给到完全固定的帧
2022-07-21 21:32:11 +08:00
else
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.back()->mnBALocalForKF = 0;
vpOptimizableKFs.back()->mnBAFixedForKF = pCurrKF->mnId;
lFixedKeyFrames.push_back(vpOptimizableKFs.back());
vpOptimizableKFs.pop_back();
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Next KFs
2022-07-21 22:27:32 +08:00
// 2.4 再添加一个pMergeKF的下一个关键帧
2022-07-21 21:32:11 +08:00
if (pMergeKF->mNextKF)
{
vpOptimizableKFs.push_back(pMergeKF->mNextKF);
vpOptimizableKFs.back()->mnBALocalForKF = pCurrKF->mnId;
}
2022-07-21 22:27:32 +08:00
// 2.5 数量不够时添加最后一个的下一帧。继续添加直到达到2Nd个可优化关键帧,或没有新的可以添加了
2022-07-21 21:32:11 +08:00
while (vpOptimizableKFs.size() < (2 * Nd))
{
if (vpOptimizableKFs.back()->mNextKF)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
vpOptimizableKFs.push_back(vpOptimizableKFs.back()->mNextKF);
vpOptimizableKFs.back()->mnBALocalForKF = pCurrKF->mnId;
2020-12-01 11:58:17 +08:00
}
else
2022-07-21 21:32:11 +08:00
break;
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
int N = vpOptimizableKFs.size();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Optimizable points seen by optimizable keyframes
2022-07-21 22:27:32 +08:00
// 3. 帧弄完了该弄点了将优化的帧的点存入lLocalMapPoints (所有被可优化关键帧看到的点)
// 添加用来优化的地图点
2022-07-21 21:32:11 +08:00
list<MapPoint *> lLocalMapPoints;
2022-07-21 22:27:32 +08:00
// 统计了在这些帧中点被观测的次数
2022-07-21 21:32:11 +08:00
map<MapPoint *, int> mLocalObs;
2022-07-21 22:27:32 +08:00
// 遍历所有可优化的关键帧
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
{
vector<MapPoint *> vpMPs = vpOptimizableKFs[i]->GetMapPointMatches();
2022-07-21 22:27:32 +08:00
// 遍历每个关键帧所有的地图点
2022-07-21 21:32:11 +08:00
for (vector<MapPoint *>::iterator vit = vpMPs.begin(), vend = vpMPs.end(); vit != vend; vit++)
{
// Using mnBALocalForKF we avoid redundance here, one MP can not be added several times to lLocalMapPoints
MapPoint *pMP = *vit;
if (pMP)
if (!pMP->isBad())
2022-07-21 22:27:32 +08:00
// 用这个变量记录是否重复添加
2022-07-21 21:32:11 +08:00
if (pMP->mnBALocalForKF != pCurrKF->mnId)
{
mLocalObs[pMP] = 1;
lLocalMapPoints.push_back(pMP);
2022-07-21 22:27:32 +08:00
pMP->mnBALocalForKF = pCurrKF->mnId; // 防止重复添加
2022-07-21 21:32:11 +08:00
}
else
{
mLocalObs[pMP]++;
}
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
std::vector<std::pair<MapPoint *, int>> pairs;
pairs.reserve(mLocalObs.size());
for (auto itr = mLocalObs.begin(); itr != mLocalObs.end(); ++itr)
pairs.push_back(*itr);
sort(pairs.begin(), pairs.end(), sortByVal);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 4. 把pCurrKF的共视帧加进来 只优化位姿,不优化速度与偏置
// 固定所有观察到地图点,但没有被加到优化变量中的关键帧
2022-07-21 21:32:11 +08:00
// Fixed Keyframes. Keyframes that see Local MapPoints but that are not Local Keyframes
int i = 0;
2022-07-21 22:27:32 +08:00
// 遍历所有的pair<地图点指针,观测次数>
2022-07-21 21:32:11 +08:00
for (vector<pair<MapPoint *, int>>::iterator lit = pairs.begin(), lend = pairs.end(); lit != lend; lit++, i++)
{
map<KeyFrame *, tuple<int, int>> observations = lit->first->GetObservations();
if (i >= maxCovKF)
break;
for (map<KeyFrame *, tuple<int, int>>::iterator mit = observations.begin(), mend = observations.end(); mit != mend; mit++)
{
KeyFrame *pKFi = mit->first;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mnBALocalForKF != pCurrKF->mnId && pKFi->mnBAFixedForKF != pCurrKF->mnId) // If optimizable or already included...
{
pKFi->mnBALocalForKF = pCurrKF->mnId;
if (!pKFi->isBad())
{
vpOptimizableCovKFs.push_back(pKFi);
break;
}
}
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 5. 构建优化器
2022-07-21 21:32:11 +08:00
g2o::SparseOptimizer optimizer;
g2o::BlockSolverX::LinearSolverType *linearSolver;
linearSolver = new g2o::LinearSolverEigen<g2o::BlockSolverX::PoseMatrixType>();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::BlockSolverX *solver_ptr = new g2o::BlockSolverX(linearSolver);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::OptimizationAlgorithmLevenberg *solver = new g2o::OptimizationAlgorithmLevenberg(solver_ptr);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
solver->setUserLambdaInit(1e3);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
optimizer.setAlgorithm(solver);
optimizer.setVerbose(false);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Local KeyFrame vertices
N = vpOptimizableKFs.size();
2022-07-21 22:27:32 +08:00
// 5.1 设置所有的可优化关键帧顶点
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
KeyFrame *pKFi = vpOptimizableKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexPose *VP = new VertexPose(pKFi);
VP->setId(pKFi->mnId);
VP->setFixed(false);
2022-07-21 22:27:32 +08:00
// 位姿
2022-07-21 21:32:11 +08:00
optimizer.addVertex(VP);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->bImu)
{
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + 3 * (pKFi->mnId) + 1);
VV->setFixed(false);
optimizer.addVertex(VV);
VertexGyroBias *VG = new VertexGyroBias(pKFi);
VG->setId(maxKFid + 3 * (pKFi->mnId) + 2);
VG->setFixed(false);
optimizer.addVertex(VG);
VertexAccBias *VA = new VertexAccBias(pKFi);
VA->setId(maxKFid + 3 * (pKFi->mnId) + 3);
VA->setFixed(false);
optimizer.addVertex(VA);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set Local cov keyframes vertices
2022-07-21 22:27:32 +08:00
// 5.2 优化位姿,速度与偏置
2022-07-21 21:32:11 +08:00
int Ncov = vpOptimizableCovKFs.size();
for (int i = 0; i < Ncov; i++)
{
KeyFrame *pKFi = vpOptimizableCovKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexPose *VP = new VertexPose(pKFi);
VP->setId(pKFi->mnId);
VP->setFixed(false);
optimizer.addVertex(VP);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->bImu)
{
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + 3 * (pKFi->mnId) + 1);
VV->setFixed(false);
optimizer.addVertex(VV);
VertexGyroBias *VG = new VertexGyroBias(pKFi);
VG->setId(maxKFid + 3 * (pKFi->mnId) + 2);
VG->setFixed(false);
optimizer.addVertex(VG);
VertexAccBias *VA = new VertexAccBias(pKFi);
VA->setId(maxKFid + 3 * (pKFi->mnId) + 3);
VA->setFixed(false);
optimizer.addVertex(VA);
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Set Fixed KeyFrame vertices
2022-07-21 22:27:32 +08:00
// 5.3 设置所有完全固定的关键帧顶点
2022-07-21 21:32:11 +08:00
for (list<KeyFrame *>::iterator lit = lFixedKeyFrames.begin(), lend = lFixedKeyFrames.end(); lit != lend; lit++)
{
KeyFrame *pKFi = *lit;
VertexPose *VP = new VertexPose(pKFi);
VP->setId(pKFi->mnId);
VP->setFixed(true);
optimizer.addVertex(VP);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->bImu)
{
VertexVelocity *VV = new VertexVelocity(pKFi);
VV->setId(maxKFid + 3 * (pKFi->mnId) + 1);
VV->setFixed(true);
optimizer.addVertex(VV);
VertexGyroBias *VG = new VertexGyroBias(pKFi);
VG->setId(maxKFid + 3 * (pKFi->mnId) + 2);
VG->setFixed(true);
optimizer.addVertex(VG);
VertexAccBias *VA = new VertexAccBias(pKFi);
VA->setId(maxKFid + 3 * (pKFi->mnId) + 3);
VA->setFixed(true);
optimizer.addVertex(VA);
}
}
2022-07-21 22:27:32 +08:00
// 6 设置所有的inertial的边
2022-07-21 21:32:11 +08:00
// Create intertial constraints
2022-07-21 22:27:32 +08:00
// 预积分边
2022-07-21 21:32:11 +08:00
vector<EdgeInertial *> vei(N, (EdgeInertial *)NULL);
2022-07-21 22:27:32 +08:00
// 角速度bias边
2022-07-21 21:32:11 +08:00
vector<EdgeGyroRW *> vegr(N, (EdgeGyroRW *)NULL);
2022-07-21 22:27:32 +08:00
// 加速地bias边
2022-07-21 21:32:11 +08:00
vector<EdgeAccRW *> vear(N, (EdgeAccRW *)NULL);
2022-07-21 22:27:32 +08:00
// 6.1 第一阶段优化vpOptimizableKFs里面的帧遍历所有可优化的关键帧
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
// cout << "inserting inertial edge " << i << endl;
KeyFrame *pKFi = vpOptimizableKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pKFi->mPrevKF)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("NOT INERTIAL LINK TO PREVIOUS FRAME!!!!", Verbose::VERBOSITY_NORMAL);
continue;
}
if (pKFi->bImu && pKFi->mPrevKF->bImu && pKFi->mpImuPreintegrated)
{
pKFi->mpImuPreintegrated->SetNewBias(pKFi->mPrevKF->GetImuBias());
2022-07-21 22:27:32 +08:00
// 位姿
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VP1 = optimizer.vertex(pKFi->mPrevKF->mnId);
2022-07-21 22:27:32 +08:00
// 速度
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VV1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 1);
2022-07-21 22:27:32 +08:00
// 角速度bias
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VG1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 2);
2022-07-21 22:27:32 +08:00
// 加速度bias
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VA1 = optimizer.vertex(maxKFid + 3 * (pKFi->mPrevKF->mnId) + 3);
2022-07-21 22:27:32 +08:00
// 同上
2022-07-21 21:32:11 +08:00
g2o::HyperGraph::Vertex *VP2 = optimizer.vertex(pKFi->mnId);
g2o::HyperGraph::Vertex *VV2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 1);
g2o::HyperGraph::Vertex *VG2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 2);
g2o::HyperGraph::Vertex *VA2 = optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 3);
if (!VP1 || !VV1 || !VG1 || !VA1 || !VP2 || !VV2 || !VG2 || !VA2)
{
cerr << "Error " << VP1 << ", " << VV1 << ", " << VG1 << ", " << VA1 << ", " << VP2 << ", " << VV2 << ", " << VG2 << ", " << VA2 << endl;
2020-12-01 11:58:17 +08:00
continue;
2022-07-21 21:32:11 +08:00
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vei[i] = new EdgeInertial(pKFi->mpImuPreintegrated);
2022-07-21 22:27:32 +08:00
// 设置顶点 2*Pose + 2*Velocity + 1 角速度bias + 1 加速度bias
2022-07-21 21:32:11 +08:00
vei[i]->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP1));
vei[i]->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV1));
vei[i]->setVertex(2, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VG1));
vei[i]->setVertex(3, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VA1));
vei[i]->setVertex(4, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VP2));
vei[i]->setVertex(5, dynamic_cast<g2o::OptimizableGraph::Vertex *>(VV2));
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// TODO Uncomment
2022-07-21 22:27:32 +08:00
// 设置优化参数
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rki = new g2o::RobustKernelHuber;
vei[i]->setRobustKernel(rki);
rki->setDelta(sqrt(16.92));
2022-07-21 22:27:32 +08:00
// 添加边
2022-07-21 21:32:11 +08:00
optimizer.addEdge(vei[i]);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 角速度bias的边
2022-07-21 21:32:11 +08:00
vegr[i] = new EdgeGyroRW();
2022-07-21 22:27:32 +08:00
// 设置顶点两个角速度bias
2022-07-21 21:32:11 +08:00
vegr[i]->setVertex(0, VG1);
vegr[i]->setVertex(1, VG2);
2022-07-21 22:27:32 +08:00
// 设置infomation matrix
2022-07-21 21:32:11 +08:00
Eigen::Matrix3d InfoG = pKFi->mpImuPreintegrated->C.block<3, 3>(9, 9).cast<double>().inverse();
vegr[i]->setInformation(InfoG);
optimizer.addEdge(vegr[i]);
2022-07-21 22:27:32 +08:00
// 设置加速度的边
2022-07-21 21:32:11 +08:00
vear[i] = new EdgeAccRW();
vear[i]->setVertex(0, VA1);
vear[i]->setVertex(1, VA2);
2022-07-21 22:27:32 +08:00
// 设置information matrix
2022-07-21 21:32:11 +08:00
Eigen::Matrix3d InfoA = pKFi->mpImuPreintegrated->C.block<3, 3>(12, 12).cast<double>().inverse();
vear[i]->setInformation(InfoA);
optimizer.addEdge(vear[i]);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
else
Verbose::PrintMess("ERROR building inertial edge", Verbose::VERBOSITY_NORMAL);
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
Verbose::PrintMess("end inserting inertial edges", Verbose::VERBOSITY_NORMAL);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Set MapPoint vertices
2022-07-21 22:27:32 +08:00
// 6.2 设置所有地图的顶点
// 设置地图点顶点
2022-07-21 21:32:11 +08:00
const int nExpectedSize = (N + Ncov + lFixedKeyFrames.size()) * lLocalMapPoints.size();
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 对于双目单目设置不同
2022-07-21 21:32:11 +08:00
// Mono
vector<EdgeMono *> vpEdgesMono;
vpEdgesMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFMono;
vpEdgeKFMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeMono;
vpMapPointEdgeMono.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Stereo
vector<EdgeStereo *> vpEdgesStereo;
vpEdgesStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<KeyFrame *> vpEdgeKFStereo;
vpEdgeKFStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
vector<MapPoint *> vpMapPointEdgeStereo;
vpMapPointEdgeStereo.reserve(nExpectedSize);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const float thHuberMono = sqrt(5.991);
const float chi2Mono2 = 5.991;
const float thHuberStereo = sqrt(7.815);
const float chi2Stereo2 = 7.815;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const unsigned long iniMPid = maxKFid * 5;
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 遍历所有被可优化关键帧观测到的的地图点
// 7. 添加重投影的边
2022-07-21 21:32:11 +08:00
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
{
MapPoint *pMP = *lit;
if (!pMP)
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::VertexSBAPointXYZ *vPoint = new g2o::VertexSBAPointXYZ();
vPoint->setEstimate(pMP->GetWorldPos().cast<double>());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
unsigned long id = pMP->mnId + iniMPid + 1;
vPoint->setId(id);
vPoint->setMarginalized(true);
2022-07-21 22:27:32 +08:00
// 添加顶点
2022-07-21 21:32:11 +08:00
optimizer.addVertex(vPoint);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
const map<KeyFrame *, tuple<int, int>> observations = pMP->GetObservations();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Create visual constraints
2022-07-21 22:27:32 +08:00
// 添加重投影边
2022-07-21 21:32:11 +08:00
for (map<KeyFrame *, tuple<int, int>>::const_iterator mit = observations.begin(), mend = observations.end(); mit != mend; mit++)
{
KeyFrame *pKFi = mit->first;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pKFi)
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if ((pKFi->mnBALocalForKF != pCurrKF->mnId) && (pKFi->mnBAFixedForKF != pCurrKF->mnId))
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->mnId > maxKFid)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
continue;
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (optimizer.vertex(id) == NULL || optimizer.vertex(pKFi->mnId) == NULL)
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (!pKFi->isBad())
{
2022-07-21 22:27:32 +08:00
// 3D点的观测
2022-07-21 21:32:11 +08:00
const cv::KeyPoint &kpUn = pKFi->mvKeysUn[get<0>(mit->second)];
2022-07-21 22:27:32 +08:00
// 如果是单目观测
2022-07-21 21:32:11 +08:00
if (pKFi->mvuRight[get<0>(mit->second)] < 0) // Monocular observation
{
2022-07-21 22:27:32 +08:00
// 投影
2022-07-21 21:32:11 +08:00
Eigen::Matrix<double, 2, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeMono *e = new EdgeMono();
2022-07-21 22:27:32 +08:00
// 设置边的顶点
// 3D点
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
2022-07-21 22:27:32 +08:00
// 关键帧位姿
2022-07-21 21:32:11 +08:00
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
e->setMeasurement(obs);
const float &invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave];
2022-07-21 22:27:32 +08:00
// 设置信息矩阵
2022-07-21 21:32:11 +08:00
e->setInformation(Eigen::Matrix2d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuberMono);
2022-07-21 22:27:32 +08:00
// 添加边
2022-07-21 21:32:11 +08:00
optimizer.addEdge(e);
vpEdgesMono.push_back(e);
vpEdgeKFMono.push_back(pKFi);
vpMapPointEdgeMono.push_back(pMP);
}
2022-07-21 22:27:32 +08:00
// 双目
2022-07-21 21:32:11 +08:00
else // stereo observation
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
const float kp_ur = pKFi->mvuRight[get<0>(mit->second)];
Eigen::Matrix<double, 3, 1> obs;
obs << kpUn.pt.x, kpUn.pt.y, kp_ur;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
EdgeStereo *e = new EdgeStereo();
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
e->setVertex(0, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(id)));
e->setVertex(1, dynamic_cast<g2o::OptimizableGraph::Vertex *>(optimizer.vertex(pKFi->mnId)));
e->setMeasurement(obs);
const float &invSigma2 = pKFi->mvInvLevelSigma2[kpUn.octave];
e->setInformation(Eigen::Matrix3d::Identity() * invSigma2);
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
g2o::RobustKernelHuber *rk = new g2o::RobustKernelHuber;
e->setRobustKernel(rk);
rk->setDelta(thHuberStereo);
2020-12-01 11:58:17 +08:00
optimizer.addEdge(e);
2022-07-21 21:32:11 +08:00
vpEdgesStereo.push_back(e);
vpEdgeKFStereo.push_back(pKFi);
vpMapPointEdgeStereo.push_back(pMP);
2020-12-01 11:58:17 +08:00
}
}
}
}
2022-07-21 22:27:32 +08:00
// 如果要停止就直接返回
2022-07-21 21:32:11 +08:00
if (pbStopFlag)
if (*pbStopFlag)
return;
2022-07-21 22:27:32 +08:00
// 8. 开始优化
2020-12-01 11:58:17 +08:00
optimizer.initializeOptimization();
2022-07-21 21:32:11 +08:00
optimizer.optimize(8);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 更具优化结果挑选删除外点
2022-07-21 21:32:11 +08:00
vector<pair<KeyFrame *, MapPoint *>> vToErase;
vToErase.reserve(vpEdgesMono.size() + vpEdgesStereo.size());
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Check inlier observations
// Mono
2022-07-21 22:27:32 +08:00
// 9. 处理外点
// 更具卡方检测来记录要删除的外点
2022-07-21 21:32:11 +08:00
for (size_t i = 0, iend = vpEdgesMono.size(); i < iend; i++)
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
EdgeMono *e = vpEdgesMono[i];
MapPoint *pMP = vpMapPointEdgeMono[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (e->chi2() > chi2Mono2)
{
KeyFrame *pKFi = vpEdgeKFMono[i];
vToErase.push_back(make_pair(pKFi, pMP));
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Stereo
for (size_t i = 0, iend = vpEdgesStereo.size(); i < iend; i++)
{
EdgeStereo *e = vpEdgesStereo[i];
MapPoint *pMP = vpMapPointEdgeStereo[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pMP->isBad())
continue;
if (e->chi2() > chi2Stereo2)
{
KeyFrame *pKFi = vpEdgeKFStereo[i];
vToErase.push_back(make_pair(pKFi, pMP));
}
2020-12-01 11:58:17 +08:00
}
2022-07-21 21:32:11 +08:00
// Get Map Mutex and erase outliers
2022-07-21 22:27:32 +08:00
// 移除外点
2022-07-21 21:32:11 +08:00
unique_lock<mutex> lock(pMap->mMutexMapUpdate);
if (!vToErase.empty())
2020-12-01 11:58:17 +08:00
{
2022-07-21 21:32:11 +08:00
for (size_t i = 0; i < vToErase.size(); i++)
{
KeyFrame *pKFi = vToErase[i].first;
MapPoint *pMPi = vToErase[i].second;
pKFi->EraseMapPointMatch(pMPi);
pMPi->EraseObservation(pKFi);
}
}
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
// Recover optimized data
2022-07-21 22:27:32 +08:00
// 10. 取数
// 根据优化的结果,修改每个被优化的变量
2022-07-21 21:32:11 +08:00
// Keyframes
2022-07-21 22:27:32 +08:00
// 对于每个可优化关键帧
2022-07-21 21:32:11 +08:00
for (int i = 0; i < N; i++)
{
KeyFrame *pKFi = vpOptimizableKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 修改位姿
2022-07-21 21:32:11 +08:00
VertexPose *VP = static_cast<VertexPose *>(optimizer.vertex(pKFi->mnId));
Sophus::SE3f Tcw(VP->estimate().Rcw[0].cast<float>(), VP->estimate().tcw[0].cast<float>());
pKFi->SetPose(Tcw);
2020-12-01 11:58:17 +08:00
2022-07-21 22:27:32 +08:00
// 在corrPoses记录每个关键帧融合后的位姿
2022-07-21 21:32:11 +08:00
Sophus::SE3d Tiw = pKFi->GetPose().cast<double>();
g2o::Sim3 g2oSiw(Tiw.unit_quaternion(), Tiw.translation(), 1.0);
corrPoses[pKFi] = g2oSiw;
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
if (pKFi->bImu)
{
2022-07-21 22:27:32 +08:00
// 速度
2022-07-21 21:32:11 +08:00
VertexVelocity *VV = static_cast<VertexVelocity *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 1));
2022-07-21 22:27:32 +08:00
// 修改速度
2022-07-21 21:32:11 +08:00
pKFi->SetVelocity(VV->estimate().cast<float>());
2022-07-21 22:27:32 +08:00
// 陀螺仪bias
2022-07-21 21:32:11 +08:00
VertexGyroBias *VG = static_cast<VertexGyroBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 2));
2022-07-21 22:27:32 +08:00
// 加速度bias
2022-07-21 21:32:11 +08:00
VertexAccBias *VA = static_cast<VertexAccBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 3));
Vector6d b;
2022-07-21 22:27:32 +08:00
// 修改bias
2022-07-21 21:32:11 +08:00
b << VG->estimate(), VA->estimate();
pKFi->SetNewBias(IMU::Bias(b[3], b[4], b[5], b[0], b[1], b[2]));
}
}
2022-07-21 22:27:32 +08:00
// 遍历所有的共视帧
2022-07-21 21:32:11 +08:00
for (int i = 0; i < Ncov; i++)
{
KeyFrame *pKFi = vpOptimizableCovKFs[i];
2020-12-01 11:58:17 +08:00
2022-07-21 21:32:11 +08:00
VertexPose *VP = static_cast<VertexPose *>(optimizer.vertex(pKFi->mnId));
Sophus::SE3f Tcw(VP->estimate().Rcw[0].cast<float>(), VP->estimate().tcw[0].cast<float>());
pKFi->SetPose(Tcw);
Sophus::SE3d Tiw = pKFi->GetPose().cast<double>();
g2o::Sim3 g2oSiw(Tiw.unit_quaternion(), Tiw.translation(), 1.0);
corrPoses[pKFi] = g2oSiw;
if (pKFi->bImu)
{
VertexVelocity *VV = static_cast<VertexVelocity *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 1));
pKFi->SetVelocity(VV->estimate().cast<float>());
VertexGyroBias *VG = static_cast<VertexGyroBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 2));
VertexAccBias *VA = static_cast<VertexAccBias *>(optimizer.vertex(maxKFid + 3 * (pKFi->mnId) + 3));
Vector6d b;
b << VG->estimate(), VA->estimate();
pKFi->SetNewBias(IMU::Bias(b[3], b[4], b[5], b[0], b[1], b[2]));
}
}
// Points
2022-07-21 22:27:32 +08:00
// 对于所有的地图点
2022-07-21 21:32:11 +08:00
for (list<MapPoint *>::iterator lit = lLocalMapPoints.begin(), lend = lLocalMapPoints.end(); lit != lend; lit++)
{
2022-07-21 22:27:32 +08:00
// 跟新位置和normal等信息
2022-07-21 21:32:11 +08:00
MapPoint *pMP = *lit;
g2o::VertexSBAPointXYZ *vPoint = static_cast<g2o::VertexSBAPointXYZ *>(optimizer.vertex(pMP->mnId + iniMPid + 1));
pMP->SetWorldPos(vPoint->estimate().cast<float>());
2020-12-01 11:58:17 +08:00
pMP->UpdateNormalAndDepth();
}
2022-07-21 21:32:11 +08:00
2020-12-01 11:58:17 +08:00
pMap->IncreaseChangeIndex();
}
2022-07-21 21:32:11 +08:00
} // namespace ORB_SLAM