Exemplo n.º 1
0
def f02xec(m, n, a, tda, ncolb, b, tdb, wantq, q, tdq, sv, wantp, ph, tdph, _iter, e, failinfo, fail):
    """
    SVD of complex matrix.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02xec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, b, q, sv, ph, _iter, e, failinfo
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        sv, e
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        _iter, failinfo
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, b, q, ph
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _a = nag_complex_type_check_and_cast("f02xec", a, "a")
    _b = nag_complex_type_check_and_cast("f02xec", b, "b")
    _q = nag_complex_type_check_and_cast("f02xec", q, "q")
    _sv = nag_double_type_check_and_cast("f02xec", sv, "sv")
    _ph = nag_complex_type_check_and_cast("f02xec", ph, "ph")
    __iter = nag_integer_type_check_and_cast("f02xec", _iter, "_iter")
    _e = nag_double_type_check_and_cast("f02xec", e, "e")
    _failinfo = nag_integer_type_check_and_cast("f02xec", failinfo, "failinfo")
    f02xec_ctypes(m, n, _a, tda, ncolb, _b, tdb, wantq, _q, tdq, _sv, wantp, _ph, tdph, __iter, _e, _failinfo, fail)
Exemplo n.º 2
0
def f04djc(order, uplo, n, nrhs, ap, ipiv, b, pdb, rcond, errbnd, fail):
    """
    Computes the solution, estimated condition number and error-bound to a
    complex symmetric system of linear equations, packed storage.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04djc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        ap, ipiv, b, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        ipiv
    TypeError will be raised when the following arguments are not of data type
    Complex:
        ap, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _ap = nag_complex_type_check_and_cast('f04djc', ap, 'ap')
    _ipiv = nag_integer_type_check_and_cast('f04djc', ipiv, 'ipiv')
    _b = nag_complex_type_check_and_cast('f04djc', b, 'b')
    _rcond = nag_double_type_check_and_cast('f04djc', rcond, 'rcond')
    _errbnd = nag_double_type_check_and_cast('f04djc', errbnd, 'errbnd')
    f04djc_ctypes(order, uplo, n, nrhs, _ap, _ipiv, _b, pdb, _rcond, _errbnd, fail)
Exemplo n.º 3
0
def f02agc(n, a, tda, r, v, tdv, _iter, fail):
    """
    All eigenvalues and eigenvectors of real matrix.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02agc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, r, v, _iter
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        a
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        _iter
    TypeError will be raised when the following arguments are not of data type
    Complex:
        r, v
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _a = nag_double_type_check_and_cast("f02agc", a, "a")
    _r = nag_complex_type_check_and_cast("f02agc", r, "r")
    _v = nag_complex_type_check_and_cast("f02agc", v, "v")
    __iter = nag_integer_type_check_and_cast("f02agc", _iter, "_iter")
    f02agc_ctypes(n, _a, tda, _r, _v, tdv, __iter, fail)
Exemplo n.º 4
0
def f12aqc(nconv, d, z, sigma, resid, v, comm, icomm, fail):
    """
    Selected eigenvalues and, optionally, eigenvectors of a complex sparse
    eigenproblem, postprocessing for f12apc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12aqc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        nconv, d, z, resid, v, comm, icomm
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        nconv, icomm
    TypeError will be raised when the following arguments are not of data type
    Complex:
        d, z, resid, v, comm
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _nconv = nag_integer_type_check_and_cast('f12aqc', nconv, 'nconv')
    _d = nag_complex_type_check_and_cast('f12aqc', d, 'd')
    _z = nag_complex_type_check_and_cast('f12aqc', z, 'z')
    _resid = nag_complex_type_check_and_cast('f12aqc', resid, 'resid')
    _v = nag_complex_type_check_and_cast('f12aqc', v, 'v')
    _comm = nag_complex_type_check_and_cast('f12aqc', comm, 'comm')
    _icomm = nag_integer_type_check_and_cast('f12aqc', icomm, 'icomm')
    f12aqc_ctypes(_nconv, _d, _z, sigma, _resid, _v, _comm, _icomm, fail)
