gtsam/cpp/GaussianFactor.cpp

423 lines
13 KiB
C++
Raw Normal View History

2009-08-22 06:23:24 +08:00
/**
* @file GaussianFactor.cpp
2009-08-22 06:23:24 +08:00
* @brief Linear Factor....A Gaussian
* @brief linearFactor
* @author Christian Potthast
*/
#include <boost/foreach.hpp>
#include <boost/assign/list_inserter.hpp> // for 'insert()'
#include <boost/assign/std/list.hpp> // for operator += in Ordering
#include "Matrix.h"
#include "Ordering.h"
#include "GaussianConditional.h"
#include "GaussianFactor.h"
2009-08-22 06:23:24 +08:00
using namespace std;
using namespace boost::assign;
2009-08-22 06:23:24 +08:00
namespace ublas = boost::numeric::ublas;
// trick from some reading group
#define FOREACH_PAIR( KEY, VAL, COL) BOOST_FOREACH (boost::tie(KEY,VAL),COL)
using namespace gtsam;
typedef pair<const string, Matrix>& mypair;
/* ************************************************************************* */
GaussianFactor::GaussianFactor(const boost::shared_ptr<GaussianConditional>& cg) :
b_(cg->get_d()) {
As_.insert(make_pair(cg->key(), cg->get_R()));
std::map<std::string, Matrix>::const_iterator it = cg->parentsBegin();
for (; it != cg->parentsEnd(); it++) {
const std::string& j = it->first;
const Matrix& Aj = it->second;
As_.insert(make_pair(j, Aj));
}
// set sigmas from precisions
size_t n = b_.size();
2009-11-05 14:59:59 +08:00
sigmas_ = cg->get_sigmas();
}
2009-08-22 06:23:24 +08:00
/* ************************************************************************* */
GaussianFactor::GaussianFactor(const vector<shared_ptr> & factors)
{
bool verbose = false;
if (verbose) cout << "GaussianFactor::GaussianFactor (factors)" << endl;
2009-11-05 14:59:59 +08:00
// Create RHS and sigmas of right size by adding together row counts
size_t m = 0;
BOOST_FOREACH(shared_ptr factor, factors) m += factor->numberOfRows();
b_ = Vector(m);
sigmas_ = Vector(m);
size_t pos = 0; // save last position inserted into the new rhs vector
// iterate over all factors
BOOST_FOREACH(shared_ptr factor, factors){
if (verbose) factor->print();
// number of rows for factor f
const size_t mf = factor->numberOfRows();
// copy the rhs vector from factor to b
const Vector bf = factor->get_b();
for (size_t i=0; i<mf; i++) b_(pos+i) = bf(i);
2009-11-05 14:59:59 +08:00
// copy the sigmas_
for (size_t i=0; i<mf; i++) sigmas_(pos+i) = factor->sigmas_(i);
// update the matrices
append_factor(factor,m,pos);
pos += mf;
}
if (verbose) cout << "GaussianFactor::GaussianFactor done" << endl;
2009-08-22 06:23:24 +08:00
}
/* ************************************************************************* */
void GaussianFactor::print(const string& s) const {
2009-08-22 06:23:24 +08:00
cout << s << endl;
if (empty()) cout << " empty" << endl;
else {
string j; Matrix A;
FOREACH_PAIR(j,A,As_) gtsam::print(A, "A["+j+"]=\n");
gtsam::print(b_,"b=");
gtsam::print(sigmas_, "sigmas = ");
2009-08-22 06:23:24 +08:00
}
}
/* ************************************************************************* */
size_t GaussianFactor::getDim(const std::string& key) const {
const_iterator it = As_.find(key);
if (it != As_.end())
return it->second.size2();
else
return 0;
}
2009-08-22 06:23:24 +08:00
/* ************************************************************************* */
// Check if two linear factors are equal
bool GaussianFactor::equals(const Factor<VectorConfig>& f, double tol) const {
2009-08-22 06:23:24 +08:00
const GaussianFactor* lf = dynamic_cast<const GaussianFactor*>(&f);
if (lf == NULL) return false;
2009-08-22 06:23:24 +08:00
if (empty()) return (lf->empty());
2009-08-22 06:23:24 +08:00
const_iterator it1 = As_.begin(), it2 = lf->As_.begin();
if(As_.size() != lf->As_.size()) return false;
2009-08-22 06:23:24 +08:00
for(; it1 != As_.end(); it1++, it2++) {
2009-08-22 06:23:24 +08:00
const string& j1 = it1->first, j2 = it2->first;
const Matrix A1 = it1->second, A2 = it2->second;
if (j1 != j2) return false;
if (!equal_with_abs_tol(A1,A2,tol))
return false;
2009-08-22 06:23:24 +08:00
}
if( !(::equal_with_abs_tol(b_, (lf->b_),tol)) )
return false;
if( !(::equal_with_abs_tol(sigmas_, (lf->sigmas_),tol)) )
return false;
2009-08-22 06:23:24 +08:00
return true;
}
2009-08-22 06:23:24 +08:00
/* ************************************************************************* */
2009-12-12 02:03:43 +08:00
Vector GaussianFactor::unweighted_error(const VectorConfig& c) const {
2009-12-12 01:42:54 +08:00
Vector e = -b_;
if (empty()) return e;
string j; Matrix Aj;
FOREACH_PAIR(j, Aj, As_)
e += (Aj * c[j]);
2009-12-12 02:03:43 +08:00
return e;
}
/* ************************************************************************* */
Vector GaussianFactor::error_vector(const VectorConfig& c) const {
2009-12-31 18:30:06 +08:00
if (empty()) return (-b_);
return ediv_(unweighted_error(c),sigmas_);
2009-12-12 01:42:54 +08:00
}
/* ************************************************************************* */
double GaussianFactor::error(const VectorConfig& c) const {
if (empty()) return 0;
Vector weighted = error_vector(c);
return 0.5 * inner_prod(weighted,weighted);
2009-08-22 06:23:24 +08:00
}
2009-09-12 11:50:44 +08:00
/* ************************************************************************* */
list<string> GaussianFactor::keys() const {
list<string> result;
2009-09-12 11:50:44 +08:00
string j; Matrix A;
FOREACH_PAIR(j,A,As_)
result.push_back(j);
2009-09-12 11:50:44 +08:00
return result;
}
2009-08-22 06:23:24 +08:00
/* ************************************************************************* */
Dimensions GaussianFactor::dimensions() const {
Dimensions result;
2009-08-22 06:23:24 +08:00
string j; Matrix A;
FOREACH_PAIR(j,A,As_)
result.insert(make_pair(j,A.size2()));
2009-08-22 06:23:24 +08:00
return result;
}
/* ************************************************************************* */
void GaussianFactor::tally_separator(const string& key, set<string>& separator) const {
2009-08-22 06:23:24 +08:00
if(involves(key)) {
string j; Matrix A;
FOREACH_PAIR(j,A,As_)
2009-08-22 06:23:24 +08:00
if(j != key) separator.insert(j);
}
}
/* ************************************************************************* */
Vector GaussianFactor::operator*(const VectorConfig& x) const {
Vector Ax = zero(b_.size());
if (empty()) return Ax;
// Just iterate over all A matrices and multiply in correct config part
string j; Matrix Aj;
FOREACH_PAIR(j, Aj, As_)
Ax += (Aj * x[j]);
2009-12-31 18:30:06 +08:00
return ediv_(Ax,sigmas_);
}
/* ************************************************************************* */
VectorConfig GaussianFactor::operator^(const Vector& e) const {
2009-12-31 18:30:06 +08:00
Vector E = ediv_(e,sigmas_);
VectorConfig x;
// Just iterate over all A matrices and insert Ai^e into VectorConfig
string j; Matrix Aj;
FOREACH_PAIR(j, Aj, As_)
x.insert(j,Aj^E);
return x;
}
2009-08-22 06:23:24 +08:00
/* ************************************************************************* */
pair<Matrix,Vector> GaussianFactor::matrix(const Ordering& ordering, bool weight) const {
2009-08-22 06:23:24 +08:00
// get pointers to the matrices
vector<const Matrix *> matrices;
BOOST_FOREACH(string j, ordering) {
const Matrix& Aj = get_A(j);
matrices.push_back(&Aj);
}
2009-08-22 06:23:24 +08:00
// assemble
Matrix A = collect(matrices);
Vector b(b_);
// divide in sigma so error is indeed 0.5*|Ax-b|
if (weight) {
Vector t = ediv(ones(sigmas_.size()),sigmas_);
A = vector_scale(t, A);
for (int i=0; i<b_.size(); ++i)
b(i) *= t(i);
}
return make_pair(A, b);
2009-08-22 06:23:24 +08:00
}
/* ************************************************************************* */
Matrix GaussianFactor::matrix_augmented(const Ordering& ordering) const {
// get pointers to the matrices
vector<const Matrix *> matrices;
BOOST_FOREACH(string j, ordering) {
const Matrix& Aj = get_A(j);
matrices.push_back(&Aj);
}
// load b into a matrix
Matrix B_mat(numberOfRows(), 1);
for (int i=0; i<b_.size(); ++i)
B_mat(i,0) = b_(i);
matrices.push_back(&B_mat);
return collect(matrices);
}
/* ************************************************************************* */
boost::tuple<list<int>, list<int>, list<double> >
2009-12-12 14:18:29 +08:00
GaussianFactor::sparse(const Dimensions& columnIndices) const {
// declare return values
list<int> I,J;
list<double> S;
2009-12-12 14:18:29 +08:00
// iterate over all matrices in the factor
string key; Matrix Aj;
FOREACH_PAIR( key, Aj, As_) {
// find first column index for this key
// TODO: check if end() and throw exception if not found
2009-12-12 14:18:29 +08:00
Dimensions::const_iterator it = columnIndices.find(key);
int column_start = it->second;
for (size_t i = 0; i < Aj.size1(); i++) {
double sigma_i = sigmas_(i);
for (size_t j = 0; j < Aj.size2(); j++)
if (Aj(i, j) != 0.0) {
I.push_back(i + 1);
J.push_back(j + column_start);
S.push_back(Aj(i, j) / sigma_i);
}
}
}
// return the result
return boost::tuple<list<int>, list<int>, list<double> >(I,J,S);
}
2009-08-22 06:23:24 +08:00
/* ************************************************************************* */
void GaussianFactor::append_factor(GaussianFactor::shared_ptr f, size_t m, size_t pos) {
2009-10-24 12:07:32 +08:00
// iterate over all matrices from the factor f
string key; Matrix A;
FOREACH_PAIR( key, A, f->As_) {
2009-10-24 12:07:32 +08:00
// find the corresponding matrix among As
iterator mine = As_.find(key);
const bool exists = mine != As_.end();
2009-10-24 12:07:32 +08:00
// find rows and columns
const size_t n = A.size2();
// use existing or create new matrix
if (exists)
copy(A.data().begin(), A.data().end(), (mine->second).data().begin()+pos*n);
else {
Matrix Z = zeros(m, n);
copy(A.data().begin(), A.data().end(), Z.data().begin()+pos*n);
insert(key, Z);
}
} // FOREACH
2009-08-22 06:23:24 +08:00
}
/* ************************************************************************* */
/* Note, in place !!!!
* Do incomplete QR factorization for the first n columns
* We will do QR on all matrices and on RHS
* Then take first n rows and make a GaussianConditional,
2009-08-22 06:23:24 +08:00
* and last rows to make a new joint linear factor on separator
*/
/* ************************************************************************* */
pair<GaussianConditional::shared_ptr, GaussianFactor::shared_ptr>
GaussianFactor::eliminate(const string& key) const
2009-08-22 06:23:24 +08:00
{
bool verbose = false;
if (verbose) cout << "GaussianFactor::eliminate(" << key << ")" << endl;
// if this factor does not involve key, we exit with empty CG and LF
2009-11-12 12:53:28 +08:00
const_iterator it = As_.find(key);
if (it==As_.end()) {
// Conditional Gaussian is just a parent-less node with P(x)=1
GaussianFactor::shared_ptr lf(new GaussianFactor);
GaussianConditional::shared_ptr cg(new GaussianConditional(key));
return make_pair(cg,lf);
}
// create an internal ordering that eliminates key first
Ordering ordering;
ordering += key;
BOOST_FOREACH(string k, keys())
if (k != key) ordering += k;
// extract A, b from the combined linear factor (ensure that x is leading)
Matrix A; Vector b;
boost::tie(A, b) = matrix(ordering, false);
size_t n = A.size2();
// Do in-place QR to get R, d of the augmented system
2009-11-13 14:13:58 +08:00
if (verbose) ::print(A,"A");
if (verbose) ::print(b,"b = ");
if (verbose) ::print(sigmas_,"sigmas = ");
std::list<boost::tuple<Vector, double, double> > solution =
weighted_eliminate(A, b, sigmas_);
// get dimensions of the eliminated variable
size_t n1 = getDim(key);
// if m<n1, this factor cannot be eliminated
size_t maxRank = solution.size();
if (maxRank<n1)
throw(domain_error("GaussianFactor::eliminate: fewer constraints than unknowns"));
// unpack the solutions
Matrix R(maxRank, n);
Vector r, d(maxRank), newSigmas(maxRank); double di, sigma;
Matrix::iterator2 Rit = R.begin2();
size_t i = 0;
BOOST_FOREACH(boost::tie(r, di, sigma), solution) {
copy(r.begin(), r.end(), Rit); // copy r vector
d(i) = di; // copy in rhs
newSigmas(i) = sigma; // copy in new sigmas
Rit += n; i += 1;
}
// create base conditional Gaussian
2009-11-13 14:13:58 +08:00
GaussianConditional::shared_ptr conditional(new GaussianConditional(key,
sub(d, 0, n1), // form d vector
sub(R, 0, n1, 0, n1), // form R matrix
sub(newSigmas, 0, n1))); // get standard deviations
// extract the block matrices for parents in both CG and LF
2009-11-13 14:13:58 +08:00
GaussianFactor::shared_ptr factor(new GaussianFactor);
size_t j = n1;
BOOST_FOREACH(string cur_key, ordering)
if (cur_key!=key) {
size_t dim = getDim(cur_key);
2009-11-13 14:13:58 +08:00
conditional->add(cur_key, sub(R, 0, n1, j, j+dim));
factor->insert(cur_key, sub(R, n1, maxRank, j, j+dim));
j+=dim;
}
// Set sigmas
2009-11-13 14:13:58 +08:00
factor->sigmas_ = sub(newSigmas,n1,maxRank);
// extract ds vector for the new b
2009-11-13 14:13:58 +08:00
factor->set_b(sub(d, n1, maxRank));
if (verbose) conditional->print("Conditional");
if (verbose) factor->print("Factor");
2009-11-13 14:13:58 +08:00
return make_pair(conditional, factor);
2009-08-22 06:23:24 +08:00
}
/* ************************************************************************* */
// Creates a factor on step-size, given initial estimate and direction d, e.g.
// Factor |A1*x+A2*y-b|/sigma -> |A1*(x0+alpha*dx)+A2*(y0+alpha*dy)-b|/sigma
// -> |(A1*dx+A2*dy)*alpha-(b-A1*x0-A2*y0)|/sigma
/* ************************************************************************* */
GaussianFactor::shared_ptr GaussianFactor::alphaFactor(const VectorConfig& x,
const VectorConfig& d) const {
2009-12-12 02:03:43 +08:00
// Calculate A matrix
size_t m = b_.size();
2009-12-12 02:03:43 +08:00
Vector A = zero(m);
string j; Matrix Aj;
2009-12-12 02:03:43 +08:00
FOREACH_PAIR(j, Aj, As_)
A += Aj * d[j];
2009-12-12 02:03:43 +08:00
// calculate the value of the factor for RHS
Vector b = - unweighted_error(x);
// construct factor
shared_ptr factor(new GaussianFactor("alpha",Matrix_(A),b,sigmas_));
return factor;
}
2009-08-22 06:23:24 +08:00
/* ************************************************************************* */
namespace gtsam {
string symbol(char c, int index) {
stringstream ss;
ss << c << index;
return ss.str();
}
}
/* ************************************************************************* */