DeRhamComputation/superelliptic.ipynb

2.0 MiB
Raw Blame History

class superelliptic:
    def __init__(self, f, m, p):
        Rx.<x> = PolynomialRing(GF(p))
        Rxy.<x, y> = PolynomialRing(GF(p), 2)
        Fxy = FractionField(Rxy)
        self.polynomial = Rx(f)
        self.exponent = m
        self.characteristic = p
        
        r = Rx(f).degree()
        delta = GCD(r, m)
        #########basis of holomorphic differentials and de Rham
                
        basis_holo = {}
        basis = {}
        degrees0 = {}
        degrees1 = {}
        k = 0
        
        for j in range(1, m):
            for i in range(1, r):
                if (r*j - m*i >= delta):
                    basis_holo[k] = superelliptic_form(self, Fxy(x^(i-1)/y^j))
                    basis[k] = superelliptic_cech(self, basis_holo[k], superelliptic_function(self, Rx(0))) 
                    degrees0[k] = (i-1, j)
                    k = k+1
        self.basis_holomorphic_differentials=basis_holo
        ## non-holomorphic elts of H^1_dR
        t = len(basis)
        
        for j in range(1, m):
            for i in range(1, r):
                if (r*(m-j) - m*i >= delta):
                    s = Rx(m-j)*Rx(x)*Rx(f.derivative()) - Rx(m)*Rx(i)*f
                    psi = Rx(cut(s, i))
                    basis[t] = superelliptic_cech(self, superelliptic_form(self, Fxy(psi/y^j)), superelliptic_function(self, Fxy(m*y^(m-j)/x^i)))
                    degrees0[t] = (psi.degree(), j)
                    degrees1[t] = (-i, m-j)
                    t += 1
        self.degree_de_rham0 = degrees0
        self.degree_de_rham1 = degrees1
        self.basis_de_rham = basis
        
    def __repr__(self):
        f = self.polynomial
        m = self.exponent
        p = self.characteristic
        return 'Superelliptic curve with the equation y^' + str(m) + ' = ' + str(f)+' over finite field with ' + str(p) + ' elements.'
    
    def is_smooth(self):
        f = self.polynomial
        if f.discriminant() == 0:
            return 0
        return 1
    
    def genus(self):
        r = self.polynomial.degree()
        m = self.exponent
        delta = GCD(r, m)
        return 1/2*((r-1)*(m-1) - delta + 1)
    
    def basis_holomorphic_differentials(self, j = 'all'):
        f = self.polynomial
        m = self.exponent
        p = self.characteristic
        r = f.degree()
        delta = GCD(r, m)
    
    def verschiebung_matrix(self):
        basis = self.basis_de_rham
        g = self.genus()
        p = self.characteristic
        M = matrix(GF(p), 2*g, 2*g)
        for i, w in basis.items():
            v = w.verschiebung().coordinates()
            M[i, :] = v
        return M
    
    def frobenius_matrix(self):
        basis = self.basis_de_rham
        g = self.genus()
        p = self.characteristic
        M = matrix(GF(p), 2*g, 2*g)
        for i, w in basis.items():
            v = w.frobenius().coordinates()
            M[i, :] = v
        return M
        
def reduction(C, g):
    p = C.characteristic
    Rxy.<x, y> = PolynomialRing(GF(p), 2)
    Fxy = FractionField(Rxy)
    f = C.polynomial
    r = f.degree()
    m = C.exponent
    g = Fxy(g)
    g1 = g.numerator()
    g2 = g.denominator()
    
    Rx.<x> = PolynomialRing(GF(p))
    Fx = FractionField(Rx)
    FxRy.<y> = PolynomialRing(Fx)    
    (A, B, C) = xgcd(FxRy(g2), FxRy(y^m - f))
    g = FxRy(g1*B/A)
    
    while(g.degree(Rxy(y)) >= m):
        d = g.degree(Rxy(y))
        G = coff(g, d)
        i = floor(d/m)
        g = g - G*y^d + f^i * y^(d%m) *G
    
    return(FxRy(g))

def reduction_form(C, g):
    p = C.characteristic
    Rxy.<x, y> = PolynomialRing(GF(p), 2)
    Fxy = FractionField(Rxy)
    f = C.polynomial
    r = f.degree()
    m = C.exponent
    g = reduction(C, g)

    g1 = Rxy(0)
    Rx.<x> = PolynomialRing(GF(p))
    Fx = FractionField(Rx)
    FxRy.<y> = PolynomialRing(Fx)
    
    g = FxRy(g)
    for j in range(0, m):
        if j==0:
            G = coff(g, 0)
            g1 += FxRy(G)
        else:
            G = coff(g, j)
            g1 += Fxy(y^(j-m)*f*G)
    return(g1)
        