Exemplo n.º 5
0
def f04ccc(order, n, nrhs, dl, d, du, du2, ipiv, b, pdb, rcond, errbnd, fail):
    """
    Computes the solution, estimated condition number and error-bound to a
    complex tridiagonal system of linear equations.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04ccc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        dl, d, du, du2, ipiv, b, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        ipiv
    TypeError will be raised when the following arguments are not of data type
    Complex:
        dl, d, du, du2, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _dl = nag_complex_type_check_and_cast('f04ccc', dl, 'dl')
    _d = nag_complex_type_check_and_cast('f04ccc', d, 'd')
    _du = nag_complex_type_check_and_cast('f04ccc', du, 'du')
    _du2 = nag_complex_type_check_and_cast('f04ccc', du2, 'du2')
    _ipiv = nag_integer_type_check_and_cast('f04ccc', ipiv, 'ipiv')
    _b = nag_complex_type_check_and_cast('f04ccc', b, 'b')
    _rcond = nag_double_type_check_and_cast('f04ccc', rcond, 'rcond')
    _errbnd = nag_double_type_check_and_cast('f04ccc', errbnd, 'errbnd')
    f04ccc_ctypes(order, n, nrhs, _dl, _d, _du, _du2, _ipiv, _b, pdb, _rcond, _errbnd, fail)
Exemplo n.º 6
0
def f04cgc(order, n, nrhs, d, e, b, pdb, rcond, errbnd, fail):
    """
    Computes the solution, estimated condition number and error-bound to a
    complex Hermitian positive definite tridiagonal system of linear
    equations.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04cgc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        d, e, b, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        d, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    Complex:
        e, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    _d = nag_double_type_check_and_cast('f04cgc', d, 'd')
    _e = nag_complex_type_check_and_cast('f04cgc', e, 'e')
    _b = nag_complex_type_check_and_cast('f04cgc', b, 'b')
    _rcond = nag_double_type_check_and_cast('f04cgc', rcond, 'rcond')
    _errbnd = nag_double_type_check_and_cast('f04cgc', errbnd, 'errbnd')
    f04cgc_ctypes(order, n, nrhs, _d, _e, _b, pdb, _rcond, _errbnd, fail)
Exemplo n.º 7
0
def f02ecc(crit, n, a, tda, wl, wu, mest, m, w, v, tdv, fail):
    """
    Computes selected eigenvalues and eigenvectors of a real general matrix.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02ecc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, m, w, v
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        a
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        m
    TypeError will be raised when the following arguments are not of data type
    Complex:
        w, v
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _a = nag_double_type_check_and_cast("f02ecc", a, "a")
    _m = nag_integer_type_check_and_cast("f02ecc", m, "m")
    _w = nag_complex_type_check_and_cast("f02ecc", w, "w")
    _v = nag_complex_type_check_and_cast("f02ecc", v, "v")
    f02ecc_ctypes(crit, n, _a, tda, wl, wu, mest, _m, _w, _v, tdv, fail)
Exemplo n.º 8
0
def c02afc(n, a, scale, z, fail):
    """
    Zeros of a polynomial with complex coefficients.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/c02/c02afc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, z
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, z
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('c02afc', a, 'a')
    _z = nag_complex_type_check_and_cast('c02afc', z, 'z')
    c02afc_ctypes(n, _a, scale, _z, fail)
Exemplo n.º 9
0
def f01rec(wheret, m, n, ncolq, a, tda, theta, fail):
    """
    Form columns of Q after factorization by f01rcc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01rec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, theta
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, theta
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f01rec', a, 'a')
    _theta = nag_complex_type_check_and_cast('f01rec', theta, 'theta')
    f01rec_ctypes(wheret, m, n, ncolq, _a, tda, _theta, fail)
Exemplo n.º 10
0
def f01rcc(m, n, a, tda, theta, fail):
    """
    QR factorization of complex m by n matrix (m >= n).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01rcc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, theta
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, theta
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f01rcc', a, 'a')
    _theta = nag_complex_type_check_and_cast('f01rcc', theta, 'theta')
    f01rcc_ctypes(m, n, _a, tda, _theta, fail)
