|
||||||||||
PREV NEXT | FRAMES NO FRAMES |
Packages that use Complex | |
---|---|
JSci.awt | |
JSci.Demos.MonteCarlo | |
JSci.io | |
JSci.maths | |
JSci.maths.algebras | Provides classes for algebras and their generalisations (vector spaces, modules). |
JSci.maths.categories | |
JSci.maths.chaos | |
JSci.maths.fields | Provides classes for fields and their generalisations (rings). |
JSci.maths.groups | Provides classes for groups and their generalisations (monoids, semigroups). |
JSci.maths.polynomials | |
JSci.maths.wavelet | |
JSci.physics.quantum | |
JSci.util |
Uses of Complex in JSci.awt |
---|
Methods in JSci.awt that return Complex | |
---|---|
Complex[] |
ArgandDiagramModel.getData()
|
Methods in JSci.awt with parameters of type Complex | |
---|---|
void |
ArgandDiagramModel.setData(Complex[] z)
|
Uses of Complex in JSci.Demos.MonteCarlo |
---|
Methods in JSci.Demos.MonteCarlo that return Complex | |
---|---|
Complex |
MonteCarlo.map(Complex z)
Not used, dummy implementation for Mapping interface. |
Methods in JSci.Demos.MonteCarlo with parameters of type Complex | |
---|---|
Complex |
MonteCarlo.map(Complex z)
Not used, dummy implementation for Mapping interface. |
Uses of Complex in JSci.io |
---|
Methods in JSci.io with parameters of type Complex | |
---|---|
org.w3c.dom.Element |
MathMLDocumentJSciImpl.createNumber(Complex z)
Creates a MathML number element ( <cn> ). |
Uses of Complex in JSci.maths |
---|
Fields in JSci.maths declared as Complex | |
---|---|
static Complex |
Complex.I
The complex number 0+1i. |
static Complex |
Complex.ONE
The complex number 1+0i. |
static Complex |
Complex.ZERO
The complex number 0+0i. |
Methods in JSci.maths that return Complex | |
---|---|
static Complex |
Complex.acos(Complex z)
Returns the arc cosine of a complex number, in the range of (0.0 through ![]() ![]() |
static Complex |
Complex.acosh(Complex z)
Returns the arc hyperbolic cosine of a complex number, in the range of (0.0 through ![]() ![]() |
Complex |
Complex.add(Complex z)
Returns the addition of this complex number and another. |
Complex |
Complex.addImag(double imag)
Returns the addition of this complex number with an imaginary part. |
Complex |
Complex.addReal(double real)
Returns the addition of this complex number with a real part. |
static Complex[] |
ArrayMath.apply(ComplexMapping m,
Complex[] v)
Apply a map to every component of an array. |
static Complex[][] |
ArrayMath.apply(ComplexMapping m,
Complex[][] v)
Apply a map to every component of an array. |
static Complex |
Complex.asin(Complex z)
Returns the arc sine of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
static Complex |
Complex.asinh(Complex z)
Returns the arc hyperbolic sine of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
static Complex |
Complex.atan(Complex z)
Returns the arc tangent of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
static Complex |
Complex.atanh(Complex z)
Returns the arc hyperbolic tangent of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
Complex |
Complex.conjugate()
Returns the complex conjugate of this complex number. |
static Complex |
Complex.cos(Complex z)
Returns the trigonometric cosine of a complex angle. |
static Complex |
Complex.cosh(Complex z)
Returns the hyperbolic cosine of a complex number. |
Complex |
ComplexSquareMatrix.det()
Returns the determinant. |
Complex |
ComplexDiagonalMatrix.det()
Returns the determinant. |
Complex |
Complex.divide(Complex z)
Returns the division of this complex number by another. |
Complex |
Complex.divide(double x)
Returns the division of this complex number by a scalar. |
static Complex[] |
WaveletMath.downsample(Complex[] filter,
Complex[] data)
Part of the Fast Wavelet Scheme. |
static Complex |
Complex.exp(Complex z)
Returns the exponential number e (2.718...) raised to the power of a complex number. |
Complex |
Supernumber.getBody()
Returns the body (rank 0) of this supernumber. |
Complex |
Complex3Vector.getComponent(int n)
Returns a component of this vector. |
Complex |
ComplexVector.getComponent(int n)
Returns a component of this vector. |
Complex |
ComplexMatrix.getElement(int i,
int j)
Returns an element of the matrix. |
Complex |
ComplexDiagonalMatrix.getElement(int i,
int j)
Returns an element of the matrix. |
Complex |
ComplexTridiagonalMatrix.getElement(int i,
int j)
Returns an element of the matrix. |
Complex |
Supernumber.getSoul1(int i)
Returns the a-number soul (rank 1) of this supernumber. |
Complex |
Supernumber.getSoul2(int i)
Returns the c-number soul (rank 2) of this supernumber. |
Complex |
Supernumber.getSoul3(int i)
Returns the a-number soul (rank 3) of this supernumber. |
Complex |
Supernumber.getSoul4()
Returns the c-number soul (rank 4) of this supernumber. |
static Complex[] |
FourierMath.inverseTransform(Complex[] data)
Inverse Fourier transform. |
static Complex[] |
FourierMath.inverseTransform(double[] data)
Inverse Fourier transform. |
static Complex[] |
FourierMath.inverseTransform(double[] dataReal,
double[] dataImag)
Inverse Fourier transform. |
static Complex |
Complex.log(Complex z)
Returns the natural logarithm (base e) of a complex number. |
Complex |
ComplexMapping.map(Complex z)
A user-defined complex function. |
Complex |
ComplexMapping.map(double real,
double imag)
A user-defined complex function. |
Complex |
Complex.multiply(Complex z)
Returns the multiplication of this complex number and another. |
Complex |
Complex.multiply(double x)
Returns the multiplication of this complex number by a scalar. |
static Complex |
Complex.polar(double mod,
double arg)
Creates a complex number with the given modulus and argument. |
Complex |
Complex.pow(Complex z)
Returns this complex number raised to the power of another. |
Complex |
Complex.pow(double x)
Returns this complex number raised to the power of a scalar. |
Complex |
Complex3Vector.scalarProduct(Complex3Vector v)
Returns the scalar product of this vector and another. |
Complex |
ComplexVector.scalarProduct(ComplexVector v)
Returns the scalar product of this vector and another. |
Complex |
ComplexVector.scalarProduct(HilbertSpace.Member v)
Returns the scalar product of this vector and another. |
static Complex |
Complex.sin(Complex z)
Returns the trigonometric sine of a complex angle. |
static Complex |
Complex.sinh(Complex z)
Returns the hyperbolic sine of a complex number. |
static Complex[] |
FourierMath.sort(Complex[] output)
Sorts the output from the Fourier transfom methods into ascending frequency/time order. |
Complex |
Complex.sqr()
Returns the square of this complex number. |
Complex |
Complex.sqrt()
Returns the square root of this complex number. |
Complex |
Complex.subtract(Complex z)
Returns the subtraction of this complex number by another. |
Complex |
Complex.subtractImag(double imag)
Returns the subtraction of this complex number by an imaginary part. |
Complex |
Complex.subtractReal(double real)
Returns the subtraction of this complex number by a real part. |
static Complex |
Complex.tan(Complex z)
Returns the trigonometric tangent of a complex angle. |
static Complex |
Complex.tanh(Complex z)
Returns the hyperbolic tangent of a complex number. |
Complex |
ComplexSquareMatrix.trace()
Returns the trace. |
Complex |
ComplexDiagonalMatrix.trace()
Returns the trace. |
Complex |
ComplexTridiagonalMatrix.trace()
Returns the trace. |
static Complex[] |
FourierMath.transform(Complex[] data)
Fourier transform. |
static Complex[] |
FourierMath.transform(double[] data)
Fourier transform. |
static Complex[] |
FourierMath.transform(double[] dataReal,
double[] dataImag)
Fourier transform. |
static Complex[] |
WaveletMath.upsample(Complex[] data)
Insertion of zeros between every other data point in 1D. |
static Complex[] |
WaveletMath.upsample(Complex[] filter,
Complex[] data)
Part of the Fast Wavelet Scheme. |
Methods in JSci.maths with parameters of type Complex | |
---|---|
static Complex |
Complex.acos(Complex z)
Returns the arc cosine of a complex number, in the range of (0.0 through ![]() ![]() |
static Complex |
Complex.acosh(Complex z)
Returns the arc hyperbolic cosine of a complex number, in the range of (0.0 through ![]() ![]() |
Complex |
Complex.add(Complex z)
Returns the addition of this complex number and another. |
static Complex[] |
ArrayMath.apply(ComplexMapping m,
Complex[] v)
Apply a map to every component of an array. |
static Complex[][] |
ArrayMath.apply(ComplexMapping m,
Complex[][] v)
Apply a map to every component of an array. |
static Complex |
Complex.asin(Complex z)
Returns the arc sine of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
static Complex |
Complex.asinh(Complex z)
Returns the arc hyperbolic sine of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
static Complex |
Complex.atan(Complex z)
Returns the arc tangent of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
static Complex |
Complex.atanh(Complex z)
Returns the arc hyperbolic tangent of a complex number, in the range of (- ![]() ![]() ![]() ![]() |
static Complex |
Complex.cos(Complex z)
Returns the trigonometric cosine of a complex angle. |
static Complex |
Complex.cosh(Complex z)
Returns the hyperbolic cosine of a complex number. |
Complex |
Complex.divide(Complex z)
Returns the division of this complex number by another. |
static Complex[] |
WaveletMath.downsample(Complex[] filter,
Complex[] data)
Part of the Fast Wavelet Scheme. |
static Complex[] |
WaveletMath.downsample(Complex[] filter,
Complex[] data)
Part of the Fast Wavelet Scheme. |
static Complex |
Complex.exp(Complex z)
Returns the exponential number e (2.718...) raised to the power of a complex number. |
static Complex[] |
FourierMath.inverseTransform(Complex[] data)
Inverse Fourier transform. |
static Complex |
Complex.log(Complex z)
Returns the natural logarithm (base e) of a complex number. |
Complex |
ComplexMapping.map(Complex z)
A user-defined complex function. |
static double[] |
ArrayMath.mod(Complex[] v)
Return the componentwise modulus of an array of Complex numbers. |
static double[][] |
ArrayMath.mod(Complex[][] v)
Return the componentwise modulus of an array of Complex numbers. |
Complex |
Complex.multiply(Complex z)
Returns the multiplication of this complex number and another. |
Complex |
Complex.pow(Complex z)
Returns this complex number raised to the power of another. |
ComplexMatrix |
ComplexMatrix.scalarDivide(Complex z)
Returns the division of this matrix by a scalar. |
ComplexVector |
Complex3Vector.scalarDivide(Complex z)
Returns the division of this vector by a scalar. |
ComplexVector |
ComplexVector.scalarDivide(Complex z)
Returns the division of this vector by a scalar. |
ComplexMatrix |
ComplexMatrix.scalarMultiply(Complex z)
Returns the multiplication of this matrix by a scalar. |
ComplexMatrix |
ComplexSquareMatrix.scalarMultiply(Complex z)
Returns the multiplication of this matrix by a scalar. |
ComplexMatrix |
ComplexDiagonalMatrix.scalarMultiply(Complex z)
Returns the multiplication of this matrix by a scalar. |
ComplexVector |
Complex3Vector.scalarMultiply(Complex z)
Returns the multiplication of this vector by a scalar. |
ComplexVector |
ComplexVector.scalarMultiply(Complex z)
Returns the multiplication of this vector by a scalar. |
ComplexMatrix |
ComplexTridiagonalMatrix.scalarMultiply(Complex z)
Returns the multiplication of this matrix by a scalar. |
void |
Supernumber.setBody(Complex b)
Sets the body (rank 0) of this supernumber. |
void |
Complex3Vector.setComponent(int n,
Complex z)
Sets the value of a component of this vector. |
void |
ComplexVector.setComponent(int n,
Complex z)
Sets the value of a component of this vector. |
void |
ComplexMatrix.setElement(int i,
int j,
Complex z)
Sets the value of an element of the matrix. |
void |
ComplexDiagonalMatrix.setElement(int i,
int j,
Complex z)
Sets the value of an element of the matrix. |
void |
ComplexTridiagonalMatrix.setElement(int i,
int j,
Complex z)
Sets the value of an element of the matrix. |
void |
Supernumber.setSoul1(int i,
Complex s)
Sets the a-number soul (rank 1) of this supernumber. |
void |
Supernumber.setSoul2(int i,
Complex s)
Sets the c-number soul (rank 2) of this supernumber. |
void |
Supernumber.setSoul3(int i,
Complex s)
Sets the a-number soul (rank 3) of this supernumber. |
void |
Supernumber.setSoul4(Complex s)
Sets the c-number soul (rank 4) of this supernumber. |
static Complex |
Complex.sin(Complex z)
Returns the trigonometric sine of a complex angle. |
static Complex |
Complex.sinh(Complex z)
Returns the hyperbolic sine of a complex number. |
static Complex[] |
FourierMath.sort(Complex[] output)
Sorts the output from the Fourier transfom methods into ascending frequency/time order. |
Complex |
Complex.subtract(Complex z)
Returns the subtraction of this complex number by another. |
static Complex |
Complex.tan(Complex z)
Returns the trigonometric tangent of a complex angle. |
static Complex |
Complex.tanh(Complex z)
Returns the hyperbolic tangent of a complex number. |
static Complex[] |
FourierMath.transform(Complex[] data)
Fourier transform. |
static Complex[] |
WaveletMath.upsample(Complex[] data)
Insertion of zeros between every other data point in 1D. |
static Complex[] |
WaveletMath.upsample(Complex[] filter,
Complex[] data)
Part of the Fast Wavelet Scheme. |
static Complex[] |
WaveletMath.upsample(Complex[] filter,
Complex[] data)
Part of the Fast Wavelet Scheme. |
Constructors in JSci.maths with parameters of type Complex | |
---|---|
Complex3Vector(Complex x,
Complex y,
Complex z)
Constructs a 3-vector. |
|
ComplexDiagonalMatrix(Complex[] array)
Constructs a matrix from an array containing the diagonal elements. |
|
ComplexDiagonalMatrix(Complex[][] array)
Constructs a matrix from an array. |
|
ComplexMatrix(Complex[][] array)
Constructs a matrix from an array. |
|
ComplexSquareMatrix(Complex[][] array)
Constructs a matrix from an array. |
|
ComplexTridiagonalMatrix(Complex[][] array)
Constructs a matrix from an array. |
|
ComplexVector(Complex[] array)
Constructs a vector from an array. |
Uses of Complex in JSci.maths.algebras |
---|
Methods in JSci.maths.algebras that return Complex | |
---|---|
Complex |
HilbertSpace.Member.scalarProduct(HilbertSpace.Member v)
The scalar product law. |
Methods in JSci.maths.algebras with parameters of type Complex | |
---|---|
VectorSpace.Member |
HilbertSpace.getVector(Complex[] array)
Returns a vector from the Hilbert space. |
Uses of Complex in JSci.maths.categories |
---|
Methods in JSci.maths.categories with parameters of type Complex | |
---|---|
VectorSpace.Member |
Hilb.OperatorSpace.getVector(Complex[][] array)
Returns an element of this hom-set. |
Constructors in JSci.maths.categories with parameters of type Complex | |
---|---|
Hilb.LinearMap(Complex[][] array)
|
Uses of Complex in JSci.maths.chaos |
---|
Fields in JSci.maths.chaos declared as Complex | |
---|---|
static Complex |
JuliaSet.RABBIT
|
static Complex |
JuliaSet.SAN_MARCO
|
static Complex |
JuliaSet.SIEGEL_DISK
|
Methods in JSci.maths.chaos that return Complex | |
---|---|
Complex |
MandelbrotMap.getConstant()
Returns the constant. |
Complex |
MandelbrotMap.iterate(int n,
Complex z)
Iterates the map. |
Complex |
MandelbrotMap.map(Complex z)
Performs the mapping. |
Complex |
MandelbrotMap.map(double real,
double imag)
Performs the mapping. |
Methods in JSci.maths.chaos with parameters of type Complex | |
---|---|
int |
MandelbrotSet.isMember(Complex z,
int maxIter)
Returns 0 if z is a member of this set, else the number of iterations it took for z to diverge to infinity. |
int |
JuliaSet.isMember(Complex z,
int maxIter)
Returns 0 if z is a member of this set, else the number of iterations it took for z to diverge to infinity. |
Complex |
MandelbrotMap.iterate(int n,
Complex z)
Iterates the map. |
Complex |
MandelbrotMap.map(Complex z)
Performs the mapping. |
void |
MandelbrotMap.setConstant(Complex aval)
Sets the constant. |
Constructors in JSci.maths.chaos with parameters of type Complex | |
---|---|
JuliaSet(Complex c)
Constructs a Julia set. |
|
MandelbrotMap(Complex aval)
Constructs a Mandelbrot map. |
Uses of Complex in JSci.maths.fields |
---|
Fields in JSci.maths.fields declared as Complex | |
---|---|
static Complex |
ComplexField.HALF
|
static Complex |
ComplexField.HALF_I
|
static Complex |
ComplexField.I
|
static Complex |
ComplexField.MINUS_HALF
|
static Complex |
ComplexField.MINUS_HALF_I
|
static Complex |
ComplexField.MINUS_I
|
static Complex |
ComplexField.MINUS_ONE
|
static Complex |
ComplexField.MINUS_PI_2
|
static Complex |
ComplexField.MINUS_PI_2_I
|
static Complex |
ComplexField.MINUS_SQRT_HALF_I
|
static Complex |
ComplexField.MINUS_TWO
|
static Complex |
ComplexField.ONE
|
static Complex |
ComplexField.PI
|
static Complex |
ComplexField.PI_2
|
static Complex |
ComplexField.PI_2_I
|
static Complex |
ComplexField.PI_I
|
static Complex |
ComplexField.SQRT_HALF
|
static Complex |
ComplexField.SQRT_HALF_I
|
static Complex |
ComplexField.TWO
|
static Complex |
ComplexField.ZERO
|
Uses of Complex in JSci.maths.groups |
---|
Methods in JSci.maths.groups that return Complex | |
---|---|
Complex |
U1.getElement(double param)
Returns an element from within the group. |
Methods in JSci.maths.groups with parameters of type Complex | |
---|---|
boolean |
U1.isIdentity(Complex a)
Returns true if the element is the identity element of this group. |
boolean |
U1.isInverse(Complex a,
Complex b)
Returns true if one element is the inverse of the other. |
Uses of Complex in JSci.maths.polynomials |
---|
Methods in JSci.maths.polynomials that return Complex | |
---|---|
static Complex |
PolynomialMath.evalPolynomial(Complex[] coeff,
Complex t)
Same as above for complex numbers |
Complex |
ComplexPolynomial.getCoefficientAsComplex(int n)
|
Complex[] |
ComplexPolynomial.getCoefficientsAsComplexes()
Return the coefficients as an array of complex numbers. |
static Complex[] |
PolynomialMath.getNullPoints(Polynomial p)
Calculate the null points of a given polynomial by solving the eigenvalue problem for the frobenius matrix This is not yet implemented (depends on a QR- decomposition) |
static Complex[] |
PolynomialMath.interpolateLagrange(Complex[][] samplingPoints)
Get the coefficients of the interpolation polynomial Caveat: this method is brute-force, slow and not very stable. |
static Complex |
PolynomialMath.interpolateLagrange(Complex[][] samplingPoints,
Complex t)
Interpolate a value by given sampling points. |
protected static Complex[] |
ComplexPolynomialRing.toComplex(Field.Member[] f)
Internal method for typesafe cast |
Methods in JSci.maths.polynomials with parameters of type Complex | |
---|---|
ComplexPolynomial |
ComplexPolynomial.divide(Complex a)
Returns the division of this polynomial by a scalar. |
static Complex |
PolynomialMath.evalPolynomial(Complex[] coeff,
Complex t)
Same as above for complex numbers |
static Complex |
PolynomialMath.evalPolynomial(Complex[] coeff,
Complex t)
Same as above for complex numbers |
static Complex[] |
PolynomialMath.interpolateLagrange(Complex[][] samplingPoints)
Get the coefficients of the interpolation polynomial Caveat: this method is brute-force, slow and not very stable. |
static Complex |
PolynomialMath.interpolateLagrange(Complex[][] samplingPoints,
Complex t)
Interpolate a value by given sampling points. |
static Complex |
PolynomialMath.interpolateLagrange(Complex[][] samplingPoints,
Complex t)
Interpolate a value by given sampling points. |
ComplexPolynomial |
ComplexPolynomial.multiply(Complex a)
Returns the multiplication of this polynomial by a scalar. |
ComplexPolynomial |
ComplexLagrangeBasis.superposition(Complex[] c)
|
Constructors in JSci.maths.polynomials with parameters of type Complex | |
---|---|
ComplexPolynomial(Complex[] coeff)
Creates a new instance of ComplexPolynomial |
Uses of Complex in JSci.maths.wavelet |
---|
Methods in JSci.maths.wavelet that return Complex | |
---|---|
Complex[] |
Signal.fft()
|
static Complex[] |
Signal.fft(Complex[] data)
|
static Complex[] |
Signal.fft(double[] data)
This is merely a copy of the FFT method found in the class FourierMath with some changes... |
static Complex[] |
Signal.fftInverse(Complex[] data)
Also noted iFFT in other packages. |
Methods in JSci.maths.wavelet with parameters of type Complex | |
---|---|
static Complex[] |
Signal.fft(Complex[] data)
|
static Complex[] |
Signal.fftInverse(Complex[] data)
Also noted iFFT in other packages. |
Uses of Complex in JSci.physics.quantum |
---|
Methods in JSci.physics.quantum that return Complex | |
---|---|
Complex |
GammaMatrix.det()
Returns the determinant. |
static Complex |
QuantumMath.expectation(DensityMatrix dm,
Operator op)
Returns the expectation value. |
static Complex |
QuantumMath.expectation(Operator op,
KetVector ket)
Returns the expectation value. |
Complex |
BraVector.multiply(KetVector ket)
Returns the multiplication of this bra vector and a ket vector. |
static Complex |
QuantumMath.probability(DensityMatrix dm,
Projector p)
Returns the probability. |
static Complex |
QuantumMath.probability(Projector p,
KetVector ket)
Returns the probability. |
Complex |
GammaMatrix.trace()
Returns the trace. |
Complex |
SpinOperator.trace()
Returns the trace. |
Complex |
Operator.trace()
Returns the trace. |
Uses of Complex in JSci.util |
---|
Methods in JSci.util that return Complex | |
---|---|
Complex |
RandomMap.map(Complex z)
|
Complex |
RandomMap.map(double real,
double imag)
|
Methods in JSci.util with parameters of type Complex | |
---|---|
Complex |
RandomMap.map(Complex z)
|
|
||||||||||
PREV NEXT | FRAMES NO FRAMES |