test_eigen.cpp
Go to the documentation of this file.
1 /*
2  tests/eigen.cpp -- automatic conversion of Eigen types
3 
4  Copyright (c) 2016 Wenzel Jakob <wenzel.jakob@epfl.ch>
5 
6  All rights reserved. Use of this source code is governed by a
7  BSD-style license that can be found in the LICENSE file.
8 */
9 
10 #include "pybind11_tests.h"
11 #include "constructor_stats.h"
12 #include <pybind11/eigen.h>
13 #include <pybind11/stl.h>
14 
15 #if defined(_MSC_VER)
16 # pragma warning(disable: 4996) // C4996: std::unary_negation is deprecated
17 #endif
18 
19 #include <Eigen/Cholesky>
20 
22 
23 
24 
25 // Sets/resets a testing reference matrix to have values of 10*r + c, where r and c are the
26 // (1-based) row/column number.
27 template <typename M> void reset_ref(M &x) {
28  for (int i = 0; i < x.rows(); i++) for (int j = 0; j < x.cols(); j++)
29  x(i, j) = 11 + 10*i + j;
30 }
31 
32 // Returns a static, column-major matrix
33 Eigen::MatrixXd &get_cm() {
34  static Eigen::MatrixXd *x;
35  if (!x) {
36  x = new Eigen::MatrixXd(3, 3);
37  reset_ref(*x);
38  }
39  return *x;
40 }
41 // Likewise, but row-major
43  static MatrixXdR *x;
44  if (!x) {
45  x = new MatrixXdR(3, 3);
46  reset_ref(*x);
47  }
48  return *x;
49 }
50 // Resets the values of the static matrices returned by get_cm()/get_rm()
51 void reset_refs() {
52  reset_ref(get_cm());
53  reset_ref(get_rm());
54 }
55 
56 // Returns element 2,1 from a matrix (used to test copy/nocopy)
57 double get_elem(Eigen::Ref<const Eigen::MatrixXd> m) { return m(2, 1); };
58 
59 
60 // Returns a matrix with 10*r + 100*c added to each matrix element (to help test that the matrix
61 // reference is referencing rows/columns correctly).
62 template <typename MatrixArgType> Eigen::MatrixXd adjust_matrix(MatrixArgType m) {
63  Eigen::MatrixXd ret(m);
64  for (int c = 0; c < m.cols(); c++) for (int r = 0; r < m.rows(); r++)
65  ret(r, c) += 10*r + 100*c;
66  return ret;
67 }
68 
70  CustomOperatorNew() = default;
71 
72  Eigen::Matrix4d a = Eigen::Matrix4d::Zero();
73  Eigen::Matrix4d b = Eigen::Matrix4d::Identity();
74 
76 };
77 
78 TEST_SUBMODULE(eigen, m) {
80  using FixedMatrixC = Eigen::Matrix<float, 5, 6>;
83  using FourRowMatrixC = Eigen::Matrix<float, 4, Eigen::Dynamic>;
84  using FourColMatrixC = Eigen::Matrix<float, Eigen::Dynamic, 4>;
85  using FourRowMatrixR = Eigen::Matrix<float, 4, Eigen::Dynamic>;
86  using FourColMatrixR = Eigen::Matrix<float, Eigen::Dynamic, 4>;
87  using SparseMatrixR = Eigen::SparseMatrix<float, Eigen::RowMajor>;
88  using SparseMatrixC = Eigen::SparseMatrix<float>;
89 
90  // various tests
91  m.def("double_col", [](const Eigen::VectorXf &x) -> Eigen::VectorXf { return 2.0f * x; });
92  m.def("double_row", [](const Eigen::RowVectorXf &x) -> Eigen::RowVectorXf { return 2.0f * x; });
93  m.def("double_complex", [](const Eigen::VectorXcf &x) -> Eigen::VectorXcf { return 2.0f * x; });
94  m.def("double_threec", [](py::EigenDRef<Eigen::Vector3f> x) { x *= 2; });
95  m.def("double_threer", [](py::EigenDRef<Eigen::RowVector3f> x) { x *= 2; });
96  m.def("double_mat_cm", [](Eigen::MatrixXf x) -> Eigen::MatrixXf { return 2.0f * x; });
97  m.def("double_mat_rm", [](DenseMatrixR x) -> DenseMatrixR { return 2.0f * x; });
98 
99  // test_eigen_ref_to_python
100  // Different ways of passing via Eigen::Ref; the first and second are the Eigen-recommended
101  m.def("cholesky1", [](Eigen::Ref<MatrixXdR> x) -> Eigen::MatrixXd { return x.llt().matrixL(); });
102  m.def("cholesky2", [](const Eigen::Ref<const MatrixXdR> &x) -> Eigen::MatrixXd { return x.llt().matrixL(); });
103  m.def("cholesky3", [](const Eigen::Ref<MatrixXdR> &x) -> Eigen::MatrixXd { return x.llt().matrixL(); });
104  m.def("cholesky4", [](Eigen::Ref<const MatrixXdR> x) -> Eigen::MatrixXd { return x.llt().matrixL(); });
105 
106  // test_eigen_ref_mutators
107  // Mutators: these add some value to the given element using Eigen, but Eigen should be mapping into
108  // the numpy array data and so the result should show up there. There are three versions: one that
109  // works on a contiguous-row matrix (numpy's default), one for a contiguous-column matrix, and one
110  // for any matrix.
111  auto add_rm = [](Eigen::Ref<MatrixXdR> x, int r, int c, double v) { x(r,c) += v; };
112  auto add_cm = [](Eigen::Ref<Eigen::MatrixXd> x, int r, int c, double v) { x(r,c) += v; };
113 
114  // Mutators (Eigen maps into numpy variables):
115  m.def("add_rm", add_rm); // Only takes row-contiguous
116  m.def("add_cm", add_cm); // Only takes column-contiguous
117  // Overloaded versions that will accept either row or column contiguous:
118  m.def("add1", add_rm);
119  m.def("add1", add_cm);
120  m.def("add2", add_cm);
121  m.def("add2", add_rm);
122  // This one accepts a matrix of any stride:
123  m.def("add_any", [](py::EigenDRef<Eigen::MatrixXd> x, int r, int c, double v) { x(r,c) += v; });
124 
125  // Return mutable references (numpy maps into eigen variables)
126  m.def("get_cm_ref", []() { return Eigen::Ref<Eigen::MatrixXd>(get_cm()); });
127  m.def("get_rm_ref", []() { return Eigen::Ref<MatrixXdR>(get_rm()); });
128  // The same references, but non-mutable (numpy maps into eigen variables, but is !writeable)
129  m.def("get_cm_const_ref", []() { return Eigen::Ref<const Eigen::MatrixXd>(get_cm()); });
130  m.def("get_rm_const_ref", []() { return Eigen::Ref<const MatrixXdR>(get_rm()); });
131 
132  m.def("reset_refs", reset_refs); // Restores get_{cm,rm}_ref to original values
133 
134  // Increments and returns ref to (same) matrix
135  m.def("incr_matrix", [](Eigen::Ref<Eigen::MatrixXd> m, double v) {
136  m += Eigen::MatrixXd::Constant(m.rows(), m.cols(), v);
137  return m;
138  }, py::return_value_policy::reference);
139 
140  // Same, but accepts a matrix of any strides
141  m.def("incr_matrix_any", [](py::EigenDRef<Eigen::MatrixXd> m, double v) {
142  m += Eigen::MatrixXd::Constant(m.rows(), m.cols(), v);
143  return m;
144  }, py::return_value_policy::reference);
145 
146  // Returns an eigen slice of even rows
147  m.def("even_rows", [](py::EigenDRef<Eigen::MatrixXd> m) {
148  return py::EigenDMap<Eigen::MatrixXd>(
149  m.data(), (m.rows() + 1) / 2, m.cols(),
150  py::EigenDStride(m.outerStride(), 2 * m.innerStride()));
151  }, py::return_value_policy::reference);
152 
153  // Returns an eigen slice of even columns
154  m.def("even_cols", [](py::EigenDRef<Eigen::MatrixXd> m) {
155  return py::EigenDMap<Eigen::MatrixXd>(
156  m.data(), m.rows(), (m.cols() + 1) / 2,
157  py::EigenDStride(2 * m.outerStride(), m.innerStride()));
158  }, py::return_value_policy::reference);
159 
160  // Returns diagonals: a vector-like object with an inner stride != 1
161  m.def("diagonal", [](const Eigen::Ref<const Eigen::MatrixXd> &x) { return x.diagonal(); });
162  m.def("diagonal_1", [](const Eigen::Ref<const Eigen::MatrixXd> &x) { return x.diagonal<1>(); });
163  m.def("diagonal_n", [](const Eigen::Ref<const Eigen::MatrixXd> &x, int index) { return x.diagonal(index); });
164 
165  // Return a block of a matrix (gives non-standard strides)
166  m.def("block", [](const Eigen::Ref<const Eigen::MatrixXd> &x, int start_row, int start_col, int block_rows, int block_cols) {
167  return x.block(start_row, start_col, block_rows, block_cols);
168  });
169 
170  // test_eigen_return_references, test_eigen_keepalive
171  // return value referencing/copying tests:
172  class ReturnTester {
173  Eigen::MatrixXd mat = create();
174  public:
175  ReturnTester() { print_created(this); }
176  ~ReturnTester() { print_destroyed(this); }
177  static Eigen::MatrixXd create() { return Eigen::MatrixXd::Ones(10, 10); }
178  static const Eigen::MatrixXd createConst() { return Eigen::MatrixXd::Ones(10, 10); }
179  Eigen::MatrixXd &get() { return mat; }
180  Eigen::MatrixXd *getPtr() { return &mat; }
181  const Eigen::MatrixXd &view() { return mat; }
182  const Eigen::MatrixXd *viewPtr() { return &mat; }
183  Eigen::Ref<Eigen::MatrixXd> ref() { return mat; }
184  Eigen::Ref<const Eigen::MatrixXd> refConst() { return mat; }
185  Eigen::Block<Eigen::MatrixXd> block(int r, int c, int nrow, int ncol) { return mat.block(r, c, nrow, ncol); }
186  Eigen::Block<const Eigen::MatrixXd> blockConst(int r, int c, int nrow, int ncol) const { return mat.block(r, c, nrow, ncol); }
187  py::EigenDMap<Eigen::Matrix2d> corners() { return py::EigenDMap<Eigen::Matrix2d>(mat.data(),
188  py::EigenDStride(mat.outerStride() * (mat.outerSize()-1), mat.innerStride() * (mat.innerSize()-1))); }
189  py::EigenDMap<const Eigen::Matrix2d> cornersConst() const { return py::EigenDMap<const Eigen::Matrix2d>(mat.data(),
190  py::EigenDStride(mat.outerStride() * (mat.outerSize()-1), mat.innerStride() * (mat.innerSize()-1))); }
191  };
192  using rvp = py::return_value_policy;
193  py::class_<ReturnTester>(m, "ReturnTester")
194  .def(py::init<>())
195  .def_static("create", &ReturnTester::create)
196  .def_static("create_const", &ReturnTester::createConst)
197  .def("get", &ReturnTester::get, rvp::reference_internal)
198  .def("get_ptr", &ReturnTester::getPtr, rvp::reference_internal)
199  .def("view", &ReturnTester::view, rvp::reference_internal)
200  .def("view_ptr", &ReturnTester::view, rvp::reference_internal)
201  .def("copy_get", &ReturnTester::get) // Default rvp: copy
202  .def("copy_view", &ReturnTester::view) // "
203  .def("ref", &ReturnTester::ref) // Default for Ref is to reference
204  .def("ref_const", &ReturnTester::refConst) // Likewise, but const
205  .def("ref_safe", &ReturnTester::ref, rvp::reference_internal)
206  .def("ref_const_safe", &ReturnTester::refConst, rvp::reference_internal)
207  .def("copy_ref", &ReturnTester::ref, rvp::copy)
208  .def("copy_ref_const", &ReturnTester::refConst, rvp::copy)
209  .def("block", &ReturnTester::block)
210  .def("block_safe", &ReturnTester::block, rvp::reference_internal)
211  .def("block_const", &ReturnTester::blockConst, rvp::reference_internal)
212  .def("copy_block", &ReturnTester::block, rvp::copy)
213  .def("corners", &ReturnTester::corners, rvp::reference_internal)
214  .def("corners_const", &ReturnTester::cornersConst, rvp::reference_internal)
215  ;
216 
217  // test_special_matrix_objects
218  // Returns a DiagonalMatrix with diagonal (1,2,3,...)
219  m.def("incr_diag", [](int k) {
221  for (int i = 0; i < k; i++) m.diagonal()[i] = i+1;
222  return m;
223  });
224 
225  // Returns a SelfAdjointView referencing the lower triangle of m
226  m.def("symmetric_lower", [](const Eigen::MatrixXi &m) {
227  return m.selfadjointView<Eigen::Lower>();
228  });
229  // Returns a SelfAdjointView referencing the lower triangle of m
230  m.def("symmetric_upper", [](const Eigen::MatrixXi &m) {
231  return m.selfadjointView<Eigen::Upper>();
232  });
233 
234  // Test matrix for various functions below.
235  Eigen::MatrixXf mat(5, 6);
236  mat << 0, 3, 0, 0, 0, 11,
237  22, 0, 0, 0, 17, 11,
238  7, 5, 0, 1, 0, 11,
239  0, 0, 0, 0, 0, 11,
240  0, 0, 14, 0, 8, 11;
241 
242  // test_fixed, and various other tests
243  m.def("fixed_r", [mat]() -> FixedMatrixR { return FixedMatrixR(mat); });
244  m.def("fixed_r_const", [mat]() -> const FixedMatrixR { return FixedMatrixR(mat); });
245  m.def("fixed_c", [mat]() -> FixedMatrixC { return FixedMatrixC(mat); });
246  m.def("fixed_copy_r", [](const FixedMatrixR &m) -> FixedMatrixR { return m; });
247  m.def("fixed_copy_c", [](const FixedMatrixC &m) -> FixedMatrixC { return m; });
248  // test_mutator_descriptors
249  m.def("fixed_mutator_r", [](Eigen::Ref<FixedMatrixR>) {});
250  m.def("fixed_mutator_c", [](Eigen::Ref<FixedMatrixC>) {});
251  m.def("fixed_mutator_a", [](py::EigenDRef<FixedMatrixC>) {});
252  // test_dense
253  m.def("dense_r", [mat]() -> DenseMatrixR { return DenseMatrixR(mat); });
254  m.def("dense_c", [mat]() -> DenseMatrixC { return DenseMatrixC(mat); });
255  m.def("dense_copy_r", [](const DenseMatrixR &m) -> DenseMatrixR { return m; });
256  m.def("dense_copy_c", [](const DenseMatrixC &m) -> DenseMatrixC { return m; });
257  // test_sparse, test_sparse_signature
258  m.def("sparse_r", [mat]() -> SparseMatrixR { return Eigen::SparseView<Eigen::MatrixXf>(mat); });
259  m.def("sparse_c", [mat]() -> SparseMatrixC { return Eigen::SparseView<Eigen::MatrixXf>(mat); });
260  m.def("sparse_copy_r", [](const SparseMatrixR &m) -> SparseMatrixR { return m; });
261  m.def("sparse_copy_c", [](const SparseMatrixC &m) -> SparseMatrixC { return m; });
262  // test_partially_fixed
263  m.def("partial_copy_four_rm_r", [](const FourRowMatrixR &m) -> FourRowMatrixR { return m; });
264  m.def("partial_copy_four_rm_c", [](const FourColMatrixR &m) -> FourColMatrixR { return m; });
265  m.def("partial_copy_four_cm_r", [](const FourRowMatrixC &m) -> FourRowMatrixC { return m; });
266  m.def("partial_copy_four_cm_c", [](const FourColMatrixC &m) -> FourColMatrixC { return m; });
267 
268  // test_cpp_casting
269  // Test that we can cast a numpy object to a Eigen::MatrixXd explicitly
270  m.def("cpp_copy", [](py::handle m) { return m.cast<Eigen::MatrixXd>()(1, 0); });
271  m.def("cpp_ref_c", [](py::handle m) { return m.cast<Eigen::Ref<Eigen::MatrixXd>>()(1, 0); });
272  m.def("cpp_ref_r", [](py::handle m) { return m.cast<Eigen::Ref<MatrixXdR>>()(1, 0); });
273  m.def("cpp_ref_any", [](py::handle m) { return m.cast<py::EigenDRef<Eigen::MatrixXd>>()(1, 0); });
274 
275 
276  // test_nocopy_wrapper
277  // Test that we can prevent copying into an argument that would normally copy: First a version
278  // that would allow copying (if types or strides don't match) for comparison:
279  m.def("get_elem", &get_elem);
280  // Now this alternative that calls the tells pybind to fail rather than copy:
281  m.def("get_elem_nocopy", [](Eigen::Ref<const Eigen::MatrixXd> m) -> double { return get_elem(m); },
282  py::arg().noconvert());
283  // Also test a row-major-only no-copy const ref:
284  m.def("get_elem_rm_nocopy", [](Eigen::Ref<const Eigen::Matrix<long, -1, -1, Eigen::RowMajor>> &m) -> long { return m(2, 1); },
285  py::arg().noconvert());
286 
287  // test_issue738
288  // Issue #738: 1xN or Nx1 2D matrices were neither accepted nor properly copied with an
289  // incompatible stride value on the length-1 dimension--but that should be allowed (without
290  // requiring a copy!) because the stride value can be safely ignored on a size-1 dimension.
291  m.def("iss738_f1", &adjust_matrix<const Eigen::Ref<const Eigen::MatrixXd> &>, py::arg().noconvert());
292  m.def("iss738_f2", &adjust_matrix<const Eigen::Ref<const Eigen::Matrix<double, -1, -1, Eigen::RowMajor>> &>, py::arg().noconvert());
293 
294  // test_issue1105
295  // Issue #1105: when converting from a numpy two-dimensional (Nx1) or (1xN) value into a dense
296  // eigen Vector or RowVector, the argument would fail to load because the numpy copy would fail:
297  // numpy won't broadcast a Nx1 into a 1-dimensional vector.
298  m.def("iss1105_col", [](Eigen::VectorXd) { return true; });
299  m.def("iss1105_row", [](Eigen::RowVectorXd) { return true; });
300 
301  // test_named_arguments
302  // Make sure named arguments are working properly:
303  m.def("matrix_multiply", [](const py::EigenDRef<const Eigen::MatrixXd> A, const py::EigenDRef<const Eigen::MatrixXd> B)
304  -> Eigen::MatrixXd {
305  if (A.cols() != B.rows()) throw std::domain_error("Nonconformable matrices!");
306  return A * B;
307  }, py::arg("A"), py::arg("B"));
308 
309  // test_custom_operator_new
310  py::class_<CustomOperatorNew>(m, "CustomOperatorNew")
311  .def(py::init<>())
312  .def_readonly("a", &CustomOperatorNew::a)
313  .def_readonly("b", &CustomOperatorNew::b);
314 
315  // test_eigen_ref_life_support
316  // In case of a failure (the caster's temp array does not live long enough), creating
317  // a new array (np.ones(10)) increases the chances that the temp array will be garbage
318  // collected and/or that its memory will be overridden with different values.
319  m.def("get_elem_direct", [](Eigen::Ref<const Eigen::VectorXd> v) {
320  py::module::import("numpy").attr("ones")(10);
321  return v(5);
322  });
323  m.def("get_elem_indirect", [](std::vector<Eigen::Ref<const Eigen::VectorXd>> v) {
324  py::module::import("numpy").attr("ones")(10);
325  return v[0](5);
326  });
327 }
Matrix3f m
double get_elem(Eigen::Ref< const Eigen::MatrixXd > m)
Definition: test_eigen.cpp:57
Matrix< RealScalar, Dynamic, Dynamic > M
Definition: bench_gemm.cpp:38
MatrixXdR & get_rm()
Definition: test_eigen.cpp:42
m m block(1, 0, 2, 2)<< 4
Eigen::Stride< Eigen::Dynamic, Eigen::Dynamic > EigenDStride
A versatible sparse matrix representation.
Definition: SparseMatrix.h:96
Eigen::Matrix< double, Eigen::Dynamic, Eigen::Dynamic, Eigen::RowMajor > MatrixXdR
Definition: test_eigen.cpp:21
ArrayXcf v
Definition: Cwise_arg.cpp:1
Scalar Scalar * c
Definition: benchVecAdd.cpp:17
void print_destroyed(T *inst, Values &&...values)
set noclip points set clip one set noclip two set bar set border lt lw set xdata set ydata set zdata set x2data set y2data set boxwidth set dummy y set format x g set format y g set format x2 g set format y2 g set format z g set angles radians set nogrid set key title set key left top Right noreverse box linetype linewidth samplen spacing width set nolabel set noarrow set nologscale set logscale x set set pointsize set encoding default set nopolar set noparametric set view
Represents a diagonal matrix with its storage.
Eigen::MatrixXd & get_cm()
Definition: test_eigen.cpp:33
CustomOperatorNew()=default
EIGEN_DEVICE_FUNC const DiagonalVectorType & diagonal() const
Expression of a dense or sparse matrix with zero or too small values removed.
A matrix or vector expression mapping an existing expression.
Definition: Ref.h:192
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE const ArgReturnType arg() const
TEST_SUBMODULE(eigen, m)
Definition: test_eigen.cpp:78
ADT create(const Signature &signature)
Expression of a fixed-size or dynamic-size block.
Definition: Block.h:103
DenseIndex ret
Definition: level1_impl.h:59
void print_created(T *inst, Values &&...values)
void corners(const MatrixType &m)
Definition: corners.cpp:16
void reset_ref(M &x)
Definition: test_eigen.cpp:27
Eigen::MatrixXd adjust_matrix(MatrixArgType m)
Definition: test_eigen.cpp:62
int EIGEN_BLAS_FUNC() copy(int *n, RealScalar *px, int *incx, RealScalar *py, int *incy)
Definition: level1_impl.h:29
Eigen::Matrix4d a
Definition: test_eigen.cpp:72
Eigen::Matrix4d b
Definition: test_eigen.cpp:73
Container::iterator get(Container &c, Position position)
The matrix class, also used for vectors and row-vectors.
set noclip points set clip one set noclip two set bar set border lt lw set xdata set ydata set zdata set x2data set y2data set boxwidth set dummy x
return_value_policy
Approach used to cast a previously unknown C++ instance into a Python object.
void reset_refs()
Definition: test_eigen.cpp:51
std::ptrdiff_t j


gtsam
Author(s):
autogenerated on Sat May 8 2021 02:46:03