mirror of
https://gitlab.com/libeigen/eigen.git
synced 2025-06-04 18:54:00 +08:00
Warning 4512 (assignment operators could not be generated) is now simply disabled.
All unimplemented assignment operators have been removed.
This commit is contained in:
parent
4498864fc8
commit
832045d363
@ -43,8 +43,6 @@ struct ei_scalar_add_op {
|
|||||||
inline const PacketScalar packetOp(const PacketScalar& a) const
|
inline const PacketScalar packetOp(const PacketScalar& a) const
|
||||||
{ return ei_padd(a, ei_pset1(m_other)); }
|
{ return ei_padd(a, ei_pset1(m_other)); }
|
||||||
const Scalar m_other;
|
const Scalar m_other;
|
||||||
private:
|
|
||||||
ei_scalar_add_op& operator=(const ei_scalar_add_op&);
|
|
||||||
};
|
};
|
||||||
template<typename Scalar>
|
template<typename Scalar>
|
||||||
struct ei_functor_traits<ei_scalar_add_op<Scalar> >
|
struct ei_functor_traits<ei_scalar_add_op<Scalar> >
|
||||||
@ -130,8 +128,6 @@ struct ei_scalar_pow_op {
|
|||||||
inline ei_scalar_pow_op(const Scalar& exponent) : m_exponent(exponent) {}
|
inline ei_scalar_pow_op(const Scalar& exponent) : m_exponent(exponent) {}
|
||||||
inline Scalar operator() (const Scalar& a) const { return ei_pow(a, m_exponent); }
|
inline Scalar operator() (const Scalar& a) const { return ei_pow(a, m_exponent); }
|
||||||
const Scalar m_exponent;
|
const Scalar m_exponent;
|
||||||
private:
|
|
||||||
ei_scalar_pow_op& operator=(const ei_scalar_pow_op&);
|
|
||||||
};
|
};
|
||||||
template<typename Scalar>
|
template<typename Scalar>
|
||||||
struct ei_functor_traits<ei_scalar_pow_op<Scalar> >
|
struct ei_functor_traits<ei_scalar_pow_op<Scalar> >
|
||||||
|
@ -94,9 +94,6 @@ template<typename MatrixType,int RowFactor,int ColFactor> class Replicate
|
|||||||
const typename MatrixType::Nested m_matrix;
|
const typename MatrixType::Nested m_matrix;
|
||||||
const ei_int_if_dynamic<RowFactor> m_rowFactor;
|
const ei_int_if_dynamic<RowFactor> m_rowFactor;
|
||||||
const ei_int_if_dynamic<ColFactor> m_colFactor;
|
const ei_int_if_dynamic<ColFactor> m_colFactor;
|
||||||
|
|
||||||
private:
|
|
||||||
Replicate& operator=(const Replicate&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \nonstableyet
|
/** \nonstableyet
|
||||||
|
@ -147,8 +147,6 @@ struct ei_member_redux {
|
|||||||
inline result_type operator()(const MatrixBase<Derived>& mat) const
|
inline result_type operator()(const MatrixBase<Derived>& mat) const
|
||||||
{ return mat.redux(m_functor); }
|
{ return mat.redux(m_functor); }
|
||||||
const BinaryOp m_functor;
|
const BinaryOp m_functor;
|
||||||
private:
|
|
||||||
ei_member_redux& operator=(const ei_member_redux&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \array_module \ingroup Array_Module
|
/** \array_module \ingroup Array_Module
|
||||||
@ -490,9 +488,6 @@ template<typename ExpressionType, int Direction> class VectorwiseOp
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionTypeNested m_matrix;
|
ExpressionTypeNested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
VectorwiseOp& operator=(const VectorwiseOp&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \array_module
|
/** \array_module
|
||||||
|
@ -275,8 +275,6 @@ struct ei_solve_retval<LDLT<_MatrixType>, Rhs>
|
|||||||
dst = rhs();
|
dst = rhs();
|
||||||
dec().solveInPlace(dst);
|
dec().solveInPlace(dst);
|
||||||
}
|
}
|
||||||
private:
|
|
||||||
ei_solve_retval& operator=(const ei_solve_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** This is the \em in-place version of solve().
|
/** This is the \em in-place version of solve().
|
||||||
|
@ -270,8 +270,6 @@ struct ei_solve_retval<LLT<_MatrixType, UpLo>, Rhs>
|
|||||||
dst = rhs();
|
dst = rhs();
|
||||||
dec().solveInPlace(dst);
|
dec().solveInPlace(dst);
|
||||||
}
|
}
|
||||||
private:
|
|
||||||
ei_solve_retval& operator=(const ei_solve_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** This is the \em in-place version of solve().
|
/** This is the \em in-place version of solve().
|
||||||
|
@ -116,9 +116,6 @@ struct CommaInitializer
|
|||||||
int m_row; // current row id
|
int m_row; // current row id
|
||||||
int m_col; // current col id
|
int m_col; // current col id
|
||||||
int m_currentBlockRows; // current block height
|
int m_currentBlockRows; // current block height
|
||||||
|
|
||||||
private:
|
|
||||||
CommaInitializer& operator=(const CommaInitializer&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \anchor MatrixBaseCommaInitRef
|
/** \anchor MatrixBaseCommaInitRef
|
||||||
|
@ -178,9 +178,6 @@ template<typename ExpressionType> class Cwise
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionTypeNested m_matrix;
|
ExpressionTypeNested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
Cwise& operator=(const Cwise&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \returns a Cwise wrapper of *this providing additional coefficient-wise operations
|
/** \returns a Cwise wrapper of *this providing additional coefficient-wise operations
|
||||||
|
@ -111,9 +111,6 @@ template<typename ExpressionType, unsigned int Added, unsigned int Removed> clas
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionTypeNested m_matrix;
|
ExpressionTypeNested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
Flagged& operator=(const Flagged&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \deprecated it is only used by lazy() which is deprecated
|
/** \deprecated it is only used by lazy() which is deprecated
|
||||||
|
@ -351,8 +351,6 @@ struct ei_scalar_multiple_op {
|
|||||||
EIGEN_STRONG_INLINE const PacketScalar packetOp(const PacketScalar& a) const
|
EIGEN_STRONG_INLINE const PacketScalar packetOp(const PacketScalar& a) const
|
||||||
{ return ei_pmul(a, ei_pset1(m_other)); }
|
{ return ei_pmul(a, ei_pset1(m_other)); }
|
||||||
typename ei_makeconst<typename NumTraits<Scalar>::Nested>::type m_other;
|
typename ei_makeconst<typename NumTraits<Scalar>::Nested>::type m_other;
|
||||||
private:
|
|
||||||
ei_scalar_multiple_op& operator=(const ei_scalar_multiple_op&);
|
|
||||||
};
|
};
|
||||||
template<typename Scalar>
|
template<typename Scalar>
|
||||||
struct ei_functor_traits<ei_scalar_multiple_op<Scalar> >
|
struct ei_functor_traits<ei_scalar_multiple_op<Scalar> >
|
||||||
@ -365,8 +363,6 @@ struct ei_scalar_multiple2_op {
|
|||||||
EIGEN_STRONG_INLINE ei_scalar_multiple2_op(const Scalar2& other) : m_other(other) { }
|
EIGEN_STRONG_INLINE ei_scalar_multiple2_op(const Scalar2& other) : m_other(other) { }
|
||||||
EIGEN_STRONG_INLINE result_type operator() (const Scalar1& a) const { return a * m_other; }
|
EIGEN_STRONG_INLINE result_type operator() (const Scalar1& a) const { return a * m_other; }
|
||||||
typename ei_makeconst<typename NumTraits<Scalar2>::Nested>::type m_other;
|
typename ei_makeconst<typename NumTraits<Scalar2>::Nested>::type m_other;
|
||||||
private:
|
|
||||||
ei_scalar_multiple2_op& operator=(ei_scalar_multiple2_op&);
|
|
||||||
};
|
};
|
||||||
template<typename Scalar1,typename Scalar2>
|
template<typename Scalar1,typename Scalar2>
|
||||||
struct ei_functor_traits<ei_scalar_multiple2_op<Scalar1,Scalar2> >
|
struct ei_functor_traits<ei_scalar_multiple2_op<Scalar1,Scalar2> >
|
||||||
@ -382,8 +378,6 @@ struct ei_scalar_quotient1_impl {
|
|||||||
EIGEN_STRONG_INLINE const PacketScalar packetOp(const PacketScalar& a) const
|
EIGEN_STRONG_INLINE const PacketScalar packetOp(const PacketScalar& a) const
|
||||||
{ return ei_pmul(a, ei_pset1(m_other)); }
|
{ return ei_pmul(a, ei_pset1(m_other)); }
|
||||||
const Scalar m_other;
|
const Scalar m_other;
|
||||||
private:
|
|
||||||
ei_scalar_quotient1_impl& operator=(const ei_scalar_quotient1_impl&);
|
|
||||||
};
|
};
|
||||||
template<typename Scalar>
|
template<typename Scalar>
|
||||||
struct ei_functor_traits<ei_scalar_quotient1_impl<Scalar,true> >
|
struct ei_functor_traits<ei_scalar_quotient1_impl<Scalar,true> >
|
||||||
@ -396,8 +390,6 @@ struct ei_scalar_quotient1_impl<Scalar,false> {
|
|||||||
EIGEN_STRONG_INLINE ei_scalar_quotient1_impl(const Scalar& other) : m_other(other) {}
|
EIGEN_STRONG_INLINE ei_scalar_quotient1_impl(const Scalar& other) : m_other(other) {}
|
||||||
EIGEN_STRONG_INLINE Scalar operator() (const Scalar& a) const { return a / m_other; }
|
EIGEN_STRONG_INLINE Scalar operator() (const Scalar& a) const { return a / m_other; }
|
||||||
typename ei_makeconst<typename NumTraits<Scalar>::Nested>::type m_other;
|
typename ei_makeconst<typename NumTraits<Scalar>::Nested>::type m_other;
|
||||||
private:
|
|
||||||
ei_scalar_quotient1_impl& operator=(const ei_scalar_quotient1_impl&);
|
|
||||||
};
|
};
|
||||||
template<typename Scalar>
|
template<typename Scalar>
|
||||||
struct ei_functor_traits<ei_scalar_quotient1_impl<Scalar,false> >
|
struct ei_functor_traits<ei_scalar_quotient1_impl<Scalar,false> >
|
||||||
@ -431,8 +423,6 @@ struct ei_scalar_constant_op {
|
|||||||
EIGEN_STRONG_INLINE const Scalar operator() (int, int = 0) const { return m_other; }
|
EIGEN_STRONG_INLINE const Scalar operator() (int, int = 0) const { return m_other; }
|
||||||
EIGEN_STRONG_INLINE const PacketScalar packetOp() const { return ei_pset1(m_other); }
|
EIGEN_STRONG_INLINE const PacketScalar packetOp() const { return ei_pset1(m_other); }
|
||||||
const Scalar m_other;
|
const Scalar m_other;
|
||||||
private:
|
|
||||||
ei_scalar_constant_op& operator=(const ei_scalar_constant_op&);
|
|
||||||
};
|
};
|
||||||
template<typename Scalar>
|
template<typename Scalar>
|
||||||
struct ei_functor_traits<ei_scalar_constant_op<Scalar> >
|
struct ei_functor_traits<ei_scalar_constant_op<Scalar> >
|
||||||
|
@ -102,9 +102,6 @@ template<typename ExpressionType> class NestByValue
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
const ExpressionType m_expression;
|
const ExpressionType m_expression;
|
||||||
|
|
||||||
private:
|
|
||||||
NestByValue& operator=(const NestByValue&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \returns an expression of the temporary version of *this.
|
/** \returns an expression of the temporary version of *this.
|
||||||
|
@ -73,9 +73,6 @@ class NoAlias
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionType& m_expression;
|
ExpressionType& m_expression;
|
||||||
|
|
||||||
private:
|
|
||||||
NoAlias& operator=(const NoAlias&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \returns a pseudo expression of \c *this with an operator= assuming
|
/** \returns a pseudo expression of \c *this with an operator= assuming
|
||||||
|
@ -320,9 +320,6 @@ struct ei_permut_matrix_product_retval
|
|||||||
protected:
|
protected:
|
||||||
const PermutationType& m_permutation;
|
const PermutationType& m_permutation;
|
||||||
const typename MatrixType::Nested m_matrix;
|
const typename MatrixType::Nested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
ei_permut_matrix_product_retval& operator=(ei_permut_matrix_product_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#endif // EIGEN_PERMUTATIONMATRIX_H
|
#endif // EIGEN_PERMUTATIONMATRIX_H
|
||||||
|
@ -211,9 +211,6 @@ class GeneralProduct<Lhs, Rhs, OuterProduct>
|
|||||||
{
|
{
|
||||||
ei_outer_product_selector<(int(Dest::Flags)&RowMajorBit) ? RowMajor : ColMajor>::run(*this, dest, alpha);
|
ei_outer_product_selector<(int(Dest::Flags)&RowMajorBit) ? RowMajor : ColMajor>::run(*this, dest, alpha);
|
||||||
}
|
}
|
||||||
|
|
||||||
private:
|
|
||||||
GeneralProduct& operator=(const GeneralProduct&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<> struct ei_outer_product_selector<ColMajor> {
|
template<> struct ei_outer_product_selector<ColMajor> {
|
||||||
@ -279,9 +276,6 @@ class GeneralProduct<Lhs, Rhs, GemvProduct>
|
|||||||
ei_gemv_selector<Side,(int(MatrixType::Flags)&RowMajorBit) ? RowMajor : ColMajor,
|
ei_gemv_selector<Side,(int(MatrixType::Flags)&RowMajorBit) ? RowMajor : ColMajor,
|
||||||
bool(ei_blas_traits<MatrixType>::ActualAccess)>::run(*this, dst, alpha);
|
bool(ei_blas_traits<MatrixType>::ActualAccess)>::run(*this, dst, alpha);
|
||||||
}
|
}
|
||||||
|
|
||||||
private:
|
|
||||||
GeneralProduct& operator=(const GeneralProduct&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
// The vector is on the left => transposition
|
// The vector is on the left => transposition
|
||||||
|
@ -129,8 +129,6 @@ class ProductBase : public MatrixBase<Derived>
|
|||||||
void coeffRef(int,int);
|
void coeffRef(int,int);
|
||||||
void coeff(int) const;
|
void coeff(int) const;
|
||||||
void coeffRef(int);
|
void coeffRef(int);
|
||||||
|
|
||||||
ProductBase& operator=(const ProductBase&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename NestedProduct>
|
template<typename NestedProduct>
|
||||||
|
@ -151,9 +151,6 @@ template<typename MatrixType, unsigned int UpLo> class SelfAdjointView
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
const typename MatrixType::Nested m_matrix;
|
const typename MatrixType::Nested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
SelfAdjointView& operator=(const SelfAdjointView&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
|
|
||||||
|
@ -117,9 +117,6 @@ template<typename ExpressionType> class SwapWrapper
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionType& m_expression;
|
ExpressionType& m_expression;
|
||||||
|
|
||||||
private:
|
|
||||||
SwapWrapper& operator=(const SwapWrapper&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** swaps *this with the expression \a other.
|
/** swaps *this with the expression \a other.
|
||||||
|
@ -2,7 +2,8 @@
|
|||||||
#ifdef _MSC_VER
|
#ifdef _MSC_VER
|
||||||
// 4273 - QtAlignedMalloc, inconsistent DLL linkage
|
// 4273 - QtAlignedMalloc, inconsistent DLL linkage
|
||||||
// 4100 - unreferenced formal parameter (occurred e.g. in aligned_allocator::destroy(pointer p))
|
// 4100 - unreferenced formal parameter (occurred e.g. in aligned_allocator::destroy(pointer p))
|
||||||
// 4101 - we need this one for the inlining fix
|
// 4101 - unreferenced local variable
|
||||||
|
// 4512 - assignment operator could not be generated
|
||||||
#pragma warning( push )
|
#pragma warning( push )
|
||||||
#pragma warning( disable : 4100 4101 4181 4244 4127 4211 4273 4522 4717 )
|
#pragma warning( disable : 4100 4101 4181 4244 4127 4211 4273 4522 4717 )
|
||||||
#endif
|
#endif
|
||||||
|
@ -241,8 +241,6 @@ struct ei_homogeneous_left_product_impl<Homogeneous<MatrixType,Vertical>,Lhs>
|
|||||||
|
|
||||||
const typename Lhs::Nested m_lhs;
|
const typename Lhs::Nested m_lhs;
|
||||||
const typename MatrixType::Nested m_rhs;
|
const typename MatrixType::Nested m_rhs;
|
||||||
private:
|
|
||||||
ei_homogeneous_left_product_impl& operator=(const ei_homogeneous_left_product_impl&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename MatrixType,typename Rhs>
|
template<typename MatrixType,typename Rhs>
|
||||||
@ -281,9 +279,6 @@ struct ei_homogeneous_right_product_impl<Homogeneous<MatrixType,Horizontal>,Rhs>
|
|||||||
|
|
||||||
const typename MatrixType::Nested m_lhs;
|
const typename MatrixType::Nested m_lhs;
|
||||||
const typename Rhs::Nested m_rhs;
|
const typename Rhs::Nested m_rhs;
|
||||||
|
|
||||||
private:
|
|
||||||
ei_homogeneous_right_product_impl& operator=(const ei_homogeneous_right_product_impl&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#endif // EIGEN_HOMOGENEOUS_H
|
#endif // EIGEN_HOMOGENEOUS_H
|
||||||
|
@ -161,9 +161,6 @@ template<typename VectorsType, typename CoeffsType> class HouseholderSequence
|
|||||||
typename CoeffsType::Nested m_coeffs;
|
typename CoeffsType::Nested m_coeffs;
|
||||||
bool m_trans;
|
bool m_trans;
|
||||||
int m_actualVectors;
|
int m_actualVectors;
|
||||||
|
|
||||||
private:
|
|
||||||
HouseholderSequence& operator=(const HouseholderSequence&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename VectorsType, typename CoeffsType>
|
template<typename VectorsType, typename CoeffsType>
|
||||||
|
@ -562,9 +562,6 @@ struct ei_kernel_retval<FullPivLU<_MatrixType> >
|
|||||||
for(int i = rank(); i < cols; ++i) dst.row(dec().permutationQ().indices().coeff(i)).setZero();
|
for(int i = rank(); i < cols; ++i) dst.row(dec().permutationQ().indices().coeff(i)).setZero();
|
||||||
for(int k = 0; k < dimker; ++k) dst.coeffRef(dec().permutationQ().indices().coeff(rank()+k), k) = Scalar(1);
|
for(int k = 0; k < dimker; ++k) dst.coeffRef(dec().permutationQ().indices().coeff(rank()+k), k) = Scalar(1);
|
||||||
}
|
}
|
||||||
|
|
||||||
private:
|
|
||||||
ei_kernel_retval& operator=(const ei_kernel_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/***** Implementation of image() *****************************************************/
|
/***** Implementation of image() *****************************************************/
|
||||||
@ -602,9 +599,6 @@ struct ei_image_retval<FullPivLU<_MatrixType> >
|
|||||||
for(int i = 0; i < rank(); ++i)
|
for(int i = 0; i < rank(); ++i)
|
||||||
dst.col(i) = originalMatrix().col(dec().permutationQ().indices().coeff(pivots.coeff(i)));
|
dst.col(i) = originalMatrix().col(dec().permutationQ().indices().coeff(pivots.coeff(i)));
|
||||||
}
|
}
|
||||||
|
|
||||||
private:
|
|
||||||
ei_image_retval& operator=(const ei_image_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/***** Implementation of solve() *****************************************************/
|
/***** Implementation of solve() *****************************************************/
|
||||||
@ -665,9 +659,6 @@ struct ei_solve_retval<FullPivLU<_MatrixType>, Rhs>
|
|||||||
for(int i = nonzero_pivots; i < dec().matrixLU().cols(); ++i)
|
for(int i = nonzero_pivots; i < dec().matrixLU().cols(); ++i)
|
||||||
dst.row(dec().permutationQ().indices().coeff(i)).setZero();
|
dst.row(dec().permutationQ().indices().coeff(i)).setZero();
|
||||||
}
|
}
|
||||||
|
|
||||||
private:
|
|
||||||
ei_solve_retval& operator=(const ei_solve_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/******* MatrixBase methods *****************************************************************/
|
/******* MatrixBase methods *****************************************************************/
|
||||||
|
@ -258,8 +258,6 @@ struct ei_inverse_impl : public ReturnByValue<ei_inverse_impl<MatrixType> >
|
|||||||
{
|
{
|
||||||
ei_compute_inverse<MatrixTypeNestedCleaned, Dest>::run(m_matrix, dst);
|
ei_compute_inverse<MatrixTypeNestedCleaned, Dest>::run(m_matrix, dst);
|
||||||
}
|
}
|
||||||
private:
|
|
||||||
ei_inverse_impl& operator=(const ei_inverse_impl&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \lu_module
|
/** \lu_module
|
||||||
|
@ -237,8 +237,6 @@ struct ei_solve_retval<HouseholderQR<_MatrixType>, Rhs>
|
|||||||
dst.corner(TopLeft, rank, c.cols()) = c.corner(TopLeft, rank, c.cols());
|
dst.corner(TopLeft, rank, c.cols()) = c.corner(TopLeft, rank, c.cols());
|
||||||
dst.corner(BottomLeft, cols-rank, c.cols()).setZero();
|
dst.corner(BottomLeft, cols-rank, c.cols()).setZero();
|
||||||
}
|
}
|
||||||
private:
|
|
||||||
ei_solve_retval& operator=(const ei_solve_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#endif // EIGEN_HIDE_HEAVY_CODE
|
#endif // EIGEN_HIDE_HEAVY_CODE
|
||||||
|
@ -456,8 +456,6 @@ struct ei_solve_retval<SVD<_MatrixType>, Rhs>
|
|||||||
dst.col(j) = dec().matrixV() * dst.col(j);
|
dst.col(j) = dec().matrixV() * dst.col(j);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
private:
|
|
||||||
ei_solve_retval& operator=(const ei_solve_retval&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** Computes the polar decomposition of the matrix, as a product unitary x positive.
|
/** Computes the polar decomposition of the matrix, as a product unitary x positive.
|
||||||
|
@ -126,10 +126,6 @@ template<typename _Scalar> class AmbiVector
|
|||||||
int m_llStart;
|
int m_llStart;
|
||||||
int m_llCurrent;
|
int m_llCurrent;
|
||||||
int m_llSize;
|
int m_llSize;
|
||||||
|
|
||||||
private:
|
|
||||||
AmbiVector(const AmbiVector&);
|
|
||||||
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/** \returns the number of non zeros in the current sub vector */
|
/** \returns the number of non zeros in the current sub vector */
|
||||||
|
@ -320,12 +320,8 @@ class DynamicSparseMatrix<Scalar,_Flags>::InnerIterator : public SparseVector<Sc
|
|||||||
inline int row() const { return IsRowMajor ? m_outer : Base::index(); }
|
inline int row() const { return IsRowMajor ? m_outer : Base::index(); }
|
||||||
inline int col() const { return IsRowMajor ? Base::index() : m_outer; }
|
inline int col() const { return IsRowMajor ? Base::index() : m_outer; }
|
||||||
|
|
||||||
|
|
||||||
protected:
|
protected:
|
||||||
const int m_outer;
|
const int m_outer;
|
||||||
|
|
||||||
private:
|
|
||||||
InnerIterator& operator=(InnerIterator&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#endif // EIGEN_DYNAMIC_SPARSEMATRIX_H
|
#endif // EIGEN_DYNAMIC_SPARSEMATRIX_H
|
||||||
|
@ -220,8 +220,6 @@ class SparseInnerVectorSet<SparseMatrix<_Scalar, _Options>, Size>
|
|||||||
inline int col() const { return IsRowMajor ? this->index() : m_outer; }
|
inline int col() const { return IsRowMajor ? this->index() : m_outer; }
|
||||||
protected:
|
protected:
|
||||||
int m_outer;
|
int m_outer;
|
||||||
private:
|
|
||||||
InnerIterator& operator=(const InnerIterator&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
inline SparseInnerVectorSet(const MatrixType& matrix, int outerStart, int outerSize)
|
inline SparseInnerVectorSet(const MatrixType& matrix, int outerStart, int outerSize)
|
||||||
|
@ -156,9 +156,6 @@ template<typename ExpressionType> class SparseCwise
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionTypeNested m_matrix;
|
ExpressionTypeNested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
SparseCwise& operator=(const SparseCwise&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename Derived>
|
template<typename Derived>
|
||||||
|
@ -126,9 +126,6 @@ class SparseCwiseBinaryOp<BinaryOp,Lhs,Rhs>::InnerIterator
|
|||||||
EIGEN_STRONG_INLINE InnerIterator(const SparseCwiseBinaryOp& binOp, int outer)
|
EIGEN_STRONG_INLINE InnerIterator(const SparseCwiseBinaryOp& binOp, int outer)
|
||||||
: Base(binOp,outer)
|
: Base(binOp,outer)
|
||||||
{}
|
{}
|
||||||
|
|
||||||
private:
|
|
||||||
InnerIterator& operator=(const InnerIterator&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/***************************************************************************
|
/***************************************************************************
|
||||||
@ -200,8 +197,6 @@ class ei_sparse_cwise_binary_op_inner_iterator_selector<BinaryOp, Lhs, Rhs, Deri
|
|||||||
const BinaryOp& m_functor;
|
const BinaryOp& m_functor;
|
||||||
Scalar m_value;
|
Scalar m_value;
|
||||||
int m_id;
|
int m_id;
|
||||||
private:
|
|
||||||
ei_sparse_cwise_binary_op_inner_iterator_selector& operator=(const ei_sparse_cwise_binary_op_inner_iterator_selector&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
// sparse - sparse (product)
|
// sparse - sparse (product)
|
||||||
@ -255,8 +250,6 @@ class ei_sparse_cwise_binary_op_inner_iterator_selector<ei_scalar_product_op<T>,
|
|||||||
LhsIterator m_lhsIter;
|
LhsIterator m_lhsIter;
|
||||||
RhsIterator m_rhsIter;
|
RhsIterator m_rhsIter;
|
||||||
const BinaryFunc& m_functor;
|
const BinaryFunc& m_functor;
|
||||||
private:
|
|
||||||
ei_sparse_cwise_binary_op_inner_iterator_selector& operator=(const ei_sparse_cwise_binary_op_inner_iterator_selector&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
// sparse - dense (product)
|
// sparse - dense (product)
|
||||||
@ -297,9 +290,6 @@ class ei_sparse_cwise_binary_op_inner_iterator_selector<ei_scalar_product_op<T>,
|
|||||||
LhsIterator m_lhsIter;
|
LhsIterator m_lhsIter;
|
||||||
const BinaryFunc m_functor;
|
const BinaryFunc m_functor;
|
||||||
const int m_outer;
|
const int m_outer;
|
||||||
|
|
||||||
private:
|
|
||||||
ei_sparse_cwise_binary_op_inner_iterator_selector& operator=(ei_sparse_cwise_binary_op_inner_iterator_selector&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
// sparse - dense (product)
|
// sparse - dense (product)
|
||||||
|
@ -90,9 +90,6 @@ class SparseCwiseUnaryOp<UnaryOp,MatrixType>::InnerIterator
|
|||||||
protected:
|
protected:
|
||||||
MatrixTypeIterator m_iter;
|
MatrixTypeIterator m_iter;
|
||||||
const UnaryOp m_functor;
|
const UnaryOp m_functor;
|
||||||
|
|
||||||
private:
|
|
||||||
InnerIterator& operator=(const InnerIterator&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename Derived>
|
template<typename Derived>
|
||||||
|
@ -133,8 +133,6 @@ class ei_sparse_diagonal_product_inner_iterator_selector
|
|||||||
const SparseDiagonalProductType& expr, int outer)
|
const SparseDiagonalProductType& expr, int outer)
|
||||||
: Base(expr.rhs().innerVector(outer) .cwise()* expr.lhs().diagonal(), 0)
|
: Base(expr.rhs().innerVector(outer) .cwise()* expr.lhs().diagonal(), 0)
|
||||||
{}
|
{}
|
||||||
private:
|
|
||||||
ei_sparse_diagonal_product_inner_iterator_selector& operator=(const ei_sparse_diagonal_product_inner_iterator_selector&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename Lhs, typename Rhs, typename SparseDiagonalProductType>
|
template<typename Lhs, typename Rhs, typename SparseDiagonalProductType>
|
||||||
@ -167,8 +165,6 @@ class ei_sparse_diagonal_product_inner_iterator_selector
|
|||||||
const SparseDiagonalProductType& expr, int outer)
|
const SparseDiagonalProductType& expr, int outer)
|
||||||
: Base(expr.lhs().innerVector(outer) .cwise()* expr.rhs().diagonal().transpose(), 0)
|
: Base(expr.lhs().innerVector(outer) .cwise()* expr.rhs().diagonal().transpose(), 0)
|
||||||
{}
|
{}
|
||||||
private:
|
|
||||||
ei_sparse_diagonal_product_inner_iterator_selector& operator=(const ei_sparse_diagonal_product_inner_iterator_selector&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
// SparseMatrixBase functions
|
// SparseMatrixBase functions
|
||||||
|
@ -64,9 +64,6 @@ template<typename ExpressionType, unsigned int Added, unsigned int Removed> clas
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionTypeNested m_matrix;
|
ExpressionTypeNested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
SparseFlagged& operator=(const SparseFlagged&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename ExpressionType, unsigned int Added, unsigned int Removed>
|
template<typename ExpressionType, unsigned int Added, unsigned int Removed>
|
||||||
@ -77,9 +74,6 @@ template<typename ExpressionType, unsigned int Added, unsigned int Removed>
|
|||||||
EIGEN_STRONG_INLINE InnerIterator(const SparseFlagged& xpr, int outer)
|
EIGEN_STRONG_INLINE InnerIterator(const SparseFlagged& xpr, int outer)
|
||||||
: ExpressionType::InnerIterator(xpr.m_matrix, outer)
|
: ExpressionType::InnerIterator(xpr.m_matrix, outer)
|
||||||
{}
|
{}
|
||||||
|
|
||||||
private:
|
|
||||||
InnerIterator& operator=(const InnerIterator&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename ExpressionType, unsigned int Added, unsigned int Removed>
|
template<typename ExpressionType, unsigned int Added, unsigned int Removed>
|
||||||
|
@ -557,9 +557,6 @@ class SparseMatrix<Scalar,_Options>::InnerIterator
|
|||||||
int m_id;
|
int m_id;
|
||||||
const int m_start;
|
const int m_start;
|
||||||
const int m_end;
|
const int m_end;
|
||||||
|
|
||||||
private:
|
|
||||||
InnerIterator& operator=(const InnerIterator&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#endif // EIGEN_SPARSEMATRIX_H
|
#endif // EIGEN_SPARSEMATRIX_H
|
||||||
|
@ -62,9 +62,6 @@ template<typename MatrixType> class SparseTranspose
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
const typename MatrixType::Nested m_matrix;
|
const typename MatrixType::Nested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
SparseTranspose& operator=(const SparseTranspose&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename MatrixType> class SparseTranspose<MatrixType>::InnerIterator : public MatrixType::InnerIterator
|
template<typename MatrixType> class SparseTranspose<MatrixType>::InnerIterator : public MatrixType::InnerIterator
|
||||||
@ -77,9 +74,6 @@ template<typename MatrixType> class SparseTranspose<MatrixType>::InnerIterator :
|
|||||||
{}
|
{}
|
||||||
inline int row() const { return Base::col(); }
|
inline int row() const { return Base::col(); }
|
||||||
inline int col() const { return Base::row(); }
|
inline int col() const { return Base::row(); }
|
||||||
|
|
||||||
private:
|
|
||||||
InnerIterator& operator=(const InnerIterator&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename MatrixType> class SparseTranspose<MatrixType>::ReverseInnerIterator : public MatrixType::ReverseInnerIterator
|
template<typename MatrixType> class SparseTranspose<MatrixType>::ReverseInnerIterator : public MatrixType::ReverseInnerIterator
|
||||||
|
@ -47,9 +47,6 @@ template<typename ExpressionType, int Mode> class SparseTriangular
|
|||||||
|
|
||||||
protected:
|
protected:
|
||||||
ExpressionTypeNested m_matrix;
|
ExpressionTypeNested m_matrix;
|
||||||
|
|
||||||
private:
|
|
||||||
SparseTriangular& operator=(const SparseTriangular&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename Derived>
|
template<typename Derived>
|
||||||
|
@ -70,9 +70,6 @@ template<typename _DecompositionType> struct ei_image_retval_base
|
|||||||
const DecompositionType& m_dec;
|
const DecompositionType& m_dec;
|
||||||
int m_rank, m_cols;
|
int m_rank, m_cols;
|
||||||
const MatrixType& m_originalMatrix;
|
const MatrixType& m_originalMatrix;
|
||||||
|
|
||||||
private:
|
|
||||||
ei_image_retval_base& operator=(const ei_image_retval_base&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#define EIGEN_MAKE_IMAGE_HELPERS(DecompositionType) \
|
#define EIGEN_MAKE_IMAGE_HELPERS(DecompositionType) \
|
||||||
|
@ -69,9 +69,6 @@ template<typename _DecompositionType> struct ei_kernel_retval_base
|
|||||||
protected:
|
protected:
|
||||||
const DecompositionType& m_dec;
|
const DecompositionType& m_dec;
|
||||||
int m_rank, m_cols;
|
int m_rank, m_cols;
|
||||||
|
|
||||||
private:
|
|
||||||
ei_kernel_retval_base& operator=(const ei_kernel_retval_base&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#define EIGEN_MAKE_KERNEL_HELPERS(DecompositionType) \
|
#define EIGEN_MAKE_KERNEL_HELPERS(DecompositionType) \
|
||||||
|
@ -63,9 +63,6 @@ template<typename _DecompositionType, typename Rhs> struct ei_solve_retval_base
|
|||||||
protected:
|
protected:
|
||||||
const DecompositionType& m_dec;
|
const DecompositionType& m_dec;
|
||||||
const typename Rhs::Nested m_rhs;
|
const typename Rhs::Nested m_rhs;
|
||||||
|
|
||||||
private:
|
|
||||||
ei_solve_retval_base& operator=(const ei_solve_retval_base&);
|
|
||||||
};
|
};
|
||||||
|
|
||||||
#define EIGEN_MAKE_SOLVE_HELPERS(DecompositionType,Rhs) \
|
#define EIGEN_MAKE_SOLVE_HELPERS(DecompositionType,Rhs) \
|
||||||
|
Loading…
x
Reference in New Issue
Block a user