LSSTApplications  10.0+286,10.0+36,10.0+46,10.0-2-g4f67435,10.1+152,10.1+37,11.0,11.0+1,11.0-1-g47edd16,11.0-1-g60db491,11.0-1-g7418c06,11.0-2-g04d2804,11.0-2-g68503cd,11.0-2-g818369d,11.0-2-gb8b8ce7
LSSTDataManagementBasePackage
Namespaces | Macros | Typedefs
MyMatrix.h File Reference
#include "Eigen/Core"
#include "Eigen/QR"
#include "Eigen/SVD"
#include "Eigen/LU"
#include "Eigen/Cholesky"

Go to the source code of this file.

Namespaces

 lsst
 Estimate image backgrounds.
 
 lsst::meas
 
 lsst::meas::algorithms
 
 lsst::meas::algorithms::shapelet
 

Macros

#define TVector(T)   Eigen::Matrix<T,Eigen::Dynamic,1>
 
#define TVectorView(T)   Eigen::Block<TVector(T) >
 
#define TConstVectorView(T)   const Eigen::Block<TVector(T) >
 
#define TMatrix(T)   Eigen::Matrix<T,Eigen::Dynamic,Eigen::Dynamic>
 
#define TMatrixView(T)   Eigen::Block<TMatrix(T) >
 
#define TConstMatrixView(T)   const Eigen::Block<TMatrix(T) >
 
#define TMV_rowsize()   cols()
 
#define TMV_colsize()   rows()
 
#define TMV_cref(i, j)   coeff(i,j)
 
#define TMV_ref(i, j)   coeffRef(i,j)
 
#define TMV_diag()   diagonal()
 
#define EIGEN_diag()   diagonal().array()
 
#define EIGEN_asDiag()   .asDiagonal()
 
#define TMV_setToIdentity()   setIdentity()
 
#define TMV_subVector(i1, i2)   segment(i1,((i2)-(i1)))
 
#define TMV_subMatrix(i1, i2, j1, j2)   block(i1,j1,((i2)-(i1)),((j2)-(j1)))
 
#define TMV_realPart()   real()
 
#define TMV_imagPart()   imag()
 
#define TMV_normSq()   squaredNorm()
 
#define TMV_normInf()   lpNorm<Eigen::Infinity>()
 
#define TMV_maxAbsElement()   array().abs().maxCoeff()
 
#define TMV_addToAll(x)   array() += (x)
 
#define TMV_setAllTo(x)   setConstant(x)
 
#define TMV_colpart(j, i1, i2)   col(j).segment(i1,i2)
 
#define TMV_rowpart(i, j1, j2)   row(i).segment(j1,j2)
 
#define TMV_diagpart(i, j1, j2)   diagonal().segment(j1,j2)
 
#define TMV_det()   determinant()
 
#define TMV_transposeSelf()   transposeInPlace()
 
#define TMV_sumElements()   sum()
 
#define TMV_view(m)   (m).block(0,0,(m).rows(),(m).cols())
 
#define TMV_vview(v)   (v).segment(0,(v).size())
 
#define TMV_colRange(m, j1, j2)   (m).block(0,j1,(m).rows(),((j2)-(j1)))
 
#define TMV_rowRange(m, i1, i2)   (m).block(i1,0,((i2)-(i1)),(m).cols())
 
#define TMV_ptr(m)   &((m).coeffRef(0,0))
 
#define TMV_cptr(m)   &((m).coeff(0,0))
 
#define TMV_stepi(m)   ((m).rowStride())
 
#define TMV_stepj(m)   ((m).colStride())
 
#define TMV_DiagMatrixViewOf(v)   (v).asDiagonal()
 
#define TMV_conjugateSelf(m)   (m) = (m).conjugate()
 
#define EIGEN_Transpose(m)   (m).transpose()
 
#define EIGEN_ToScalar(m)   (m)(0,0)
 
#define TMV_NormInf(m)   (m).lpNorm<Eigen::Infinity>()
 
#define TMV_Norm(m)   (m).norm()
 
#define TMV_const
 
#define EIGEN_mutable   mutable
 
#define EIGEN_twice(x)   x,x
 
#define TMV_QR(m)   Eigen::ColPivHouseholderQR<DMatrix> QR_Solver_ ## m = (m).colPivHouseholderQr();
 
#define TMV_QR1(m)
 
#define TMV_QR2(m)   Eigen::ColPivHouseholderQR<DMatrix> QR_Solver_ ## m = (m).colPivHouseholderQr();
 
#define TMV_QRisSingular(m)   QR_Solver_ ## m .isInjective()
 
#define TMV_QR_Solve(m, x, b)   (x) = QR_Solver_ ## m .solve(b);
 
#define TMV_throwSingular   throw std::runtime_error("Singular")
 
#define TMV_QR_InverseATA(m, cov)
 

Typedefs

typedef Eigen::VectorXd lsst::meas::algorithms::shapelet::DVector
 
typedef Eigen::Block< DVector,
Eigen::Dynamic, 1 > 
lsst::meas::algorithms::shapelet::DVectorView
 
