]> gitweb.michael.orlitzky.com - sage.d.git/blobdiff - mjo/eja/euclidean_jordan_algebra.py
eja: replace the Hom stuff with a custom EJA operator class.
[sage.d.git] / mjo / eja / euclidean_jordan_algebra.py
index cc356dc0ff7e6a94186d4d809ae937c01f0a3e6c..31717eeeb8e6b9daf37f8992eaa7f52fc1127470 100644 (file)
@@ -7,359 +7,235 @@ what can be supported in a general Jordan Algebra.
 
 from sage.categories.finite_dimensional_algebras_with_basis import FiniteDimensionalAlgebrasWithBasis
 from sage.categories.morphism import SetMorphism
+from sage.modules.vector_space_morphism import VectorSpaceMorphism
 from sage.structure.element import is_Matrix
 from sage.structure.category_object import normalize_names
 
 from sage.algebras.finite_dimensional_algebras.finite_dimensional_algebra import FiniteDimensionalAlgebra
 from sage.algebras.finite_dimensional_algebras.finite_dimensional_algebra_element import FiniteDimensionalAlgebraElement
-from sage.algebras.finite_dimensional_algebras.finite_dimensional_algebra_morphism import FiniteDimensionalAlgebraMorphism, FiniteDimensionalAlgebraHomset
 
 
-class FiniteDimensionalEuclideanJordanAlgebraHomset(FiniteDimensionalAlgebraHomset):
-
-    def has_coerce_map_from(self, S):
-        """
-        EXAMPLES::
-
-            sage: J = RealSymmetricEJA(2)
-            sage: H = J.Hom(J)
-            sage: H.has_coerce_map_from(QQ)
-            True
-
-        """
-        try:
-            # The Homset classes override has_coerce_map_from() with
-            # something that crashes when it's given e.g. QQ.
-            if S.is_subring(self.codomain().base_ring()):
-                return True
-        except:
-            pclass = super(FiniteDimensionalEuclideanJordanAlgebraHomset, self)
-            return pclass.has_coerce_map_from(S)
+class FiniteDimensionalEuclideanJordanAlgebraOperator(VectorSpaceMorphism):
+    def __init__(self, domain_eja, codomain_eja, mat):
+        # We save these so that we can output them as part of our
+        # text representation. Overriding the domain/codomain methods
+        # doesn't work because the EJAs aren't (directly) vector spaces.
+        self._domain_eja = domain_eja
+        self._codomain_eja = codomain_eja
 
-
-    def _coerce_map_from_(self, S):
-        """
-        EXAMPLES::
-
-            sage: J = RealSymmetricEJA(2)
-            sage: H = J.Hom(J)
-            sage: H.coerce(2)
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
-            [2 0 0]
-            [0 2 0]
-            [0 0 2]
-
-        """
-        C = self.codomain()
-        R = C.base_ring()
-        if S.is_subring(R):
-            h = S.hom(self.codomain())
-            return SetMorphism(Hom(S,C), lambda x: h(x).operator())
+        # Otherwise, we just feed everything to the vector space morphism
+        # constructor.
+        V = domain_eja.vector_space()
+        W = codomain_eja.vector_space()
+        homspace = V.Hom(W)
+        VectorSpaceMorphism.__init__(self, homspace, mat)
 
 
     def __call__(self, x):
         """
+        Allow this operator to be called only on elements of an EJA.
+
         EXAMPLES::
 
-            sage: J = RealSymmetricEJA(2)
-            sage: H = J.Hom(J)
-            sage: H(2)
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
-            [2 0 0]
-            [0 2 0]
-            [0 0 2]
+            sage: J = JordanSpinEJA(3)
+            sage: x = J.linear_combination(zip(range(len(J.gens())), J.gens()))
+            sage: id = identity_matrix(J.base_ring(), J.dimension())
+            sage: f = FiniteDimensionalEuclideanJordanAlgebraOperator(J,J,id)
+            sage: f(x) == x
+            True
 
         """
