aboutsummaryrefslogtreecommitdiffhomepage
path: root/Eigen/src
diff options
context:
space:
mode:
authorGravatar Hauke Heibel <hauke.heibel@gmail.com>2009-12-14 10:32:43 +0100
committerGravatar Hauke Heibel <hauke.heibel@gmail.com>2009-12-14 10:32:43 +0100
commit832045d363a6edf59d4dc4ad0cfbe02272dcce3c (patch)
tree3731ca27621cde14807d93cb70b24c04ea42ad94 /Eigen/src
parent4498864fc83340f3f52a55c12027faac19d1ede1 (diff)
Warning 4512 (assignment operators could not be generated) is now simply disabled.
All unimplemented assignment operators have been removed.
Diffstat (limited to 'Eigen/src')
-rw-r--r--Eigen/src/Array/Functors.h4
-rw-r--r--Eigen/src/Array/Replicate.h3
-rw-r--r--Eigen/src/Array/VectorwiseOp.h5
-rw-r--r--Eigen/src/Cholesky/LDLT.h2
-rw-r--r--Eigen/src/Cholesky/LLT.h2
-rw-r--r--Eigen/src/Core/CommaInitializer.h3
-rw-r--r--Eigen/src/Core/Cwise.h3
-rw-r--r--Eigen/src/Core/Flagged.h3
-rw-r--r--Eigen/src/Core/Functors.h10
-rw-r--r--Eigen/src/Core/NestByValue.h3
-rw-r--r--Eigen/src/Core/NoAlias.h3
-rw-r--r--Eigen/src/Core/PermutationMatrix.h3
-rw-r--r--Eigen/src/Core/Product.h6
-rw-r--r--Eigen/src/Core/ProductBase.h2
-rw-r--r--Eigen/src/Core/SelfAdjointView.h3
-rw-r--r--Eigen/src/Core/Swap.h3
-rw-r--r--Eigen/src/Core/util/DisableMSVCWarnings.h3
-rw-r--r--Eigen/src/Geometry/Homogeneous.h5
-rw-r--r--Eigen/src/Householder/HouseholderSequence.h3
-rw-r--r--Eigen/src/LU/FullPivLU.h9
-rw-r--r--Eigen/src/LU/Inverse.h2
-rw-r--r--Eigen/src/QR/HouseholderQR.h2
-rw-r--r--Eigen/src/SVD/SVD.h2
-rw-r--r--Eigen/src/Sparse/AmbiVector.h4
-rw-r--r--Eigen/src/Sparse/DynamicSparseMatrix.h4
-rw-r--r--Eigen/src/Sparse/SparseBlock.h2
-rw-r--r--Eigen/src/Sparse/SparseCwise.h3
-rw-r--r--Eigen/src/Sparse/SparseCwiseBinaryOp.h10
-rw-r--r--Eigen/src/Sparse/SparseCwiseUnaryOp.h3
-rw-r--r--Eigen/src/Sparse/SparseDiagonalProduct.h4
-rw-r--r--Eigen/src/Sparse/SparseFlagged.h6
-rw-r--r--Eigen/src/Sparse/SparseMatrix.h3
-rw-r--r--Eigen/src/Sparse/SparseTranspose.h6
-rw-r--r--Eigen/src/Sparse/SparseTriangular.h3
-rw-r--r--Eigen/src/misc/Image.h3
-rw-r--r--Eigen/src/misc/Kernel.h3
-rw-r--r--Eigen/src/misc/Solve.h3
37 files changed, 2 insertions, 139 deletions
diff --git a/Eigen/src/Array/Functors.h b/Eigen/src/Array/Functors.h
index 3a7753d04..fd259f7bc 100644
--- a/Eigen/src/Array/Functors.h
+++ b/Eigen/src/Array/Functors.h
@@ -43,8 +43,6 @@ struct ei_scalar_add_op {
inline const PacketScalar packetOp(const PacketScalar& a) const
{ return ei_padd(a, ei_pset1(m_other)); }
const Scalar m_other;
-private:
- ei_scalar_add_op& operator=(const ei_scalar_add_op&);
};
template<typename 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 Scalar operator() (const Scalar& a) const { return ei_pow(a, m_exponent); }
const Scalar m_exponent;
-private:
- ei_scalar_pow_op& operator=(const ei_scalar_pow_op&);
};
template<typename Scalar>
struct ei_functor_traits<ei_scalar_pow_op<Scalar> >
diff --git a/Eigen/src/Array/Replicate.h b/Eigen/src/Array/Replicate.h
index 478c0bf68..653bda666 100644
--- a/Eigen/src/Array/Replicate.h
+++ b/Eigen/src/Array/Replicate.h
@@ -94,9 +94,6 @@ template<typename MatrixType,int RowFactor,int ColFactor> class Replicate
const typename MatrixType::Nested m_matrix;
const ei_int_if_dynamic<RowFactor> m_rowFactor;
const ei_int_if_dynamic<ColFactor> m_colFactor;
-
- private:
- Replicate& operator=(const Replicate&);
};
/** \nonstableyet
diff --git a/Eigen/src/Array/VectorwiseOp.h b/Eigen/src/Array/VectorwiseOp.h
index 92e5cc000..37ed8ac17 100644
--- a/Eigen/src/Array/VectorwiseOp.h
+++ b/Eigen/src/Array/VectorwiseOp.h
@@ -147,8 +147,6 @@ struct ei_member_redux {
inline result_type operator()(const MatrixBase<Derived>& mat) const
{ return mat.redux(m_functor); }
const BinaryOp m_functor;
-private:
- ei_member_redux& operator=(const ei_member_redux&);
};
/** \array_module \ingroup Array_Module
@@ -490,9 +488,6 @@ template<typename ExpressionType, int Direction> class VectorwiseOp
protected:
ExpressionTypeNested m_matrix;
-
- private:
- VectorwiseOp& operator=(const VectorwiseOp&);
};
/** \array_module
diff --git a/Eigen/src/Cholesky/LDLT.h b/Eigen/src/Cholesky/LDLT.h
index 2898d8747..d0f292634 100644
--- a/Eigen/src/Cholesky/LDLT.h
+++ b/Eigen/src/Cholesky/LDLT.h
@@ -275,8 +275,6 @@ struct ei_solve_retval<LDLT<_MatrixType>, Rhs>
dst = rhs();
dec().solveInPlace(dst);
}
-private:
- ei_solve_retval& operator=(const ei_solve_retval&);
};
/** This is the \em in-place version of solve().
diff --git a/Eigen/src/Cholesky/LLT.h b/Eigen/src/Cholesky/LLT.h
index 6612984ab..ad737aaeb 100644
--- a/Eigen/src/Cholesky/LLT.h
+++ b/Eigen/src/Cholesky/LLT.h
@@ -270,8 +270,6 @@ struct ei_solve_retval<LLT<_MatrixType, UpLo>, Rhs>
dst = rhs();
dec().solveInPlace(dst);
}
-private:
- ei_solve_retval& operator=(const ei_solve_retval&);
};
/** This is the \em in-place version of solve().
diff --git a/Eigen/src/Core/CommaInitializer.h b/Eigen/src/Core/CommaInitializer.h
index 328c5580c..e86f47ad0 100644
--- a/Eigen/src/Core/CommaInitializer.h
+++ b/Eigen/src/Core/CommaInitializer.h
@@ -116,9 +116,6 @@ struct CommaInitializer
int m_row; // current row id
int m_col; // current col id
int m_currentBlockRows; // current block height
-
-private:
- CommaInitializer& operator=(const CommaInitializer&);
};
/** \anchor MatrixBaseCommaInitRef
diff --git a/Eigen/src/Core/Cwise.h b/Eigen/src/Core/Cwise.h
index 80414782e..4f3d641cb 100644
--- a/Eigen/src/Core/Cwise.h
+++ b/Eigen/src/Core/Cwise.h
@@ -178,9 +178,6 @@ template<typename ExpressionType> class Cwise
protected:
ExpressionTypeNested m_matrix;
-
- private:
- Cwise& operator=(const Cwise&);
};
/** \returns a Cwise wrapper of *this providing additional coefficient-wise operations
diff --git a/Eigen/src/Core/Flagged.h b/Eigen/src/Core/Flagged.h
index b98861f42..754eaf6c5 100644
--- a/Eigen/src/Core/Flagged.h
+++ b/Eigen/src/Core/Flagged.h
@@ -111,9 +111,6 @@ template<typename ExpressionType, unsigned int Added, unsigned int Removed> clas
protected:
ExpressionTypeNested m_matrix;
-
- private:
- Flagged& operator=(const Flagged&);
};
/** \deprecated it is only used by lazy() which is deprecated
diff --git a/Eigen/src/Core/Functors.h b/Eigen/src/Core/Functors.h
index e2a212c89..6b62fb4ea 100644
--- a/Eigen/src/Core/Functors.h
+++ b/Eigen/src/Core/Functors.h
@@ -351,8 +351,6 @@ struct ei_scalar_multiple_op {
EIGEN_STRONG_INLINE const PacketScalar packetOp(const PacketScalar& a) const
{ return ei_pmul(a, ei_pset1(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>
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 result_type operator() (const Scalar1& a) const { return a * 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>
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
{ return ei_pmul(a, ei_pset1(m_other)); }
const Scalar m_other;
-private:
- ei_scalar_quotient1_impl& operator=(const ei_scalar_quotient1_impl&);
};
template<typename Scalar>
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 Scalar operator() (const Scalar& a) const { return a / 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>
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 PacketScalar packetOp() const { return ei_pset1(m_other); }
const Scalar m_other;
-private:
- ei_scalar_constant_op& operator=(const ei_scalar_constant_op&);
};
template<typename Scalar>
struct ei_functor_traits<ei_scalar_constant_op<Scalar> >
diff --git a/Eigen/src/Core/NestByValue.h b/Eigen/src/Core/NestByValue.h
index 94a8f8078..85a672779 100644
--- a/Eigen/src/Core/NestByValue.h
+++ b/Eigen/src/Core/NestByValue.h
@@ -102,9 +102,6 @@ template<typename ExpressionType> class NestByValue
protected:
const ExpressionType m_expression;
-
- private:
- NestByValue& operator=(const NestByValue&);
};
/** \returns an expression of the temporary version of *this.
diff --git a/Eigen/src/Core/NoAlias.h b/Eigen/src/Core/NoAlias.h
index dc32c2f7b..66d8d834d 100644
--- a/Eigen/src/Core/NoAlias.h
+++ b/Eigen/src/Core/NoAlias.h
@@ -73,9 +73,6 @@ class NoAlias
protected:
ExpressionType& m_expression;
-
- private:
- NoAlias& operator=(const NoAlias&);
};
/** \returns a pseudo expression of \c *this with an operator= assuming
diff --git a/Eigen/src/Core/PermutationMatrix.h b/Eigen/src/Core/PermutationMatrix.h
index 4d30b2dac..284baf678 100644
--- a/Eigen/src/Core/PermutationMatrix.h
+++ b/Eigen/src/Core/PermutationMatrix.h
@@ -320,9 +320,6 @@ struct ei_permut_matrix_product_retval
protected:
const PermutationType& m_permutation;
const typename MatrixType::Nested m_matrix;
-
- private:
- ei_permut_matrix_product_retval& operator=(ei_permut_matrix_product_retval&);
};
#endif // EIGEN_PERMUTATIONMATRIX_H
diff --git a/Eigen/src/Core/Product.h b/Eigen/src/Core/Product.h
index cc751650d..d24ef6159 100644
--- a/Eigen/src/Core/Product.h
+++ b/Eigen/src/Core/Product.h
@@ -211,9 +211,6 @@ class GeneralProduct<Lhs, Rhs, OuterProduct>
{
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> {
@@ -279,9 +276,6 @@ class GeneralProduct<Lhs, Rhs, GemvProduct>
ei_gemv_selector<Side,(int(MatrixType::Flags)&RowMajorBit) ? RowMajor : ColMajor,
bool(ei_blas_traits<MatrixType>::ActualAccess)>::run(*this, dst, alpha);
}
-
-private:
- GeneralProduct& operator=(const GeneralProduct&);
};
// The vector is on the left => transposition
diff --git a/Eigen/src/Core/ProductBase.h b/Eigen/src/Core/ProductBase.h
index 955e87feb..33ada4bee 100644
--- a/Eigen/src/Core/ProductBase.h
+++ b/Eigen/src/Core/ProductBase.h
@@ -129,8 +129,6 @@ class ProductBase : public MatrixBase<Derived>
void coeffRef(int,int);
void coeff(int) const;
void coeffRef(int);
-
- ProductBase& operator=(const ProductBase&);
};
template<typename NestedProduct>
diff --git a/Eigen/src/Core/SelfAdjointView.h b/Eigen/src/Core/SelfAdjointView.h
index 9518a6498..9b6b3261f 100644
--- a/Eigen/src/Core/SelfAdjointView.h
+++ b/Eigen/src/Core/SelfAdjointView.h
@@ -151,9 +151,6 @@ template<typename MatrixType, unsigned int UpLo> class SelfAdjointView
protected:
const typename MatrixType::Nested m_matrix;
-
- private:
- SelfAdjointView& operator=(const SelfAdjointView&);
};
diff --git a/Eigen/src/Core/Swap.h b/Eigen/src/Core/Swap.h
index 45c180983..a7cf219f7 100644
--- a/Eigen/src/Core/Swap.h
+++ b/Eigen/src/Core/Swap.h
@@ -117,9 +117,6 @@ template<typename ExpressionType> class SwapWrapper
protected:
ExpressionType& m_expression;
-
- private:
- SwapWrapper& operator=(const SwapWrapper&);
};
/** swaps *this with the expression \a other.
diff --git a/Eigen/src/Core/util/DisableMSVCWarnings.h b/Eigen/src/Core/util/DisableMSVCWarnings.h
index 18484e490..c11d582fd 100644
--- a/Eigen/src/Core/util/DisableMSVCWarnings.h
+++ b/Eigen/src/Core/util/DisableMSVCWarnings.h
@@ -2,7 +2,8 @@
#ifdef _MSC_VER
// 4273 - QtAlignedMalloc, inconsistent DLL linkage
// 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( disable : 4100 4101 4181 4244 4127 4211 4273 4522 4717 )
#endif
diff --git a/Eigen/src/Geometry/Homogeneous.h b/Eigen/src/Geometry/Homogeneous.h
index f2a2fe73e..229fd80b3 100644
--- a/Eigen/src/Geometry/Homogeneous.h
+++ b/Eigen/src/Geometry/Homogeneous.h
@@ -241,8 +241,6 @@ struct ei_homogeneous_left_product_impl<Homogeneous<MatrixType,Vertical>,Lhs>
const typename Lhs::Nested m_lhs;
const typename MatrixType::Nested m_rhs;
-private:
- ei_homogeneous_left_product_impl& operator=(const ei_homogeneous_left_product_impl&);
};
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 Rhs::Nested m_rhs;
-
-private:
- ei_homogeneous_right_product_impl& operator=(const ei_homogeneous_right_product_impl&);
};
#endif // EIGEN_HOMOGENEOUS_H
diff --git a/Eigen/src/Householder/HouseholderSequence.h b/Eigen/src/Householder/HouseholderSequence.h
index 1159f03ed..25e962001 100644
--- a/Eigen/src/Householder/HouseholderSequence.h
+++ b/Eigen/src/Householder/HouseholderSequence.h
@@ -161,9 +161,6 @@ template<typename VectorsType, typename CoeffsType> class HouseholderSequence
typename CoeffsType::Nested m_coeffs;
bool m_trans;
int m_actualVectors;
-
-private:
- HouseholderSequence& operator=(const HouseholderSequence&);
};
template<typename VectorsType, typename CoeffsType>
diff --git a/Eigen/src/LU/FullPivLU.h b/Eigen/src/LU/FullPivLU.h
index 5505d3bee..1358c9490 100644
--- a/Eigen/src/LU/FullPivLU.h
+++ b/Eigen/src/LU/FullPivLU.h
@@ -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 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() *****************************************************/
@@ -602,9 +599,6 @@ struct ei_image_retval<FullPivLU<_MatrixType> >
for(int i = 0; i < rank(); ++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() *****************************************************/
@@ -665,9 +659,6 @@ struct ei_solve_retval<FullPivLU<_MatrixType>, Rhs>
for(int i = nonzero_pivots; i < dec().matrixLU().cols(); ++i)
dst.row(dec().permutationQ().indices().coeff(i)).setZero();
}
-
-private:
- ei_solve_retval& operator=(const ei_solve_retval&);
};
/******* MatrixBase methods *****************************************************************/
diff --git a/Eigen/src/LU/Inverse.h b/Eigen/src/LU/Inverse.h
index c31b3502e..8afbfda96 100644
--- a/Eigen/src/LU/Inverse.h
+++ b/Eigen/src/LU/Inverse.h
@@ -258,8 +258,6 @@ struct ei_inverse_impl : public ReturnByValue<ei_inverse_impl<MatrixType> >
{
ei_compute_inverse<MatrixTypeNestedCleaned, Dest>::run(m_matrix, dst);
}
-private:
- ei_inverse_impl& operator=(const ei_inverse_impl&);
};
/** \lu_module
diff --git a/Eigen/src/QR/HouseholderQR.h b/Eigen/src/QR/HouseholderQR.h
index 3b174a873..95496b943 100644
--- a/Eigen/src/QR/HouseholderQR.h
+++ b/Eigen/src/QR/HouseholderQR.h
@@ -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(BottomLeft, cols-rank, c.cols()).setZero();
}
-private:
- ei_solve_retval& operator=(const ei_solve_retval&);
};
#endif // EIGEN_HIDE_HEAVY_CODE
diff --git a/Eigen/src/SVD/SVD.h b/Eigen/src/SVD/SVD.h
index a90704cb9..0ec41e36d 100644
--- a/Eigen/src/SVD/SVD.h
+++ b/Eigen/src/SVD/SVD.h
@@ -456,8 +456,6 @@ struct ei_solve_retval<SVD<_MatrixType>, Rhs>
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.
diff --git a/Eigen/src/Sparse/AmbiVector.h b/Eigen/src/Sparse/AmbiVector.h
index 5e75bd6e7..2988999d6 100644
--- a/Eigen/src/Sparse/AmbiVector.h
+++ b/Eigen/src/Sparse/AmbiVector.h
@@ -126,10 +126,6 @@ template<typename _Scalar> class AmbiVector
int m_llStart;
int m_llCurrent;
int m_llSize;
-
- private:
- AmbiVector(const AmbiVector&);
-
};
/** \returns the number of non zeros in the current sub vector */
diff --git a/Eigen/src/Sparse/DynamicSparseMatrix.h b/Eigen/src/Sparse/DynamicSparseMatrix.h
index 00386442c..3ce5e84da 100644
--- a/Eigen/src/Sparse/DynamicSparseMatrix.h
+++ b/Eigen/src/Sparse/DynamicSparseMatrix.h
@@ -320,12 +320,8 @@ class DynamicSparseMatrix<Scalar,_Flags>::InnerIterator : public SparseVector<Sc
inline int row() const { return IsRowMajor ? m_outer : Base::index(); }
inline int col() const { return IsRowMajor ? Base::index() : m_outer; }
-
protected:
const int m_outer;
-
- private:
- InnerIterator& operator=(InnerIterator&);
};
#endif // EIGEN_DYNAMIC_SPARSEMATRIX_H
diff --git a/Eigen/src/Sparse/SparseBlock.h b/Eigen/src/Sparse/SparseBlock.h
index 1fe919736..6659a88e2 100644
--- a/Eigen/src/Sparse/SparseBlock.h
+++ b/Eigen/src/Sparse/SparseBlock.h
@@ -220,8 +220,6 @@ class SparseInnerVectorSet<SparseMatrix<_Scalar, _Options>, Size>
inline int col() const { return IsRowMajor ? this->index() : m_outer; }
protected:
int m_outer;
- private:
- InnerIterator& operator=(const InnerIterator&);
};
inline SparseInnerVectorSet(const MatrixType& matrix, int outerStart, int outerSize)
diff --git a/Eigen/src/Sparse/SparseCwise.h b/Eigen/src/Sparse/SparseCwise.h
index c2e302956..bf8f2355c 100644
--- a/Eigen/src/Sparse/SparseCwise.h
+++ b/Eigen/src/Sparse/SparseCwise.h
@@ -156,9 +156,6 @@ template<typename ExpressionType> class SparseCwise
protected:
ExpressionTypeNested m_matrix;
-
- private:
- SparseCwise& operator=(const SparseCwise&);
};
template<typename Derived>
diff --git a/Eigen/src/Sparse/SparseCwiseBinaryOp.h b/Eigen/src/Sparse/SparseCwiseBinaryOp.h
index 01f4da197..2dcd6b944 100644
--- a/Eigen/src/Sparse/SparseCwiseBinaryOp.h
+++ b/Eigen/src/Sparse/SparseCwiseBinaryOp.h
@@ -126,9 +126,6 @@ class SparseCwiseBinaryOp<BinaryOp,Lhs,Rhs>::InnerIterator
EIGEN_STRONG_INLINE InnerIterator(const SparseCwiseBinaryOp& binOp, int 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;
Scalar m_value;
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)
@@ -255,8 +250,6 @@ class ei_sparse_cwise_binary_op_inner_iterator_selector<ei_scalar_product_op<T>,
LhsIterator m_lhsIter;
RhsIterator m_rhsIter;
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)
@@ -297,9 +290,6 @@ class ei_sparse_cwise_binary_op_inner_iterator_selector<ei_scalar_product_op<T>,
LhsIterator m_lhsIter;
const BinaryFunc m_functor;
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)
diff --git a/Eigen/src/Sparse/SparseCwiseUnaryOp.h b/Eigen/src/Sparse/SparseCwiseUnaryOp.h
index 9c102ed64..9a73374bd 100644
--- a/Eigen/src/Sparse/SparseCwiseUnaryOp.h
+++ b/Eigen/src/Sparse/SparseCwiseUnaryOp.h
@@ -90,9 +90,6 @@ class SparseCwiseUnaryOp<UnaryOp,MatrixType>::InnerIterator
protected:
MatrixTypeIterator m_iter;
const UnaryOp m_functor;
-
- private:
- InnerIterator& operator=(const InnerIterator&);
};
template<typename Derived>
diff --git a/Eigen/src/Sparse/SparseDiagonalProduct.h b/Eigen/src/Sparse/SparseDiagonalProduct.h
index 24f724ad1..e9ba47f70 100644
--- a/Eigen/src/Sparse/SparseDiagonalProduct.h
+++ b/Eigen/src/Sparse/SparseDiagonalProduct.h
@@ -133,8 +133,6 @@ class ei_sparse_diagonal_product_inner_iterator_selector
const SparseDiagonalProductType& expr, int outer)
: 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>
@@ -167,8 +165,6 @@ class ei_sparse_diagonal_product_inner_iterator_selector
const SparseDiagonalProductType& expr, int outer)
: 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
diff --git a/Eigen/src/Sparse/SparseFlagged.h b/Eigen/src/Sparse/SparseFlagged.h
index 34233e5a1..386a80abc 100644
--- a/Eigen/src/Sparse/SparseFlagged.h
+++ b/Eigen/src/Sparse/SparseFlagged.h
@@ -64,9 +64,6 @@ template<typename ExpressionType, unsigned int Added, unsigned int Removed> clas
protected:
ExpressionTypeNested m_matrix;
-
- private:
- SparseFlagged& operator=(const SparseFlagged&);
};
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)
: ExpressionType::InnerIterator(xpr.m_matrix, outer)
{}
-
- private:
- InnerIterator& operator=(const InnerIterator&);
};
template<typename ExpressionType, unsigned int Added, unsigned int Removed>
diff --git a/Eigen/src/Sparse/SparseMatrix.h b/Eigen/src/Sparse/SparseMatrix.h
index e1c740cdb..8369bba54 100644
--- a/Eigen/src/Sparse/SparseMatrix.h
+++ b/Eigen/src/Sparse/SparseMatrix.h
@@ -557,9 +557,6 @@ class SparseMatrix<Scalar,_Options>::InnerIterator
int m_id;
const int m_start;
const int m_end;
-
- private:
- InnerIterator& operator=(const InnerIterator&);
};
#endif // EIGEN_SPARSEMATRIX_H
diff --git a/Eigen/src/Sparse/SparseTranspose.h b/Eigen/src/Sparse/SparseTranspose.h
index 2689caf79..9a702739d 100644
--- a/Eigen/src/Sparse/SparseTranspose.h
+++ b/Eigen/src/Sparse/SparseTranspose.h
@@ -62,9 +62,6 @@ template<typename MatrixType> class SparseTranspose
protected:
const typename MatrixType::Nested m_matrix;
-
- private:
- SparseTranspose& operator=(const SparseTranspose&);
};
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 col() const { return Base::row(); }
-
- private:
- InnerIterator& operator=(const InnerIterator&);
};
template<typename MatrixType> class SparseTranspose<MatrixType>::ReverseInnerIterator : public MatrixType::ReverseInnerIterator
diff --git a/Eigen/src/Sparse/SparseTriangular.h b/Eigen/src/Sparse/SparseTriangular.h
index c3d3ea48f..42e7ff02a 100644
--- a/Eigen/src/Sparse/SparseTriangular.h
+++ b/Eigen/src/Sparse/SparseTriangular.h
@@ -47,9 +47,6 @@ template<typename ExpressionType, int Mode> class SparseTriangular
protected:
ExpressionTypeNested m_matrix;
-
- private:
- SparseTriangular& operator=(const SparseTriangular&);
};
template<typename Derived>
diff --git a/Eigen/src/misc/Image.h b/Eigen/src/misc/Image.h
index 05ffa667c..2f39d6b9d 100644
--- a/Eigen/src/misc/Image.h
+++ b/Eigen/src/misc/Image.h
@@ -70,9 +70,6 @@ template<typename _DecompositionType> struct ei_image_retval_base
const DecompositionType& m_dec;
int m_rank, m_cols;
const MatrixType& m_originalMatrix;
-
- private:
- ei_image_retval_base& operator=(const ei_image_retval_base&);
};
#define EIGEN_MAKE_IMAGE_HELPERS(DecompositionType) \
diff --git a/Eigen/src/misc/Kernel.h b/Eigen/src/misc/Kernel.h
index bb8458e11..908c408e9 100644
--- a/Eigen/src/misc/Kernel.h
+++ b/Eigen/src/misc/Kernel.h
@@ -69,9 +69,6 @@ template<typename _DecompositionType> struct ei_kernel_retval_base
protected:
const DecompositionType& m_dec;
int m_rank, m_cols;
-
- private:
- ei_kernel_retval_base& operator=(const ei_kernel_retval_base&);
};
#define EIGEN_MAKE_KERNEL_HELPERS(DecompositionType) \
diff --git a/Eigen/src/misc/Solve.h b/Eigen/src/misc/Solve.h
index 75597564b..4ab0775fc 100644
--- a/Eigen/src/misc/Solve.h
+++ b/Eigen/src/misc/Solve.h
@@ -63,9 +63,6 @@ template<typename _DecompositionType, typename Rhs> struct ei_solve_retval_base
protected:
const DecompositionType& m_dec;
const typename Rhs::Nested m_rhs;
-
- private:
- ei_solve_retval_base& operator=(const ei_solve_retval_base&);
};
#define EIGEN_MAKE_SOLVE_HELPERS(DecompositionType,Rhs) \