typedef const DVectorView lsst::meas::algorithms::shapelet::DConstVectorView
 
typedef Eigen::MatrixXd lsst::meas::algorithms::shapelet::DMatrix
 
typedef Eigen::Block< DMatrix > lsst::meas::algorithms::shapelet::DMatrixView
 
typedef const DMatrixView lsst::meas::algorithms::shapelet::DConstMatrixView
 
typedef Eigen::Matrix< double, 2, 2 > lsst::meas::algorithms::shapelet::DSmallMatrix22
 
typedef Eigen::RowVectorXd lsst::meas::algorithms::shapelet::DRowVector
 
typedef Eigen::MatrixXd lsst::meas::algorithms::shapelet::DBandMatrix
 
typedef Eigen::VectorXcd lsst::meas::algorithms::shapelet::CDVector
 
typedef Eigen::Block< CDVector,
Eigen::Dynamic, 1 > 
lsst::meas::algorithms::shapelet::CDVectorView
 
typedef const CDVectorView lsst::meas::algorithms::shapelet::CDConstVectorView
 
typedef Eigen::MatrixXcd lsst::meas::algorithms::shapelet::CDMatrix
 
typedef Eigen::Block< CDMatrix > lsst::meas::algorithms::shapelet::CDMatrixView
 
typedef const CDMatrixView lsst::meas::algorithms::shapelet::CDConstMatrixView
 
typedef Eigen::VectorXf lsst::meas::algorithms::shapelet::FVector
 
typedef Eigen::Block< FVector,
Eigen::Dynamic, 1 > 
lsst::meas::algorithms::shapelet::FVectorView
 
typedef const FVectorView lsst::meas::algorithms::shapelet::FConstVectorView
 
typedef Eigen::MatrixXf lsst::meas::algorithms::shapelet::FMatrix
 
typedef Eigen::Block< FMatrix > lsst::meas::algorithms::shapelet::FMatrixView
 
typedef const FMatrixView lsst::meas::algorithms::shapelet::FConstMatrixView
 
typedef Eigen::Matrix< float, 2, 2 > lsst::meas::algorithms::shapelet::FSmallMatrix22
 
typedef Eigen::VectorXcf lsst::meas::algorithms::shapelet::CFVector
 
typedef Eigen::Block< CFVector,
Eigen::Dynamic, 1 > 
lsst::meas::algorithms::shapelet::CFVectorView
 
typedef const CFVectorView lsst::meas::algorithms::shapelet::CFConstVectorView
 
typedef Eigen::MatrixXcf lsst::meas::algorithms::shapelet::CFMatrix
 
typedef Eigen::Block< CFMatrix > lsst::meas::algorithms::shapelet::CFMatrixView
 
typedef const CFMatrixView lsst::meas::algorithms::shapelet::CFConstMatrixView
 
typedef DVector lsst::meas::algorithms::shapelet::DDiagMatrix
 
typedef DMatrix lsst::meas::algorithms::shapelet::DSymMatrix
 

Macro Definition Documentation

#define EIGEN_asDiag ( )    .asDiagonal()

Definition at line 180 of file MyMatrix.h.

#define EIGEN_diag ( )    diagonal().array()

Definition at line 179 of file MyMatrix.h.

#define EIGEN_mutable   mutable

Definition at line 218 of file MyMatrix.h.

#define EIGEN_ToScalar (   m)    (m)(0,0)

Definition at line 212 of file MyMatrix.h.

#define EIGEN_Transpose (   m)    (m).transpose()

Definition at line 211 of file MyMatrix.h.

#define EIGEN_twice (   x)    x,x

Definition at line 219 of file MyMatrix.h.

#define TConstMatrixView (   T)    const Eigen::Block<TMatrix(T) >

Definition at line 171 of file MyMatrix.h.

#define TConstVectorView (   T)    const Eigen::Block<TVector(T) >

Definition at line 168 of file MyMatrix.h.

#define TMatrix (   T)    Eigen::Matrix<T,Eigen::Dynamic,Eigen::Dynamic>

Definition at line 169 of file MyMatrix.h.

#define TMatrixView (   T)    Eigen::Block<TMatrix(T) >

Definition at line 170 of file MyMatrix.h.

#define TMV_addToAll (   x)    array() += (x)

Definition at line 189 of file MyMatrix.h.

#define TMV_colpart (   j,
  i1,
  i2 
)    col(j).segment(i1,i2)

Definition at line 191 of file MyMatrix.h.

#define TMV_colRange (   m,
  j1,
  j2 
)    (m).block(0,j1,(m).rows(),((j2)-(j1)))

Definition at line 203 of file MyMatrix.h.

#define TMV_colsize ( )    rows()

Definition at line 175 of file MyMatrix.h.

#define TMV_conjugateSelf (   m)    (m) = (m).conjugate()

Definition at line 210 of file MyMatrix.h.

#define TMV_const

Definition at line 217 of file MyMatrix.h.

#define TMV_cptr (   m)    &((m).coeff(0,0))