-        if x in self.base_ring():
-            cols = self.domain().dimension()
-            rows = self.codomain().dimension()
-            x = x*identity_matrix(self.codomain().base_ring(), rows, cols)
-        return FiniteDimensionalEuclideanJordanAlgebraMorphism(self, x)
-
-
-class FiniteDimensionalEuclideanJordanAlgebraMorphism(FiniteDimensionalAlgebraMorphism):
-    """
-    A linear map between two finite-dimensional EJAs.
+        # Overriding the single-underscore _call_ didn't work?
+        if x not in self._domain_eja:
+            raise ValueError("argument does not live in the operator's domain")
+        return self._codomain_eja(self.matrix()*x.vector())
 
-    This is a very thin wrapper around FiniteDimensionalAlgebraMorphism
-    that does only a few things:
 
-      1. Avoids the ``unitary`` and ``check`` arguments to the constructor
-         that will always be ``False``. This is necessary because these
-         are homomorphisms with respect to ADDITION, but the SageMath
-         machinery wants to check that they're homomorphisms with respect
-         to (Jordan) MULTIPLICATION. That obviously doesn't work.
-
-      2. Inputs and outputs the underlying matrix with respect to COLUMN
-         vectors, unlike the parent class.
-
-      3. Allows us to add, subtract, negate, multiply (compose), and
-         invert morphisms in the obvious way.
+    def _repr_(self):
+        r"""
 
-    If this seems a bit heavyweight, it is. I would have been happy to
-    use a the ring morphism that underlies the finite-dimensional
-    algebra morphism, but they don't seem to be callable on elements of
-    our EJA, and you can't add/multiply/etc. them.
-    """
-    def _add_(self, other):
-        """
-        Add two EJA morphisms in the obvious way.
+        A text representation of this linear operator on a Euclidean
+        Jordan Algebra.
 
         EXAMPLES::
 
-            sage: J = RealSymmetricEJA(3)
-            sage: x = J.zero()
-            sage: y = J.one()
-            sage: x.operator() + y.operator()
-            Morphism from Euclidean Jordan algebra of degree 6 over Rational
-            Field to Euclidean Jordan algebra of degree 6 over Rational Field
-            given by matrix
-            [1 0 0 0 0 0]
-            [0 1 0 0 0 0]
-            [0 0 1 0 0 0]
-            [0 0 0 1 0 0]
-            [0 0 0 0 1 0]
-            [0 0 0 0 0 1]
-
-        TESTS::
-
-            sage: set_random_seed()
-            sage: J = random_eja()
-            sage: x = J.random_element()
-            sage: y = J.random_element()
-            sage: (x.operator() + y.operator()) in J.Hom(J)
-            True
+            sage: J = JordanSpinEJA(2)
+            sage: id = identity_matrix(J.base_ring(), J.dimension())
+            sage: FiniteDimensionalEuclideanJordanAlgebraOperator(J,J,id)
+            Linear operator between finite-dimensional Euclidean Jordan
+            algebras represented by the matrix:
+            [1 0]
+            [0 1]
+            Domain: Euclidean Jordan algebra of degree 2 over Rational Field
+            Codomain: Euclidean Jordan algebra of degree 2 over Rational Field
 
         """
-        P = self.parent()
-        if not other in P:
-            raise ValueError("summands must live in the same space")
+        msg = ("Linear operator between finite-dimensional Euclidean Jordan "
+                "algebras represented by the matrix:\n",
+               "{!r}\n",
+               "Domain: {}\n",
+               "Codomain: {}")
+        return ''.join(msg).format(self.matrix(),
+                                   self._domain_eja,
+                                   self._codomain_eja)
 
-        return FiniteDimensionalEuclideanJordanAlgebraMorphism(
-                  P,
-                  self.matrix() + other.matrix() )
 
+    def __add__(self, other):
+        """
+        Add the ``other`` EJA operator to this one.
 