class superelliptic_function:
    def __init__(self, C, g):
        p = C.characteristic
        Rxy.<x, y> = PolynomialRing(GF(p), 2)
        Fxy = FractionField(Rxy)
        f = C.polynomial
        r = f.degree()
        m = C.exponent
        
        self.curve = C
        g = reduction(C, g)
        self.function = g
        
    def __repr__(self):
        return str(self.function)
    
    def jth_component(self, j):
        g = self.function
        C = self.curve
        p = C.characteristic
        Rx.<x> = PolynomialRing(GF(p))
        Fx.<x> = FractionField(Rx)
        FxRy.<y> = PolynomialRing(Fx)
        g = FxRy(g)
        return coff(g, j)
    
    def __add__(self, other):
        C = self.curve
        g1 = self.function
        g2 = other.function
        g = reduction(C, g1 + g2)
        return superelliptic_function(C, g)
    
    def __sub__(self, other):
        C = self.curve
        g1 = self.function
        g2 = other.function
        g = reduction(C, g1 - g2)
        return superelliptic_function(C, g)
    
    def __mul__(self, other):
        C = self.curve
        g1 = self.function
        g2 = other.function
        g = reduction(C, g1 * g2)
        return superelliptic_function(C, g)
    
    def __truediv__(self, other):
        C = self.curve
        g1 = self.function
        g2 = other.function
        g = reduction(C, g1 / g2)
        return superelliptic_function(C, g)
    
def diffn(self):
    C = self.curve
    f = C.polynomial
    m = C.exponent
    p = C.characteristic
    g = self.function
    Rxy.<x, y> = PolynomialRing(GF(p), 2)
    Fxy = FractionField(Rxy)
    g = Fxy(g)
    A = g.derivative(x)
    B = g.derivative(y)*f.derivative(x)/(m*y^(m-1))
    return superelliptic_form(C, A+B)
        
class superelliptic_form:
    def __init__(self, C, g):
        p = C.characteristic
        Rxy.<x, y> = PolynomialRing(GF(p), 2)
        Fxy = FractionField(Rxy)
        g = Fxy(reduction_form(C, g))
        self.form = g
        self.curve = C      
        
    def __add__(self, other):
        C = self.curve
        g1 = self.form
        g2 = other.form
        g = reduction(C, g1 + g2)
        return superelliptic_form(C, g)
    
    def __sub__(self, other):
        C = self.curve
        g1 = self.form
        g2 = other.form
        g = reduction(C, g1 - g2)
        return superelliptic_form(C, g)
    
    def __repr__(self):
        g = self.form
        if len(str(g)) == 1:
            return str(g) + ' dx'
        return '('+str(g) + ') dx'
    
    def cartier(self):
        C = self.curve
        m = C.exponent
        p = C.characteristic
        f = C.polynomial
        Rx.<x> = PolynomialRing(GF(p))
        Fx = FractionField(Rx)
        FxRy.<y> = PolynomialRing(Fx)
        Fxy = FractionField(FxRy)
        result = superelliptic_form(C, FxRy(0))
        mult_order = Integers(m)(p).multiplicative_order()
        M = Integer((p^(mult_order)-1)/m)
        
        for j in range(1, m):
            fct_j = self.jth_component(j)
            h = Rx(fct_j*f^(M*j))
            j1 = (p^(mult_order-1)*j)%m
            B = floor(p^(mult_order-1)*j/m)
            result += superelliptic_form(C, polynomial_part(p, h)/(f^B*y^(j1)))
        return result
    
    def jth_component(self, j):
        g = self.form
        C = self.curve
        p = C.characteristic
        Rx.<x> = PolynomialRing(GF(p))
        Fx = FractionField(Rx)
        FxRy.<y> = PolynomialRing(Fx)
        Fxy = FractionField(FxRy)
        Ryinv.<y_inv> = PolynomialRing(Fx)
        g = Fxy(g)
        g = g(y = 1/y_inv)
        g = Ryinv(g)
        return coff(g, j)
    
    def is_regular_on_U0(self):
        C = self.curve
        p = C.characteristic
        m = C.exponent
        Rx.<x> = PolynomialRing(GF(p))
        for j in range(1, m):
            if self.jth_component(j) not in Rx:
                return 0
        return 1
    
    def is_regular_on_Uinfty(self):
        C = self.curve
        p = C.characteristic
        m = C.exponent
        f = C.polynomial
        r = f.degree()
        delta = GCD(m, r)
        M = m/delta
        R = r/delta
        
        for j in range(1, m):
            A = self.jth_component(j)
            d = degree_of_rational_fctn(A)
            if(-d*M + j*R -(M+1)<0):
                return 0
        return 1
    
    