Exemplo n.º 11
0
def f01fmc(order, n, a, pda, f, comm, iflag, fail):
    """
    Function of a complex matrix (using user-supplied derivatives).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01fmc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, iflag
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        iflag
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a
    ImportError will be raised for this function on Mac.
    """
    from platform import system
    if system() == 'Darwin':
        from nag4py.util import nagImportErrorMessage
        raise ImportError(nagImportErrorMessage('f01fmc', system()))
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f01fmc', a, 'a')
    _iflag = nag_integer_type_check_and_cast('f01fmc', iflag, 'iflag')
    f01fmc_ctypes(order, n, _a, pda, f, comm, _iflag, fail)
Exemplo n.º 12
0
def f02bjc(n, a, tda, b, tdb, tol, alfa, beta, wantv, v, tdv, _iter, fail):
    """
    Computes all eigenvalues and, optionally, eigenvectors of real
    generalized eigenproblem, by QZ algorithm.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02bjc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, b, alfa, beta, v, _iter
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        a, b, beta, v
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        _iter
    TypeError will be raised when the following arguments are not of data type
    Complex:
        alfa
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _a = nag_double_type_check_and_cast("f02bjc", a, "a")
    _b = nag_double_type_check_and_cast("f02bjc", b, "b")
    _alfa = nag_complex_type_check_and_cast("f02bjc", alfa, "alfa")
    _beta = nag_double_type_check_and_cast("f02bjc", beta, "beta")
    _v = nag_double_type_check_and_cast("f02bjc", v, "v")
    __iter = nag_integer_type_check_and_cast("f02bjc", _iter, "_iter")
    f02bjc_ctypes(n, _a, tda, _b, tdb, tol, _alfa, _beta, wantv, _v, tdv, __iter, fail)
Exemplo n.º 13
0
def f01rdc(trans, wheret, m, n, a, tda, theta, ncolb, b, tdb, fail):
    """
    Compute QB or Q**HB after factorization by f01rcc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01rdc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, theta, b
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, theta, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f01rdc', a, 'a')
    _theta = nag_complex_type_check_and_cast('f01rdc', theta, 'theta')
    _b = nag_complex_type_check_and_cast('f01rdc', b, 'b')
    f01rdc_ctypes(trans, wheret, m, n, _a, tda, _theta, ncolb, _b, tdb, fail)
Exemplo n.º 14
0
def f04adc(n, nrhs, a, tda, b, tdb, x, tdx, fail):
    """
    Approximate solution of complex simultaneous linear equations with
    multiple right-hand sides.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04adc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, b, x
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, b, x
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f04adc', a, 'a')
    _b = nag_complex_type_check_and_cast('f04adc', b, 'b')
    _x = nag_complex_type_check_and_cast('f04adc', x, 'x')
    f04adc_ctypes(n, nrhs, _a, tda, _b, tdb, _x, tdx, fail)
Exemplo n.º 15
0
def f12apc(irevcm, resid, v, x, y, mx, nshift, comm, icomm, fail):
    """
    Selected eigenvalues and, optionally, eigenvectors of a complex sparse
    eigenproblem, reverse communication.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12apc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        irevcm, resid, v, x, y, mx, nshift, comm, icomm
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        irevcm, nshift, icomm
    TypeError will be raised when the following arguments are not of data type
    Complex:
        resid, v, x, y, mx, comm
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _irevcm = nag_integer_type_check_and_cast('f12apc', irevcm, 'irevcm')
    _resid = nag_complex_type_check_and_cast('f12apc', resid, 'resid')
    _v = nag_complex_type_check_and_cast('f12apc', v, 'v')
    _x = nag_complex_type_check_and_cast('f12apc', x, 'x')
    _y = nag_complex_type_check_and_cast('f12apc', y, 'y')
    _mx = nag_complex_type_check_and_cast('f12apc', mx, 'mx')
    _nshift = nag_integer_type_check_and_cast('f12apc', nshift, 'nshift')
    _comm = nag_complex_type_check_and_cast('f12apc', comm, 'comm')
    _icomm = nag_integer_type_check_and_cast('f12apc', icomm, 'icomm')
    f12apc_ctypes(_irevcm, _resid, _v, _x, _y, _mx, _nshift, _comm, _icomm, fail)