-    def __init__(self, parent, f):
-        FiniteDimensionalAlgebraMorphism.__init__(self,
-                                                  parent,
-                                                  f.transpose(),
-                                                  unitary=False,
-                                                  check=False)
+        EXAMPLES:
 
-
-    def __invert__(self):
-        """
-        EXAMPLES::
+        When we add two EJA operators, we get another one back::
 
             sage: J = RealSymmetricEJA(2)
-            sage: x = J.linear_combination(zip(range(len(J.gens())), J.gens()))
-            sage: x.is_invertible()
-            True
-            sage: ~x.operator()
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
-            [-3/2    2 -1/2]
-            [   1    0    0]
-            [-1/2    0  1/2]
-            sage: x.operator_matrix().inverse()
-            [-3/2    2 -1/2]
-            [   1    0    0]
-            [-1/2    0  1/2]
-
-        TESTS::
-
-            sage: set_random_seed()
-            sage: J = random_eja()
-            sage: x = J.random_element()
-            sage: not x.is_invertible() or (
-            ....:   (~x.operator()).matrix() == x.operator_matrix().inverse() )
-            True
+            sage: id = identity_matrix(J.base_ring(), J.dimension())
+            sage: f = FiniteDimensionalEuclideanJordanAlgebraOperator(J,J,id)
+            sage: g = FiniteDimensionalEuclideanJordanAlgebraOperator(J,J,id)
+            sage: f + g
+            Linear operator between finite-dimensional Euclidean Jordan
+            algebras represented by the matrix:
+            [2 0 0]
+            [0 2 0]
+            [0 0 2]
+            Domain: Euclidean Jordan algebra of degree 3 over Rational Field
+            Codomain: Euclidean Jordan algebra of degree 3 over Rational Field
+
+        If you try to add two identical vector space operators but on
+        different EJAs, that should blow up::
+
+            sage: J1 = RealSymmetricEJA(2)
+            sage: J2 = JordanSpinEJA(3)
+            sage: id = identity_matrix(QQ, 3)
+            sage: f = FiniteDimensionalEuclideanJordanAlgebraOperator(J1,J1,id)
+            sage: g = FiniteDimensionalEuclideanJordanAlgebraOperator(J2,J2,id)
+            sage: f + g
+            Traceback (most recent call last):
+            ...
+            ValueError: operator (co)domains must match
 
         """
-        A = self.matrix()
-        if not A.is_invertible():
-            raise ValueError("morphism is not invertible")
+        if not (self._domain_eja == other._domain_eja and
+                self._codomain_eja == other._codomain_eja):
+            raise ValueError("operator (co)domains must match")
+        return FiniteDimensionalEuclideanJordanAlgebraOperator(
+                self._domain_eja,
+                self._codomain_eja,
+                VectorSpaceMorphism.__add__(self,other))
 
-        P = self.parent()
-        return FiniteDimensionalEuclideanJordanAlgebraMorphism(self.parent(),
-                                                                A.inverse())
 
-    def _lmul_(self, right):
+    def __invert__(self):
         """
-        Compose two EJA morphisms using multiplicative notation.
+        Invert this EJA operator.
 
         EXAMPLES::
 
             sage: J = RealSymmetricEJA(2)
-            sage: x = J.zero()
-            sage: y = J.one()
-            sage: x.operator() * y.operator()
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
-            [0 0 0]
-            [0 0 0]
-            [0 0 0]
-
-        ::
-
-            sage: J = RealSymmetricEJA(2)
-            sage: x = J.linear_combination(zip(range(len(J.gens())), J.gens()))
-            sage: x.operator()
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
-            [  0   1   0]
-            [1/2   1 1/2]
-            [  0   1   2]
-            sage: 2*x.operator()
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
-            [0 2 0]
-            [1 2 1]
-            [0 2 4]
-            sage: x.operator()*2
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
-            [0 2 0]
-            [1 2 1]
-            [0 2 4]
-
-        TESTS::
-
-            sage: set_random_seed()
-            sage: J = random_eja()
-            sage: x = J.random_element()
-            sage: y = J.random_element()
-            sage: (x.operator() * y.operator()) in J.Hom(J)
-            True
+            sage: id = identity_matrix(J.base_ring(), J.dimension())
+            sage: f = FiniteDimensionalEuclideanJordanAlgebraOperator(J,J,id)
+            sage: ~f
+            Linear operator between finite-dimensional Euclidean Jordan
+            algebras represented by the matrix:
+            [1 0 0]
+            [0 1 0]
+            [0 0 1]
+            Domain: Euclidean Jordan algebra of degree 3 over Rational Field
+            Codomain: Euclidean Jordan algebra of degree 3 over Rational Field
 
         """