class superelliptic_cech:
    def __init__(self, C, omega, fct):
        self.omega0 = omega
        self.omega8 = omega - diffn(fct)
        self.f = fct
        self.curve = C
        
    def __add__(self, other):
        C = self.curve
        return superelliptic_cech(C, self.omega0 + other.omega0, self.f + other.f)
    
    def __sub__(self, other):
        C = self.curve
        return superelliptic_cech(C, self.omega0 - other.omega0, self.f - other.f)
    
    def mult(self, constant):
        C = self.curve
        w1 = self.omega0.form
        f1 = self.f.function
        w2 = superelliptic_form(C, constant*w1)
        f2 = superelliptic_function(C, constant*f1)
        return superelliptic_cech(C, w2, f2)
    
    def __repr__(self):
        return "(" + str(self.omega0) + ", " + str(self.f) + ", " + str(self.omega8) + ")" 
    
    def verschiebung(self):
        C = self.curve
        omega = self.omega0
        p = C.characteristic
        Rx.<x> = PolynomialRing(GF(p))
        return superelliptic_cech(C, omega.cartier(), superelliptic_function(C, Rx(0)))
    
    def frobenius(self):
        C = self.curve
        fct = self.f.function
        p = C.characteristic
        Rx.<x> = PolynomialRing(GF(p))
        return superelliptic_cech(C, superelliptic_form(C, Rx(0)), superelliptic_function(C, fct^p))

    def coordinates(self):
        print('coo', self)
        C = self.curve
        p = C.characteristic
        m = C.exponent
        Rx.<x> = PolynomialRing(GF(p))
        Fx = FractionField(Rx)
        FxRy.<y> = PolynomialRing(Fx)
        g = C.genus()
        degrees0 = C.degree_de_rham0
        degrees0_inv = {b:a for a, b in degrees0.items()}        
        degrees1 = C.degree_de_rham1
        degrees1_inv = {b:a for a, b in degrees1.items()}
        basis = C.basis_de_rham
        
        omega = self.omega0
        fct = self.f
        
        if fct.function == Rx(0) and omega.form != Rx(0):
            for j in range(1, m):
                omega_j = Fx(omega.jth_component(j))
                if omega_j != Fx(0):
                    d = degree_of_rational_fctn(omega_j)
                    index = degrees0_inv[(d, j)]
                    a = coeff_of_rational_fctn(omega_j)
                    a1 = coeff_of_rational_fctn(basis[index].omega0.jth_component(j))
                    elt = self - basis[index].mult(a/a1)
                    print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
                    return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(0, 2*g)])
                    
        for j in range(1, m):
            fct_j = Fx(fct.jth_component(j))
            if (fct_j != Rx(0)):
                d = degree_of_rational_fctn(fct_j)
            
                if (d, j) in degrees1.values():
                    index = degrees1_inv[(d, j)]
                    a = coeff_of_rational_fctn(fct_j)
                    elt = self - basis[index].mult(a/m)
                    return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(0, 2*g)])
                
                if d<0:
                    a = coeff_of_rational_fctn(fct_j)
                    h = superelliptic_function(C, FxRy(a*y^j*x^d))
                    elt = superelliptic_cech(C, self.omega0, self.f - h)
                    return elt.coordinates()
            
                if (fct_j != Rx(0)):
                    G = superelliptic_function(C, y^j*x^d)
                    a = coeff_of_rational_fctn(fct_j)
                    elt =self - superelliptic_cech(C, diffn(G), G).mult(a)
                    return elt.coordinates()

        return vector(2*g*[0])
    
    def is_cocycle(self):
        w0 = self.omega0
        w8 = self.omega8
        fct = self.f
        if not w0.is_regular_on_U0() and not w8.is_regular_on_Uinfty():
            return('w0 & w8')
        if not w0.is_regular_on_U0():
            return('w0')
        if not w8.is_regular_on_Uinfty():
            return('w8')
        if w0.is_regular_on_U0() and w8.is_regular_on_Uinfty():
            return 1
        return 0
        
def degree_of_rational_fctn(f):
    Rx.<x> = PolynomialRing(GF(p))
    Fx = FractionField(Rx)
    f = Fx(f)
    f1 = f.numerator()
    f2 = f.denominator()
    d1 = f1.degree()
    d2 = f2.degree()
    return(d1 - d2)

def coeff_of_rational_fctn(f):
    Rx.<x> = PolynomialRing(GF(p))
    Fx = FractionField(Rx)
    f = Fx(f)
    if f == Rx(0):
        return 0
    f1 = f.numerator()
    f2 = f.denominator()
    d1 = f1.degree()
    d2 = f2.degree()
    a1 = f1.coefficients(sparse = false)[d1]
    a2 = f2.coefficients(sparse = false)[d2]
    return(a1/a2)