Definition at line 206 of file MyMatrix.h.

#define TMV_cref (   i,
 
)    coeff(i,j)

Definition at line 176 of file MyMatrix.h.

#define TMV_det ( )    determinant()

Definition at line 196 of file MyMatrix.h.

#define TMV_diag ( )    diagonal()

Definition at line 178 of file MyMatrix.h.

#define TMV_DiagMatrixViewOf (   v)    (v).asDiagonal()

Definition at line 209 of file MyMatrix.h.

#define TMV_diagpart (   i,
  j1,
  j2 
)    diagonal().segment(j1,j2)

Definition at line 195 of file MyMatrix.h.

#define TMV_imagPart ( )    imag()

Definition at line 185 of file MyMatrix.h.

#define TMV_maxAbsElement ( )    array().abs().maxCoeff()

Definition at line 188 of file MyMatrix.h.

#define TMV_Norm (   m)    (m).norm()

Definition at line 214 of file MyMatrix.h.

#define TMV_normInf ( )    lpNorm<Eigen::Infinity>()

Definition at line 187 of file MyMatrix.h.

#define TMV_NormInf (   m)    (m).lpNorm<Eigen::Infinity>()

Definition at line 213 of file MyMatrix.h.

#define TMV_normSq ( )    squaredNorm()

Definition at line 186 of file MyMatrix.h.

#define TMV_ptr (   m)    &((m).coeffRef(0,0))

Definition at line 205 of file MyMatrix.h.

#define TMV_QR (   m)    Eigen::ColPivHouseholderQR<DMatrix> QR_Solver_ ## m = (m).colPivHouseholderQr();

Definition at line 222 of file MyMatrix.h.

#define TMV_QR1 (   m)

Definition at line 223 of file MyMatrix.h.

#define TMV_QR2 (   m)    Eigen::ColPivHouseholderQR<DMatrix> QR_Solver_ ## m = (m).colPivHouseholderQr();

Definition at line 224 of file MyMatrix.h.

#define TMV_QR_InverseATA (   m,
  cov 
)
Value:
do { \
(cov).setIdentity(); \
QR_Solver_ ## m .matrixQR().triangularView<Eigen::Upper>().transpose().solveInPlace(cov); \
QR_Solver_ ## m .matrixQR().triangularView<Eigen::Upper>().solveInPlace(cov); \
} while (false)
tuple m
Definition: lsstimport.py:48

Definition at line 229 of file MyMatrix.h.

#define TMV_QR_Solve (   m,
  x,
  b 
)    (x) = QR_Solver_ ## m .solve(b);

Definition at line 227 of file MyMatrix.h.

#define TMV_QRisSingular (   m)    QR_Solver_ ## m .isInjective()

Definition at line 226 of file MyMatrix.h.

#define TMV_realPart ( )    real()

Definition at line 184 of file MyMatrix.h.

#define TMV_ref (   i,
 
)    coeffRef(i,j)

Definition at line 177 of file MyMatrix.h.

#define TMV_rowpart (   i,
  j1,
  j2 
)    row(i).segment(j1,j2)

Definition at line 192 of file MyMatrix.h.

#define TMV_rowRange (   m,
  i1,
  i2 
)    (m).block(i1,0,((i2)-(i1)),(m).cols())

Definition at line 204 of file MyMatrix.h.

#define TMV_rowsize ( )    cols()

Definition at line 174 of file MyMatrix.h.

#define TMV_setAllTo (   x)    setConstant(x)

Definition at line 190 of file MyMatrix.h.

#define TMV_setToIdentity ( )    setIdentity()

Definition at line 181 of file MyMatrix.h.

#define TMV_stepi (   m)    ((m).rowStride())

Definition at line 207 of file MyMatrix.h.

#define TMV_stepj (   m)    ((m).colStride())

Definition at line 208 of file MyMatrix.h.

#define TMV_subMatrix (   i1,
  i2,
  j1,
  j2 
)    block(i1,j1,((i2)-(i1)),((j2)-(j1)))

Definition at line 183 of file MyMatrix.h.

#define TMV_subVector (   i1,
  i2 
)    segment(i1,((i2)-(i1)))

Definition at line 182 of file MyMatrix.h.

#define TMV_sumElements ( )    sum()

Definition at line 198 of file MyMatrix.h.

#define TMV_throwSingular   throw std::runtime_error("Singular")

Definition at line 228 of file MyMatrix.h.

#define TMV_transposeSelf ( )    transposeInPlace()

Definition at line 197 of file MyMatrix.h.

#define TMV_view (   m)    (m).block(0,0,(m).rows(),(m).cols())

Definition at line 201 of file MyMatrix.h.

#define TMV_vview (   v)    (v).segment(0,(v).size())

Definition at line 202 of file MyMatrix.h.

#define TVector (   T)    Eigen::Matrix<T,Eigen::Dynamic,1>

Definition at line 166 of file MyMatrix.h.

#define TVectorView (   T)    Eigen::Block<TVector(T) >

Definition at line 167 of file MyMatrix.h.