-        try:
-            # I think the morphism classes break the coercion framework
-            # somewhere along the way, so we have to do this ourselves.
-            right = self.parent().coerce(right)
-        except:
-            pass
+        return FiniteDimensionalEuclideanJordanAlgebraOperator(
+                self._codomain_eja,
+                self._domain_eja,
+                VectorSpaceMorphism.__invert__(self))
 
-        if not right.codomain() is self.domain():
-            raise ValueError("(co)domains must agree for composition")
+    def __mul__(self, other):
+        """
+        Compose this EJA operator with the ``other`` one, or scale it by
+        an element of its base ring.
+        """
+        if other in self._codomain_eja.base_ring():
+            return FiniteDimensionalEuclideanJordanAlgebraOperator(
+                self._domain_eja,
+                self._codomain_eja,
+                self._matrix*other)
 
-        return FiniteDimensionalEuclideanJordanAlgebraMorphism(
-                 self.parent(),
-                 self.matrix()*right.matrix() )
+        if not (self._domain_eja == other._codomain_eja):
+            raise ValueError("operator (co)domains must be compatible")
 
-    __mul__ = _lmul_
+        return FiniteDimensionalEuclideanJordanAlgebraOperator(
+                other._domain_eja,
+                self._codomain_eja,
+                VectorSpaceMorphism.__mul__(self,other))
 
 
-    def _neg_(self):
+    def __neg__(self):
         """
-        Negate this morphism.
+        Negate this EJA operator.
 
         EXAMPLES::
 
             sage: J = RealSymmetricEJA(2)
-            sage: x = J.one()
-            sage: -x.operator()
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational Field
-            given by matrix
+            sage: id = identity_matrix(J.base_ring(), J.dimension())
+            sage: f = FiniteDimensionalEuclideanJordanAlgebraOperator(J,J,id)
+            sage: -f
+            Linear operator between finite-dimensional Euclidean Jordan
+            algebras represented by the matrix:
             [-1  0  0]
             [ 0 -1  0]
             [ 0  0 -1]
-
-        TESTS::
-
-            sage: set_random_seed()
-            sage: J = random_eja()
-            sage: x = J.random_element()
-            sage: -x.operator() in J.Hom(J)
-            True
+            Domain: Euclidean Jordan algebra of degree 3 over Rational Field
+            Codomain: Euclidean Jordan algebra of degree 3 over Rational Field
 
         """