def coff(f, d):
    lista = f.coefficients(sparse = false)
    if len(lista) <= d:
        return 0
    return lista[d]

def cut(f, i):
    R = f.parent()
    coeff = f.coefficients(sparse = false)
    return sum(R(x^(j-i-1)) * coeff[j] for j in range(i+1, f.degree() + 1))

def polynomial_part(p, h):
    Rx.<x> = PolynomialRing(GF(p))
    h = Rx(h)
    result = Rx(0)
    for i in range(0, h.degree()+1):
        if (i%p) == p-1:
            power = Integer((i-(p-1))/p)
            result += Integer(h[i]) * x^(power)    
    return result
def preimage(U, V, M): #preimage of subspace U under M
    basis_preimage = M.right_kernel().basis()
    imageU = U.intersection(M.transpose().image())
    basis = imageU.basis()
    for v in basis:
        w = M.solve_right(v)
        basis_preimage = basis_preimage + [w]
    return V.subspace(basis_preimage)

def image(U, V, M):
    basis = U.basis()
    basis_image = []
    for v in basis:
        basis_image += [M*v]
    return V.subspace(basis_image)

def flag(F, V, p):
    dim = F.dimensions()[0]
    space = VectorSpace(GF(p), dim)
    flag_subspaces = (dim+1)*[0]
    flag_used = (dim+1)*[0]
    final_type = (dim+1)*[-1]
    
    flag_subspaces[dim] = space
    flag_used[dim] = 1
   
    
    while 1 in flag_used:
        index = flag_used.index(1)
        flag_used[index] = 0
        U = flag_subspaces[index]
        U_im = image(U, space, V)
        d_im = U_im.dimension()
        final_type[index] = d_im
        U_pre = preimage(U, space, F)
        d_pre = U_pre.dimension()
        
        if flag_subspaces[d_im] == 0:
            flag_subspaces[d_im] = U_im
            flag_used[d_im] = 1
        
        if flag_subspaces[d_pre] == 0:
            flag_subspaces[d_pre] = U_pre
            flag_used[d_pre] = 1
    
    for i in range(0, dim+1):
        if final_type[i] == -1 and final_type[dim - i] != -1:
            i1 = dim - i
            final_type[i] = final_type[i1] - i1 + dim/2
    print('test', final_type)
    
    final_type[0] = 0
    for i in range(1, dim+1):
        if final_type[i] == -1:
            final_type[i] = final_type[i-1] + 1
    
    if is_final(final_type, dim/2):
        return final_type[1:dim/2 + 1]
    return 'error'
    
def is_final(final_type, dim):
    n = len(final_type)
    if final_type[0] != 0:
        return 0
    
    if final_type[n-1] != dim:
        return 0
    
    for i in range(1, n):
        if final_type[i] != final_type[i - 1] or final_type[i] != final_type[i - 1] + 1:
            return 0
    return 1
p = 5
for a in range(0, p):
    for b in range(0, p):
        Rx.<x> = PolynomialRing(GF(p))
        C = superelliptic(x^9+a*x^8+b*x^3+x^2+x+1, 2, p)
        if C.is_smooth():
            print(a, b)
            V = C.verschiebung_matrix()
            F = C.frobenius_matrix()
            print(a, b, V.rank(), flag(F, V, p))
0 3
coo (((2*x + 2)/y) dx, 0, ((2*x + 2)/y) dx)
elt bazy 1 ((x/y) dx, 0, (x/y) dx) 2 ((2*x/y) dx, 0, (2*x/y) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
elt bazy 5 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx) 1 ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx)
coo (0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
coo ((2/y) dx, 0, (2/y) dx)
---------------------------------------------------------------------------
KeyboardInterrupt                         Traceback (most recent call last)
<ipython-input-22-afeec6e02e63> in <module>()
      6         if C.is_smooth():
      7             print(a, b)
----> 8             V = C.verschiebung_matrix()
      9             F = C.frobenius_matrix()
     10             print(a, b, V.rank(), flag(F, V, p))

<ipython-input-20-b4ab11771f80> in verschiebung_matrix(self)
     73         M = matrix(GF(p), Integer(2)*g, Integer(2)*g)
     74         for i, w in basis.items():
---> 75             v = w.verschiebung().coordinates()
     76             M[i, :] = v
     77         return M

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
--> 365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    366 
    367         for j in range(Integer(1), m):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    374                     a = coeff_of_rational_fctn(fct_j)
    375                     elt = self - basis[index].mult(a/m)
--> 376                     return elt.coordinates() + a/m*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])
    377 
    378                 if d<Integer(0):

<ipython-input-20-b4ab11771f80> in coordinates(self)
    361                     a = coeff_of_rational_fctn(omega_j)
    362                     a1 = coeff_of_rational_fctn(basis[index].omega0.jth_component(j))