Exemplo n.º 16
0
def f03ahc(n, a, tda, pivot, det, dete, fail):
    """
    LU factorization and determinant of complex matrix.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f03/f03ahc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, pivot, det, dete
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        pivot, dete
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, det
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f03ahc', a, 'a')
    _pivot = nag_integer_type_check_and_cast('f03ahc', pivot, 'pivot')
    _det = nag_complex_type_check_and_cast('f03ahc', det, 'det')
    _dete = nag_integer_type_check_and_cast('f03ahc', dete, 'dete')
    f03ahc_ctypes(n, _a, tda, _pivot, _det, _dete, fail)
Exemplo n.º 17
0
def f03bnc(order, n, a, pda, ipiv, d, _id, fail):
    """
    Determinant of complex matrix previously LU factorized.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f03/f03bnc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, ipiv, d, _id
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        ipiv, _id
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, d
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f03bnc', a, 'a')
    _ipiv = nag_integer_type_check_and_cast('f03bnc', ipiv, 'ipiv')
    _d = nag_complex_type_check_and_cast('f03bnc', d, 'd')
    __id = nag_integer_type_check_and_cast('f03bnc', _id, '_id')
    f03bnc_ctypes(order, n, _a, pda, _ipiv, _d, __id, fail)
Exemplo n.º 18
0
def f02axc(n, a, tda, r, v, tdv, fail):
    """
    All eigenvalues and eigenvectors of complex Hermitian matrix.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02axc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, r, v
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        r
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, v
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast

    _a = nag_complex_type_check_and_cast("f02axc", a, "a")
    _r = nag_double_type_check_and_cast("f02axc", r, "r")
    _v = nag_complex_type_check_and_cast("f02axc", v, "v")
    f02axc_ctypes(n, _a, tda, _r, _v, tdv, fail)
Exemplo n.º 19
0
def f04akc(n, nrhs, a, tda, pivot, b, tdb, fail):
    """
    Approximate solution of complex simultaneous linear equations
    (coefficient matrix already factorized by f03ahc).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04akc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, pivot, b
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        pivot
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f04akc', a, 'a')
    _pivot = nag_integer_type_check_and_cast('f04akc', pivot, 'pivot')
    _b = nag_complex_type_check_and_cast('f04akc', b, 'b')
    f04akc_ctypes(n, nrhs, _a, tda, _pivot, _b, tdb, fail)
Exemplo n.º 20
0
def f04awc(n, nrhs, a, tda, p, b, tdb, x, tdx, fail):
    """
    Approximate solution of complex Hermitian positive definite simultaneous
    linear equations (coefficient matrix already factorized by f01bnc).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04awc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, p, b, x
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        p
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, b, x
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f04awc', a, 'a')
    _p = nag_double_type_check_and_cast('f04awc', p, 'p')
    _b = nag_complex_type_check_and_cast('f04awc', b, 'b')
    _x = nag_complex_type_check_and_cast('f04awc', x, 'x')
    f04awc_ctypes(n, nrhs, _a, tda, _p, _b, tdb, _x, tdx, fail)
Exemplo n.º 21
0
def f06kec(n, alpha, x, incx):
    """
    Multiply complex vector by reciprocal of real scalar.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f06/f06kec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x
    TypeError will be raised when the following arguments are not of data type
    Complex:
        x
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _x = nag_complex_type_check_and_cast('f06kec', x, 'x')
    f06kec_ctypes(n, alpha, _x, incx)