-        return FiniteDimensionalEuclideanJordanAlgebraMorphism(
-                  self.parent(),
-                  -self.matrix() )
+        return FiniteDimensionalEuclideanJordanAlgebraOperator(
+                self._domain_eja,
+                self._codomain_eja,
+                VectorSpaceMorphism.__neg__(self))
 
 
-    def _repr_(self):
+    def __pow__(self, n):
         """
-        We override only the representation that is shown to the user,
-        because we want the matrix to be with respect to COLUMN vectors.
+        Raise this EJA operator to the power ``n``.
 
         TESTS:
 
-        Ensure that we see the transpose of the underlying matrix object:
-
-            sage: J = RealSymmetricEJA(3)
-            sage: x = J.linear_combination(zip(range(len(J.gens())), J.gens()))
-            sage: L = x.operator()
-            sage: L
-            Morphism from Euclidean Jordan algebra of degree 6 over Rational
-            Field to Euclidean Jordan algebra of degree 6 over Rational Field
-            given by matrix
-            [  0   1   2   0   0   0]
-            [1/2 3/2   2 1/2   1   0]
-            [  1   2 5/2   0 1/2   1]
-            [  0   1   0   3   4   0]
-            [  0   1 1/2   2   4   2]
-            [  0   0   2   0   4   5]
-            sage: L._matrix
-            [  0 1/2   1   0   0   0]
-            [  1 3/2   2   1   1   0]
-            [  2   2 5/2   0 1/2   2]
-            [  0 1/2   0   3   2   0]
-            [  0   1 1/2   4   4   4]
-            [  0   0   1   0   2   5]
-
-        """
-        return "Morphism from {} to {} given by matrix\n{}".format(
-            self.domain(), self.codomain(), self.matrix())
-
-
-    def __sub__(self, other):
-        """
-        Subtract one morphism from another using addition and negation.
-
-        EXAMPLES::
+        Ensure that we get back another EJA operator that can be added,
+        subtracted, et cetera::
 
             sage: J = RealSymmetricEJA(2)
-            sage: L1 = J.one().operator()
-            sage: L1 - L1
-            Morphism from Euclidean Jordan algebra of degree 3 over Rational
-            Field to Euclidean Jordan algebra of degree 3 over Rational
-            Field given by matrix
-            [0 0 0]
-            [0 0 0]
-            [0 0 0]
-
-        TESTS::
-
-            sage: set_random_seed()
-            sage: J = random_eja()
-            sage: x = J.random_element()
-            sage: y = J.random_element()
-            sage: x.operator() - y.operator() in J.Hom(J)
-            True
+            sage: id = identity_matrix(J.base_ring(), J.dimension())
+            sage: f = FiniteDimensionalEuclideanJordanAlgebraOperator(J,J,id)
+            sage: f^0 + f^1 + f^2
+            Linear operator between finite-dimensional Euclidean Jordan
+            algebras represented by the matrix:
+            [3 0 0]
+            [0 3 0]
+            [0 0 3]
+            Domain: Euclidean Jordan algebra of degree 3 over Rational Field
+            Codomain: Euclidean Jordan algebra of degree 3 over Rational Field
 
         """
-        return self + (-other)
+        if (n == 1):
+            return self
+        elif (n == 0):
+            # Raising a vector space morphism to the zero power gives
+            # you back a special IdentityMorphism that is useless to us.
+            rows = self.codomain().dimension()
+            cols = self.domain().dimension()
+            mat = matrix.identity(self.base_ring(), rows, cols)
+        else:
+            mat = VectorSpaceMorphism.__pow__(self,n)
 
+        return FiniteDimensionalEuclideanJordanAlgebraOperator(
+                 self._domain_eja,
+                 self._codomain_eja,
+                 mat)
 
-    def matrix(self):
+    def __sub__(self, other):
         """
-        Return the matrix of this morphism with respect to a left-action
-        on column vectors.
+        Subtract ``other`` from this EJA operator.
         """
-        return FiniteDimensionalAlgebraMorphism.matrix(self).transpose()
+        return (self + (-other))
 
 
 class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
@@ -398,15 +274,6 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
                                  natural_basis=natural_basis)
 
 