--> 363                     elt = self - basis[index].mult(a/a1)
    364                     print('elt bazy', index, basis[index], a/a1, basis[index].mult(a/a1))
    365                     return elt.coordinates() + a/a1*vector([GF(p)(i == index) for i in range(Integer(0), Integer(2)*g)])

<ipython-input-20-b4ab11771f80> in mult(self, constant)
    316         w2 = superelliptic_form(C, constant*w1)
    317         f2 = superelliptic_function(C, constant*f1)
--> 318         return superelliptic_cech(C, w2, f2)
    319 
    320     def __repr__(self):

<ipython-input-20-b4ab11771f80> in __init__(self, C, omega, fct)
    298     def __init__(self, C, omega, fct):
    299         self.omega0 = omega
--> 300         self.omega8 = omega - diffn(fct)
    301         self.f = fct
    302         self.curve = C

<ipython-input-20-b4ab11771f80> in diffn(self)
    201     A = g.derivative(x)
    202     B = g.derivative(y)*f.derivative(x)/(m*y**(m-Integer(1)))
--> 203     return superelliptic_form(C, A+B)
    204 
    205 class superelliptic_form:

<ipython-input-20-b4ab11771f80> in __init__(self, C, g)
    208         Rxy = PolynomialRing(GF(p), Integer(2), names=('x', 'y',)); (x, y,) = Rxy._first_ngens(2)
    209         Fxy = FractionField(Rxy)
--> 210         g = Fxy(reduction_form(C, g))
    211         self.form = g
    212         self.curve = C

<ipython-input-20-b4ab11771f80> in reduction_form(C, g)
    133         else:
    134             G = coff(g, j)
--> 135             g1 += Fxy(y**(j-m)*f*G)
    136     return(g1)
    137 

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/parent.pyx in sage.structure.parent.Parent.__call__ (build/cythonized/sage/structure/parent.c:9218)()
    898         if mor is not None:
    899             if no_extra_args:
--> 900                 return mor._call_(x)
    901             else:
    902                 return mor._call_with_args(x, args, kwds)

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/coerce_maps.pyx in sage.structure.coerce_maps.DefaultConvertMap_unique._call_ (build/cythonized/sage/structure/coerce_maps.c:4448)()
    154         cdef Parent C = self._codomain
    155         try:
--> 156             return C._element_constructor(x)
    157         except Exception:
    158             if print_warnings:

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/fraction_field.py in _element_constructor_(self, x, y, coerce)
    613             ring_one = self.ring().one()
    614             try:
--> 615                 return self._element_class(self, x, ring_one, coerce=coerce)
    616             except (TypeError, ValueError):
    617                 pass

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/fraction_field_element.pyx in sage.rings.fraction_field_element.FractionFieldElement.__init__ (build/cythonized/sage/rings/fraction_field_element.c:2921)()
    112         FieldElement.__init__(self, parent)
    113         if coerce:
--> 114             self.__numerator   = parent.ring()(numerator)
    115             self.__denominator = parent.ring()(denominator)
    116         else:

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/parent.pyx in sage.structure.parent.Parent.__call__ (build/cythonized/sage/structure/parent.c:9218)()
    898         if mor is not None:
    899             if no_extra_args:
--> 900                 return mor._call_(x)
    901             else:
    902                 return mor._call_with_args(x, args, kwds)

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/coerce_maps.pyx in sage.structure.coerce_maps.DefaultConvertMap_unique._call_ (build/cythonized/sage/structure/coerce_maps.c:4448)()
    154         cdef Parent C = self._codomain
    155         try:
--> 156             return C._element_constructor(x)
    157         except Exception:
    158             if print_warnings:

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/polynomial/multi_polynomial_libsingular.pyx in sage.rings.polynomial.multi_polynomial_libsingular.MPolynomialRing_libsingular._element_constructor_ (build/cythonized/sage/rings/polynomial/multi_polynomial_libsingular.cpp:11562)()
    995             return self(element.external_string())
    996         try:
--> 997             return self(str(element))
    998         except TypeError:
    999             pass

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/sage_object.pyx in sage.structure.sage_object.SageObject.__repr__ (build/cythonized/sage/structure/sage_object.c:2436)()
    192         except AttributeError:
    193             return super().__repr__()
--> 194         result = reprfunc()
    195         if isinstance(result, str):
    196             return result

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/fraction_field_element.pyx in sage.rings.fraction_field_element.FractionFieldElement._repr_ (build/cythonized/sage/rings/fraction_field_element.c:5310)()
    471         if self.is_zero():
    472             return "0"