Exemplo n.º 22
0
def c06pxc(direct, n1, n2, n3, x, fail):
    """
    Three-dimensional complex discrete Fourier transform, complex data type.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/c06/c06pxc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x
    TypeError will be raised when the following arguments are not of data type
    Complex:
        x
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _x = nag_complex_type_check_and_cast('c06pxc', x, 'x')
    c06pxc_ctypes(direct, n1, n2, n3, _x, fail)
Exemplo n.º 23
0
def f12asc(niter, nconv, ritz, rzest, icomm, comm):
    """
    Provides monitoring information for f12apc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12asc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        niter, nconv, ritz, rzest, icomm, comm
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        niter, nconv, icomm
    TypeError will be raised when the following arguments are not of data type
    Complex:
        ritz, rzest, comm
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _niter = nag_integer_type_check_and_cast('f12asc', niter, 'niter')
    _nconv = nag_integer_type_check_and_cast('f12asc', nconv, 'nconv')
    _ritz = nag_complex_type_check_and_cast('f12asc', ritz, 'ritz')
    _rzest = nag_complex_type_check_and_cast('f12asc', rzest, 'rzest')
    _icomm = nag_integer_type_check_and_cast('f12asc', icomm, 'icomm')
    _comm = nag_complex_type_check_and_cast('f12asc', comm, 'comm')
    f12asc_ctypes(_niter, _nconv, _ritz, _rzest, _icomm, _comm)
Exemplo n.º 24
0
def x04dfc(order, m, n, kl, ku, a, pda, cmplxform, form, title, labrow, rlabs, labcol, clabs, ncols, indent, outfile, fail):
    """
    Print complex packed banded matrix (comprehensive).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/x04/x04dfc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('x04dfc', a, 'a')
    x04dfc_ctypes(order, m, n, kl, ku, _a, pda, cmplxform, form, title, labrow, rlabs, labcol, clabs, ncols, indent, outfile, fail)
Exemplo n.º 25
0
def x04dec(order, m, n, kl, ku, a, pda, title, outfile, fail):
    """
    Print complex packed banded matrix (easy-to-use).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/x04/x04dec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('x04dec', a, 'a')
    x04dec_ctypes(order, m, n, kl, ku, _a, pda, title, outfile, fail)
Exemplo n.º 26
0
def f01fdc(order, uplo, n, a, pda, fail):
    """
    Complex Hermitian matrix exponential.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01fdc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a
    """
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f01fdc', a, 'a')
    f01fdc_ctypes(order, uplo, n, _a, pda, fail)
Exemplo n.º 27
0
def f01bnc(n, a, tda, p, fail):
    """
    UU**H factorization of complex Hermitian positive definite matrix.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01bnc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, p
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        p
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f01bnc', a, 'a')
    _p = nag_double_type_check_and_cast('f01bnc', p, 'p')
    f01bnc_ctypes(n, _a, tda, _p, fail)
Exemplo n.º 28
0
def f01fjc(order, n, a, pda, fail):
    """
    Complex matrix logarithm.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01fjc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a
    ImportError will be raised for this function on Mac.
    """
    from platform import system
    if system() == 'Darwin':
        from nag4py.util import nagImportErrorMessage
        raise ImportError(nagImportErrorMessage('f01fjc', system()))
    from nag4py.util import nag_complex_type_check_and_cast
    _a = nag_complex_type_check_and_cast('f01fjc', a, 'a')
    f01fjc_ctypes(order, n, _a, pda, fail)
Exemplo n.º 29
0
def c05bbc(branch, offset, z, w, resid, fail):
    """
    Values of Lambert's W function, W(z).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/c05/c05bbc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        w, resid
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        resid
    TypeError will be raised when the following arguments are not of data type
    Complex:
        w
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    _w = nag_complex_type_check_and_cast('c05bbc', w, 'w')
    _resid = nag_double_type_check_and_cast('c05bbc', resid, 'resid')
    c05bbc_ctypes(branch, offset, z, _w, _resid, fail)
Exemplo n.º 30
0
def f12arc(_str, icomm, comm, fail):
    """
    Set a single option from a string (f12apc/f12aqc).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12arc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        icomm, comm
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        icomm
    TypeError will be raised when the following arguments are not of data type
    Complex:
        comm
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _icomm = nag_integer_type_check_and_cast('f12arc', icomm, 'icomm')
    _comm = nag_complex_type_check_and_cast('f12arc', comm, 'comm')
    f12arc_ctypes(_str, _icomm, _comm, fail)