-    def _Hom_(self, B, cat):
-        """
-        Construct a homset of ``self`` and ``B``.
-        """
-        return FiniteDimensionalEuclideanJordanAlgebraHomset(self,
-                                                             B,
-                                                             category=cat)
-
-
     def __init__(self,
                  field,
                  mult_table,
@@ -468,7 +335,7 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
         determinant).
         """
         z = self._a_regular_element()
-        V = z.vector().parent().ambient_vector_space()
+        V = self.vector_space()
         V1 = V.span_of_basis( (z**k).vector() for k in range(self.rank()) )
         b =  (V1.basis() + V1.complement().basis())
         return V.span_of_basis(b)
@@ -693,6 +560,19 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
         else:
             return self._rank
 
+    def vector_space(self):
+        """
+        Return the vector space that underlies this algebra.
+
+        EXAMPLES::
+
+            sage: J = RealSymmetricEJA(2)
+            sage: J.vector_space()
+            Vector space of dimension 3 over Rational Field
+
+        """
+        return self.zero().vector().parent().ambient_vector_space()
+
 
     class Element(FiniteDimensionalAlgebraElement):
         """
@@ -1041,12 +921,12 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
                 sage: n = ZZ.random_element(1,10)
                 sage: J = JordanSpinEJA(n)
                 sage: x = J.random_element()
-                sage: while x.is_zero():
+                sage: while not x.is_invertible():
                 ....:     x = J.random_element()
                 sage: x_vec = x.vector()
                 sage: x0 = x_vec[0]
                 sage: x_bar = x_vec[1:]
-                sage: coeff = 1/(x0^2 - x_bar.inner_product(x_bar))
+                sage: coeff = ~(x0^2 - x_bar.inner_product(x_bar))
                 sage: inv_vec = x_vec.parent()([x0] + (-x_bar).list())
                 sage: x_inverse = coeff*inv_vec
                 sage: x.inverse() == J(x_inverse)
@@ -1089,8 +969,7 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
             if not self.is_invertible():
                 raise ValueError("element is not invertible")
 
-            P = self.parent()
-            return P(self.quadratic_representation().inverse()*self.vector())
+            return (~self.quadratic_representation())(self)
 
 
         def is_invertible(self):
@@ -1380,8 +1259,8 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
 
             """
             P = self.parent()
-            return FiniteDimensionalEuclideanJordanAlgebraMorphism(
-                     Hom(P,P),
+            return FiniteDimensionalEuclideanJordanAlgebraOperator(
+                     P,P,
                      self.operator_matrix() )
 
 
@@ -1447,6 +1326,15 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
                 sage: bool(lhs == rhs)
                 True
 
+            Ensure that our operator's ``matrix`` method agrees with
+            this implementation::
+
+                sage: set_random_seed()
+                sage: J = random_eja()
+                sage: x = J.random_element()
+                sage: x.operator().matrix() == x.operator_matrix()
+                True
+
             """
             fda_elt = FiniteDimensionalAlgebraElement(self.parent(), self)
             return fda_elt.matrix().transpose()
@@ -1475,7 +1363,7 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
                 sage: D = (x0^2 - x_bar.inner_product(x_bar))*D
                 sage: D = D + 2*x_bar.tensor_product(x_bar)
                 sage: Q = block_matrix(2,2,[A,B,C,D])
-                sage: Q == x.quadratic_representation().operator_matrix()
+                sage: Q == x.quadratic_representation().matrix()
                 True
 
             Test all of the properties from Theorem 11.2 in Alizadeh::
@@ -1498,10 +1386,10 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
                 sage: 2*Qxy == (x+y).quadratic_representation() - Qx - Qy
                 True
 
-            Property 2:
+            Property 2 (multiply on the right for :trac:`28272`):
 
                 sage: alpha = QQ.random_element()
-                sage: (alpha*x).quadratic_representation() == (alpha^2)*Qx
+                sage: (alpha*x).quadratic_representation() == Qx*(alpha^2)
                 True
 
             Property 3:
@@ -1578,7 +1466,7 @@ class FiniteDimensionalEuclideanJordanAlgebra(FiniteDimensionalAlgebra):
             #
             # We do the extra ambient_vector_space() in case we're messing
             # with polynomials and the direct parent is a module.
-            V = self.vector().parent().ambient_vector_space()
+            V = self.parent().vector_space()
             return V.span( (self**d).vector() for d in xrange(V.dimension()) )