--> 473         s = "%s" % self.__numerator
    474         if self.__denominator != 1:
    475             denom_string = str( self.__denominator )

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/sage_object.pyx in sage.structure.sage_object.SageObject.__repr__ (build/cythonized/sage/structure/sage_object.c:2436)()
    192         except AttributeError:
    193             return super().__repr__()
--> 194         result = reprfunc()
    195         if isinstance(result, str):
    196             return result

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/polynomial/polynomial_element.pyx in sage.rings.polynomial.polynomial_element.Polynomial._repr_ (build/cythonized/sage/rings/polynomial/polynomial_element.c:26915)()
   2601             NotImplementedError: object does not support renaming: x^3 + 2/3*x^2 - 5/3
   2602         """
-> 2603         return self._repr()
   2604 
   2605     def _latex_(self, name=None):

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/polynomial/polynomial_element.pyx in sage.rings.polynomial.polynomial_element.Polynomial._repr (build/cythonized/sage/rings/polynomial/polynomial_element.c:26355)()
   2567                 if n != m-1:
   2568                     s += " + "
-> 2569                 x = y = repr(x)
   2570                 if y.find("-") == 0:
   2571                     y = y[1:]

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/sage_object.pyx in sage.structure.sage_object.SageObject.__repr__ (build/cythonized/sage/structure/sage_object.c:2436)()
    192         except AttributeError:
    193             return super().__repr__()
--> 194         result = reprfunc()
    195         if isinstance(result, str):
    196             return result

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/fraction_field_FpT.pyx in sage.rings.fraction_field_FpT.FpTElement._repr_ (build/cythonized/sage/rings/fraction_field_FpT.cpp:7163)()
    332         else:
    333             numer_s = repr(self.numer())
--> 334             denom_s = repr(self.denom())
    335             if '-' in numer_s or '+' in numer_s:
    336                 numer_s = "(%s)" % numer_s

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/sage_object.pyx in sage.structure.sage_object.SageObject.__repr__ (build/cythonized/sage/structure/sage_object.c:2436)()
    192         except AttributeError:
    193             return super().__repr__()
--> 194         result = reprfunc()
    195         if isinstance(result, str):
    196             return result

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/polynomial/polynomial_element.pyx in sage.rings.polynomial.polynomial_element.Polynomial._repr_ (build/cythonized/sage/rings/polynomial/polynomial_element.c:26915)()
   2601             NotImplementedError: object does not support renaming: x^3 + 2/3*x^2 - 5/3
   2602         """
-> 2603         return self._repr()
   2604 
   2605     def _latex_(self, name=None):

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/polynomial/polynomial_element.pyx in sage.rings.polynomial.polynomial_element.Polynomial._repr (build/cythonized/sage/rings/polynomial/polynomial_element.c:26355)()
   2567                 if n != m-1:
   2568                     s += " + "
-> 2569                 x = y = repr(x)
   2570                 if y.find("-") == 0:
   2571                     y = y[1:]

src/cysignals/signals.pyx in cysignals.signals.python_check_interrupt()

KeyboardInterrupt: 
C = superelliptic(x^9+3*x^3+x^2+x+1, 2, 5)
C.basis_de_rham[0].mult(2) - C.basis_de_rham[5]
(0 dx, 3/x^2*y, ((2*x^3 - 2*x^2 + 2*x + 1)/(x^3*y)) dx)
C.basis_de_rham
{0: ((1/y) dx, 0, (1/y) dx),
 1: ((x/y) dx, 0, (x/y) dx),
 2: ((x^2/y) dx, 0, (x^2/y) dx),
 3: ((x^3/y) dx, 0, (x^3/y) dx),
 4: (((2*x^7 - 2*x)/y) dx, 2/x*y, ((x + 2)/(x^2*y)) dx),
 5: ((2/y) dx, 2/x^2*y, ((2*x^2 - 2*x - 1)/(x^3*y)) dx),
 6: (((-2*x^5)/y) dx, 2/x^3*y, ((-x^3 - x^2 + 1)/(x^4*y)) dx),
 7: ((x^4/y) dx, 2/x^4*y, ((x^2 + 2*x - 2)/(x^5*y)) dx)}
M = matrix(QQ, [[1,2], [3,6]])
U = M.kernel()
V = VectorSpace(QQ,2)
M.transpose().image()
Vector space of degree 2 and dimension 1 over Rational Field
Basis matrix:
[1 3]
l = U.basis()
l = l +[(1, 1/3)]
###fragment kodu do obliczania residuuow w niesk - zaniechany
#def more_v(f, prec):
#    C = f.curve
#    f = f.vw
#    g = C.polynomial8
#    p = C.characteristic
#    m = C.exponent
#    r = C.polynomial.degree()
#    delta, a, b = xgcd(m, r)
#    a = -a
#    M = m/delta
#    R = r/delta
#    
#    Fpbar = GF(p).algebraic_closure()
#    Ruv.<u, v> = PolynomialRing(Fpbar, 2)
#    if prec == 0:
#        return 0
#    zeta = Fpbar.zeta(m)
#    a = f(v = zeta, w = 0)
#    f1 = f - a
#    if w.divides(f1):
#        return more_v(f1/w, prec-1)
    
p = 7
Rx.<x> = PolynomialRing(GF(p))
C = superelliptic(x^3 + x + 3, 5, p)
baza = C.basis_de_rham
print(C.genus())
#E = EllipticCurve(GF(p), [1, 2])
print(E.trace_of_frobenius())
#C.basis_holomorphic_differentials(  )
4
2
C.degree_de_rham0
{0: (0, 2),
 1: (0, 3),
 2: (0, 4),
 3: (1, 4),
 4: (-1, 1),
 5: (0, 1),
 6: (1, 2),
 7: (1, 3)}
C.basis_de_rham
{0: ((1/y^2) dx, 0, (1/y^2) dx),
 1: ((1/y^3) dx, 0, (1/y^3) dx),
 2: ((1/y^4) dx, 0, (1/y^4) dx),
 3: ((x/y^4) dx, 0, (x/y^4) dx),
 4: (0 dx, 5/x*y^4, ((x + 1)/(x^2*y)) dx),
 5: ((2/y) dx, 5/x^2*y^4, ((-x + 2)/(x^3*y)) dx),
 6: (((-3*x)/y^2) dx, 5/x*y^3, ((2*x + 1)/(x^2*y^2)) dx),
 7: ((x/y^3) dx, 5/x*y^2, ((3*x + 1)/(x^2*y^3)) dx)}
A = C.frobenius_matrix()
B = C.verschiebung_matrix()
A.solve_right((0, 0, 0, 0, 4, 2, 5, 3))
(1, 0, 0, 4, 3, 0, 2, 0)
A*vector((1, 0, 0, 4, 3, 0, 2, 0))
(0, 0, 0, 0, 4, 2, 5, 3)
vector((1, 0, 0, 4, 5, 0, 0, 0)) - vector((0, 0, 0, 0, 2, 6, 5, 5))
(1, 0, 0, 4, 3, -6, -5, -5)
omega = diffn(superelliptic_function(C, y^2))
omega.jth_component(0)
3*x^2 + 1
R.<x, y> = PolynomialRing(GF(p), 2)
g1 = x^3*y^7 + x^2*y^9
g2 = x^2*y + y^6
R1.<x> = PolynomialRing(GF(p))
R2 = FractionField(R1)
R3.<y> = PolynomialRing(R2)

xgcd(R3(g1), R3(g2))[1]*R3(g1) + xgcd(R3(g1), R3(g2))[2]*R3(g2)
y
H = HyperellipticCurve(x^5 - x + 1)
H
Hyperelliptic Curve over Finite Field of size 5 defined by y^2 = x^5 + 4*x + 1
f = x^3 + x + 2
f.derivative(x)
-2*x^2 + 1
p = 5
R1.<x> = PolynomialRing(GF(p))
R2 = FractionField(R1)
R3.<y> = PolynomialRing(R2)
g = y^2/x + y/(x+1)    
g = 1/y+x/y^2
R3.<z> = PolynomialRing(R2)
g(y = 1/z)
x*z^2 + z
f
x^3 + x + 4
f.coefficient()
---------------------------------------------------------------------------
AttributeError                            Traceback (most recent call last)
<ipython-input-62-e054c182ec1a> in <module>()
----> 1 f.coefficient()

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/element.pyx in sage.structure.element.Element.__getattr__ (build/cythonized/sage/structure/element.c:4614)()
    485             AttributeError: 'LeftZeroSemigroup_with_category.element_class' object has no attribute 'blah_blah'
    486         """
--> 487         return self.getattr_from_category(name)
    488 
    489     cdef getattr_from_category(self, name):

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/element.pyx in sage.structure.element.Element.getattr_from_category (build/cythonized/sage/structure/element.c:4723)()
    498         else:
    499             cls = P._abstract_element_class
--> 500         return getattr_from_other_class(self, cls, name)
    501 
    502     def __dir__(self):

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/cpython/getattr.pyx in sage.cpython.getattr.getattr_from_other_class (build/cythonized/sage/cpython/getattr.c:2614)()
    392         dummy_error_message.cls = type(self)
    393         dummy_error_message.name = name
--> 394         raise AttributeError(dummy_error_message)
    395     attribute = <object>attr
    396     # Check for a descriptor (__get__ in Python)

AttributeError: 'sage.rings.polynomial.polynomial_zmod_flint.Polynomial_zmod_flint' object has no attribute 'coefficient'
x^3+x+1
x^3 + x + 1
parent(x)
Symbolic Ring
R.<x> = PolynomialRing(GF(5))
R = (x^3+x).parent()
R.<x, y> = PolynomialRing(GF(5))
RR = FractionField(R)
A = RR(1/(x*y))
A.derivative(x)
(-1)/(x^2*y)
dict1 = {}
dict1[3] = 5
dict1[6] = 121
degrees1_inv = {b:a for a, b in dict1.items()}
degrees1_inv
{5: 3, 121: 6}
C
Superelliptic curve with the equation y^7 = x^3 + x + 2 over finite field with 5 elements.
basis = C.basis_de_rham()
basis.items()
dict_items([(0, ((x/y) dx, 2/x*y, ((x^3*y^5 - x^3 + x - 1)/(x^2*y^6)) dx)), (1, (((-1)/y) dx, 2/x^2*y, ((-x^3*y^5 + x^3 - 2*x - 2)/(x^3*y^6)) dx)), (2, (((-2*x)/y^2) dx, 2/x*y^2, ((-2*x^3*y^3 + x^3 - 1)/(x^2*y^5)) dx)), (3, ((1/y^2) dx, 2/x^2*y^2, ((x^3*y^3 - 2*x^3 + 2*x - 2)/(x^3*y^5)) dx)), (4, ((1/y^3) dx, 0, (1/y^3) dx)), (5, (0 dx, 2/x*y^3, ((-2*x^3 - x - 1)/(x^2*y^4)) dx)), (6, ((1/y^4) dx, 0, (1/y^4) dx)), (7, ((2*x/y^4) dx, 2/x*y^4, ((2*x^3 - 2*x*y - y)/(x^2*y^4)) dx)), (8, ((1/y^5) dx, 0, (1/y^5) dx)), (9, ((x/y^5) dx, 0, (x/y^5) dx)), (10, ((1/y^6) dx, 0, (1/y^6) dx)), (11, ((x/y^6) dx, 0, (x/y^6) dx))])
m = 9
r = 6
delta, a, b = xgcd(m, r)
a = -a
xgcd(9, 6)
(3, 1, -1)
b*r -a*m, delta
(3, 3)
Fpbar = GF(5).algebraic_closure()
z = Fpbar.zeta(7)
GF(5^6)(z)
---------------------------------------------------------------------------
TypeError                                 Traceback (most recent call last)
<ipython-input-23-42625790d9c3> in <module>()
----> 1 GF(Integer(5)**Integer(6))(z)

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/parent.pyx in sage.structure.parent.Parent.__call__ (build/cythonized/sage/structure/parent.c:9218)()
    898         if mor is not None:
    899             if no_extra_args:
--> 900                 return mor._call_(x)
    901             else:
    902                 return mor._call_with_args(x, args, kwds)

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/coerce_maps.pyx in sage.structure.coerce_maps.DefaultConvertMap_unique._call_ (build/cythonized/sage/structure/coerce_maps.c:4556)()
    159                 print(type(C), C)
    160                 print(type(C._element_constructor), C._element_constructor)
--> 161             raise
    162 
    163     cpdef Element _call_with_args(self, x, args=(), kwds={}):

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/structure/coerce_maps.pyx in sage.structure.coerce_maps.DefaultConvertMap_unique._call_ (build/cythonized/sage/structure/coerce_maps.c:4448)()
    154         cdef Parent C = self._codomain
    155         try:
--> 156             return C._element_constructor(x)
    157         except Exception:
    158             if print_warnings:

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/finite_rings/finite_field_givaro.py in _element_constructor_(self, e)
    368             2*a4^3 + 2*a4^2 + 1
    369         """
--> 370         return self._cache.element_from_data(e)
    371 
    372     def gen(self, n=0):

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/finite_rings/element_givaro.pyx in sage.rings.finite_rings.element_givaro.Cache_givaro.element_from_data (build/cythonized/sage/rings/finite_rings/element_givaro.cpp:7458)()
    312         return make_FiniteField_givaroElement(self,res)
    313 
--> 314     cpdef FiniteField_givaroElement element_from_data(self, e):
    315         """
    316         Coerces several data types to ``self``.

/opt/sagemath-9.1/local/lib/python3.7/site-packages/sage/rings/finite_rings/element_givaro.pyx in sage.rings.finite_rings.element_givaro.Cache_givaro.element_from_data (build/cythonized/sage/rings/finite_rings/element_givaro.cpp:7080)()
    451 
    452         else:
--> 453             raise TypeError("unable to coerce %r" % type(e))
    454 
    455         cdef GEN t

TypeError: unable to coerce <class 'sage.rings.algebraic_closure_finite_field.AlgebraicClosureFiniteField_pseudo_conway_with_category.element_class'>
Integers(7)(5).multiplicative_order()
6