- S - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The pi/4 phase rotation operator acting on a single qubit.
- S_H - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The Hermitian conjugate of the pi/4 phase rotation acting on a single qubit.
- save() - Method in class org.mathIT.genes.DNA
-
Saves this genome in gnom format.
- save() - Method in class org.mathIT.genes.Genome
-
Saves this genome in GNOM format.
- save(ArrayList<ORF>) - Static method in class org.mathIT.genes.ORF
-
Saves this genome in GENE format.
- save() - Method in class org.mathIT.genes.Protein
-
Saves this protein in PROT format.
- save(String, CharSequence) - Static method in class org.mathIT.genes.Utils
-
Saves the specified character sequence.
- save(String, CharSequence) - Static method in class org.mathIT.util.Files
-
Saves the specified text to a file.
- save(String, CharSequence, boolean) - Static method in class org.mathIT.util.Files
-
Saves the specified text to a file.
- saveAsCSV() - Method in class org.mathIT.genes.Genome
-
Saves this genome as CSV file.
- saveAsCSV() - Method in class org.mathIT.genes.Protein
-
Saves this protein as CSV file.
- saveAsCSV() - Method in class org.mathIT.graphs.Graph
-
This method asks the user to select a file name
and saves a representation of this graph as a CSV file.
- saveOccurrencesAsText(String, TreeMap<String, Integer>, int) - Static method in class org.mathIT.genes.Utils
-
Saves those occurrences of a frequency distribution which have the specified
frequency into a text file.
- saveOccurrencesAsText(String, TreeMap<String, Integer>, int, char[]) - Static method in class org.mathIT.genes.Utils
-
Saves those occurrences of a frequency distribution which have the specified
frequency into a text file.
- saveWordFrequenciesAsCSV() - Static method in class org.mathIT.genes.Utils
-
This method asks the user to select a list of files,
computes the word frequencies and saves them in a CSV file.
- scaler - Variable in class org.mathIT.gui.GraphViewer
-
- selectFASTAFiles() - Static method in class org.mathIT.genes.Utils
-
Asks the user to select a directory and returns a list of FASTA files.
- SEPARATOR - Static variable in class org.mathIT.graphs.Graph
-
Column separator for CSV files.
- Set<E> - Class in org.mathIT.algebra
-
This class enables to create finite mathematical sets and supplies some of the
usual mathematical set operations such as immutable copy, set difference,
union, or intersection.
- Set() - Constructor for class org.mathIT.algebra.Set
-
Constructs a new, empty set; the backing HashMap instance has default
initial capacity (16) and load factor (0.75).
- Set(Collection<? extends E>) - Constructor for class org.mathIT.algebra.Set
-
Constructs a new set containing the elements in the specified collection.
- Set(int) - Constructor for class org.mathIT.algebra.Set
-
Constructs a new, empty set; the backing HashMap instance has the
specified initial capacity and default load factor (0.75).
- Set(int, float) - Constructor for class org.mathIT.algebra.Set
-
Constructs a new, empty set; the backing HashMap instance has the
specified initial capacity and the specified load factor.
- Set(E[]) - Constructor for class org.mathIT.algebra.Set
-
Constructs a new set from the input array.
- setActive(boolean) - Method in interface org.mathIT.graphs.Activatable
-
Sets the flag whether this vertex is active.
- setActive(boolean) - Method in class org.mathIT.graphs.Actor
-
Sets the flag whether this actor is active.
- setActive(boolean) - Method in interface org.mathIT.graphs.NetworkOfActivatables
-
Sets this network as active, i.e., it has had at least one of its nodes
been active during the history of this network.
- setActive(boolean) - Method in class org.mathIT.graphs.SocialNetwork
-
Sets this network as active, i.e., it has had at least one of its nodes
been active during the history of this network.
- setAdjacency(V[]) - Method in class org.mathIT.graphs.Vertex
-
Sets the adjacency list of this vertex as specified by the weighted
graph it belongs to.
- setAdjacency(V[]) - Method in interface org.mathIT.graphs.Vertible
-
Sets the adjacency list of this vertex as specified by the
graph it belongs to.
- setAngles(double, double) - Method in class org.mathIT.plot.ComplexPlotPane
-
Sets the rotation angles of this plot.
- setBackground(Color) - Method in class org.mathIT.plot.ComplexPlotPane
-
- setDistance(double) - Method in class org.mathIT.graphs.Vertex
-
Sets the distance of the shortest path from a
specified source to this vertex as determined by the Dijkstra algorithm.
- setDistance(double) - Method in interface org.mathIT.graphs.Vertible
-
Sets the distance of the shortest path from a
specified source to this vertex as determined by the Dijkstra algorithm.
- setDrawAxes(boolean) - Method in class org.mathIT.plot.ComplexPlotPane
-
Decides whether to draw the coordinate axes of this plot.
- setDrawGrid(boolean) - Method in class org.mathIT.plot.Plot3DPane
-
Decides whether a coordinate grid is plotted.
- setDrawGrid(boolean) - Method in class org.mathIT.plot.PlotPane
-
Decides whether a coordinate grid is plotted.
- setDrawTicks(boolean) - Method in class org.mathIT.plot.Plot3DPane
-
Decides whether coordinate ticks are plotted.
- setDrawTicks(boolean) - Method in class org.mathIT.plot.PlotPane
-
Decides whether coordinate ticks are plotted.
- setFinalStep() - Method in class org.mathIT.quantum.Circuit
-
Sets the quantum cicuit into its final state.
- setFinalStep() - Method in class org.mathIT.quantum.stabilizer.Circuit
-
Sets the quantum cicuit into its final state.
- setFPixels(int[][]) - Method in class org.mathIT.plot.PlotPane
-
Sets the function pixel values of this plot.
- setImaginary(double[]) - Method in class org.mathIT.quantum.Register
-
Returns the array containing the imaginary parts of the qubit state components
of this register.
- setImaginary(double[]) - Method in class org.mathIT.quantum.stabilizer.Register
-
Returns the array containing the imaginary parts of the qubit state components
of this register.
- setImaginaryPart(boolean) - Method in class org.mathIT.plot.ComplexPlotPane
-
Decides whether the imaginary part of the function is plotted.
- setIndex(int) - Method in class org.mathIT.graphs.Vertex
-
Sets the index of this vertex as specified by the weighted graph it belongs to.
- setIndex(int) - Method in interface org.mathIT.graphs.Vertible
-
Sets the index of this vertex as specified by the graph it belongs to.
- setInitialQubits(int[]) - Method in class org.mathIT.quantum.Circuit
-
Sets the initial states of the qubits of this quantum circuit.
- setInitialQubits(int[]) - Method in class org.mathIT.quantum.stabilizer.Circuit
-
Sets the initial states of the qubits of this quantum circuit.
- setInitialState(int[]) - Method in class org.mathIT.quantum.Circuit
-
Determines the initial state of the quantum circuit.
- setInitialState(int[]) - Method in class org.mathIT.quantum.stabilizer.Circuit
-
Determines the initial state of the quantum circuit.
- setInProcess(boolean) - Method in class org.mathIT.graphs.Vertex
-
Sets this vertex process flag to the specified value.
- setInProcess(boolean) - Method in interface org.mathIT.graphs.Vertible
-
Sets this vertex process flag to the specified value.
- setLimits(double, double, double, double, double, double) - Method in class org.mathIT.plot.ComplexPlotPane
-
Sets the limits for the values.
- setMarked(boolean) - Method in class org.mathIT.graphs.Vertex
-
Sets this vertex mark flag to the specified value.
- setMarked(boolean) - Method in interface org.mathIT.graphs.Vertible
-
Sets this vertex mark flag to the specified value.
- setName(String) - Method in class org.mathIT.graphs.Vertex
-
Sets the name of this vertex as specified by the weighted graph it belongs to.
- setName(String) - Method in interface org.mathIT.graphs.Vertible
-
Sets the index of this vertex as specified by the graph it belongs to.
- setNextStep() - Method in class org.mathIT.quantum.Circuit
-
Executes the next quantum gate in this quantum circuit.
- setNextStep() - Method in class org.mathIT.quantum.stabilizer.Circuit
-
Executes the next quantum gate in this quantum circuit.
- setOrigin(int, int) - Method in class org.mathIT.plot.PlotPane
-
Sets the origin of this plot pane.
- setPredecessor(V) - Method in class org.mathIT.graphs.Vertex
-
Sets the predecessor of this vertex in the shortest path from a
specified source as determined by the Dijkstra algorithm.
- setPredecessor(V) - Method in interface org.mathIT.graphs.Vertible
-
Sets the predecessor of this vertex in the shortest path from a
specified source as determined by the Dijkstra algorithm.
- setPreviousStep() - Method in class org.mathIT.quantum.Circuit
-
Executes the inverse of the previously executed quantum gate in this quantum circuit.
- setPreviousStep() - Method in class org.mathIT.quantum.stabilizer.Circuit
-
Executes the inverse of the previously executed quantum gate in this quantum circuit.
- setReal(double[]) - Method in class org.mathIT.quantum.Register
-
Returns the array containing the real parts of the qubit state components
of this register.
- setReal(double[]) - Method in class org.mathIT.quantum.stabilizer.Register
-
Returns the array containing the real parts of the qubit state components
of this register.
- setRealPart(boolean) - Method in class org.mathIT.plot.ComplexPlotPane
-
Decides whether the real part of the function is plotted.
- setThreshold(double) - Method in interface org.mathIT.graphs.Activatable
-
Sets the threshold of this vertex.
- setThreshold(double) - Method in class org.mathIT.graphs.Actor
-
Sets the threshold of this actor.
- setTicks(double[], int[], double[], int[], double[], int[]) - Method in class org.mathIT.plot.Plot3DPane
-
Sets ticks for this plot.
- setTicks(double[], int[], double[], int[]) - Method in class org.mathIT.plot.PlotPane
-
Sets ticks for this plot.
- setUndirected(boolean) - Method in class org.mathIT.graphs.Graph
-
Sets the flag whether this graph is undirected.
- setValue(int, int, double) - Method in class org.mathIT.algebra.Matrix
-
Sets the value into the matrix position given by the parameters row and col
in the usual mathematical convention, that is, both indices are
counted from 1 and terminate at the maximum number of rows or columns, respectively.
- setVertices(V[]) - Method in class org.mathIT.graphs.Graph
-
Sets the vertices of this graph.
- setVLimits(int, int, int, int) - Method in class org.mathIT.plot.ComplexPlotPane
-
Sets the limit projected values.
- sGate(int) - Method in class org.mathIT.quantum.Register
-
Applies the S gate to the j-th qubit.
- sGate(int) - Method in class org.mathIT.quantum.stabilizer.GraphRegister
-
Applies an S gate, or "phase gate", on vertex v.
- sGate(int) - Method in class org.mathIT.quantum.stabilizer.Register
-
Applies the S gate to the j-th qubit.
- shortValue() - Method in class org.mathIT.numbers.Quaternion
-
Returns the short value of the real part of this quaternion (by casting to type short).
- show(JTable) - Static method in class org.mathIT.graphs.Graph
-
This method displays the specified table in a simple option pane.
- show(JTable) - Static method in class org.mathIT.graphs.WeightedGraph
-
- show(int) - Method in class org.mathIT.quantum.Register
-
Returns a string representation of the first nMax
qubits of
this register.
- show(int) - Method in class org.mathIT.quantum.stabilizer.Register
-
Returns a string representation of the first nMax
qubits of
this register.
- showDaubCoefficients(String) - Static method in class org.mathIT.approximation.Wavelets
-
Returns a structured string representation of the normalized Daubechies
filter coefficients
h
, in the specified format.
- showWaveletCoefficients(double[][]) - Static method in class org.mathIT.approximation.Wavelets
-
Returns a structured string representation of the wavelet coefficients
given by the array w.
- signProd(double, double) - Static method in class org.mathIT.statistics.Probability
-
returns sign(xy).
- SimpleVertex - Class in org.mathIT.graphs
-
An instance of this class represents a vertex of a directed graph.
- SimpleVertex(int) - Constructor for class org.mathIT.graphs.SimpleVertex
-
Creates a vertex with the specified index which also specifies its name.
- SimpleVertex(String) - Constructor for class org.mathIT.graphs.SimpleVertex
-
Creates a vertex with the specified name.
- SimpleVertex(int, String) - Constructor for class org.mathIT.graphs.SimpleVertex
-
Creates a vertex with the specified index and name.
- SimpleVertex(int, String, SimpleVertex[]) - Constructor for class org.mathIT.graphs.SimpleVertex
-
Creates a vertex with the specified name, index, and adjacency list.
- sin(BigDecimal) - Static method in class org.mathIT.numbers.BigNumbers
-
Returns the trigonometric sine of an angle x.
- sin(BigDecimal, int) - Static method in class org.mathIT.numbers.BigNumbers
-
Returns the trigonometric sine of an angle x
with |x| ≤ π/4, up to the approximation order n.
- sin(double[]) - Static method in class org.mathIT.numbers.Complex
-
Returns the sine of a complex number z.
- sin(Complex) - Static method in class org.mathIT.numbers.Complex
-
Returns the sine of a complex number z.
- sin() - Method in class org.mathIT.numbers.Complex
-
Returns the sine of this complex number.
- SingularValueDecomposition - Class in org.mathIT.algebra
-
Singular Value Decomposition.
- SingularValueDecomposition(Matrix) - Constructor for class org.mathIT.algebra.SingularValueDecomposition
-
Construct the singular value decomposition Structure to access U, S and V.
- size() - Method in class org.mathIT.algebra.EnumSet
-
Returns the size of this EnumSet, that is, the number of its elements.
- size() - Method in class org.mathIT.graphs.FibonacciHeap
-
Returns the size of the heap which is measured in the number of elements
contained in the heap.
- size() - Method in class org.mathIT.graphs.PriorityQueue
-
Returns the number of elements in this priority queue.
- size - Variable in class org.mathIT.quantum.Register
-
The number of qubits of this register.
- size - Variable in class org.mathIT.quantum.stabilizer.Register
-
The number of qubits of this register.
- size() - Method in class org.mathIT.util.Tuple
-
- smiX - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The Sqrt(-iX) operator acting on a single qubit.
- smiY - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The Sqrt(-iY) operator acting on a single qubit.
- smiZ - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The Sqrt(-iZ) operator acting on a single qubit.
- SocialNetwork - Class in org.mathIT.graphs
-
This class represents a social network as a directed graph
of individual nodes represented by actors
.
- SocialNetwork(Actor[], double[][]) - Constructor for class org.mathIT.graphs.SocialNetwork
-
Creates a social network of the specified actors and their directed and weighted
relations determined by the specified weight matrix.
- SocialNetwork(Actor[], int[][]) - Constructor for class org.mathIT.graphs.SocialNetwork
-
Creates a social network of the specified actors and their directed
relations determined by the specified adjacency matrix.
- SocialNetwork(boolean, Actor[], double[][]) - Constructor for class org.mathIT.graphs.SocialNetwork
-
Creates a social network of the specified actors and their
relations determined by the specified flag whether they are symmetric
and by the specified weight matrix.
- SocialNetwork(boolean, Actor[], int[][]) - Constructor for class org.mathIT.graphs.SocialNetwork
-
Creates a social network of the specified actors and their
relations determined by the specified flag whether they are symmetric
and by the specified adjacency matrix.
- solve(Matrix) - Method in class org.mathIT.algebra.Matrix
-
This method solves the n linear equation Ax = b,
where A is this matrix and b the given vector.
- solveLinearDiophantine(long, long, long) - Static method in class org.mathIT.numbers.Numbers
-
Returns the array {
d,x,y} such that the linear Diophantine equation
ax + by = c
is solved and d = gcd(a,b).
- spiX - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The Sqrt(+iX) operator acting on a single qubit.
- spiY - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The Sqrt(+iY) operator acting on a single qubit.
- spiZ - Static variable in class org.mathIT.quantum.stabilizer.LocalCliffordOperator
-
The Sqrt(+iZ) operator acting on a single qubit.
- sqr(BigInteger) - Static method in class org.mathIT.numbers.BigNumbers
-
Returns the value of x2.
- sqr(long) - Static method in class org.mathIT.numbers.Numbers
-
Returns the value of x2.
- sqrt(BigInteger) - Static method in class org.mathIT.numbers.BigNumbers
-
Returns the square root of
z, with an accuracy of 10
-50/2 z.
- sqrt(BigDecimal, int) - Static method in class org.mathIT.numbers.BigNumbers
-
Returns the square root of
z, with an accuracy of 10
-50/2 z.
- sqrt(BigDecimal) - Static method in class org.mathIT.numbers.BigNumbers
-
Returns the square root of
z, with an accuracy of 10
-50/2 z.
- sqrt(double[]) - Static method in class org.mathIT.numbers.Complex
-
Returns the square root of a complex number z.
- sqrt(Complex) - Static method in class org.mathIT.numbers.Complex
-
Returns the square root of a complex number z.
- SQRT2 - Static variable in class org.mathIT.numbers.Numbers
-
constant representing the square root of 2.
- SQRT3 - Static variable in class org.mathIT.numbers.Numbers
-
constant representing the square root of 3.
- SQRT_1_2 - Static variable in class org.mathIT.numbers.Numbers
-
Square root of 1/2.
- SQRT_ONE_HALF - Static variable in class org.mathIT.numbers.BigNumbers
-
Square root of 1/2.
- SQRT_TWO - Static variable in class org.mathIT.numbers.BigNumbers
-
Square root of 2.
- sqrtX(int) - Method in class org.mathIT.quantum.Register
-
Applies the √X, or √NOT gate to the j-th qubit.
- sqrtX(int) - Method in class org.mathIT.quantum.stabilizer.Register
-
Applies the √X, or √NOT gate to the j-th qubit.
- standardNormalDensity(double) - Static method in class org.mathIT.statistics.Probability
-
Standard normal density function.
- standardNormalDistribution(double) - Static method in class org.mathIT.statistics.Probability
-
standard normal distribution.
- standardNormalQuantile(double) - Static method in class org.mathIT.statistics.Probability
-
Standard normal quantile.
- start - Variable in class org.mathIT.graphs.Edge
-
The start vertex of this edge.
- startPrinterJob() - Method in class org.mathIT.gui.GraphCanvas
-
This method starts a printer job to print out this graph canvas.
- startPrinterJob() - Method in class org.mathIT.plot.ComplexPlotPane
-
Prints this plot.
- startPrinterJob() - Method in class org.mathIT.plot.Plot3DPane
-
Prints this plot.
- startPrinterJob() - Method in class org.mathIT.plot.PlotPane
-
Prints this plot.
- studentDensity(double, int) - Static method in class org.mathIT.statistics.Probability
-
Student t-density function for n degrees of freedom.
- studentDistribution(double, int) - Static method in class org.mathIT.statistics.Probability
-
Student t-distribution function of n degrees of freedom.
- studentQuantile(double, int) - Static method in class org.mathIT.statistics.Probability
-
Computes the quantile of the Student t-distribution.
- subgraph(Set<V>) - Method in class org.mathIT.graphs.Graph
-
Returns the subgraph given by the specified set of vertices of this graph.
- subgraph(V[]) - Method in class org.mathIT.graphs.Graph
-
Returns the subgraph given by the specified array of vertices of this graph.
- subsets(int) - Method in class org.mathIT.algebra.EnumSet
-
Returns the k-element subsets of this set,
i.e., each of its k-element combination, stored in an array list.
- subsets(EnumSet<E>, int) - Static method in class org.mathIT.algebra.EnumSet
-
Returns the k-element subsets of a set s,
i.e., each k-element combination of s,
stored in an array list.
- subsets(int) - Method in class org.mathIT.algebra.MathSet
-
Returns the k-element subsets of this set,
i.e., each of its k-element combination, stored in an array list.
- subsets(Set<E>, int) - Static method in class org.mathIT.algebra.MathSet
-
Returns the k-element subsets of a set s,
i.e., each k-element combination of s,
stored in an array list.
- subsets(int) - Method in class org.mathIT.algebra.OrderedSet
-
Returns the k-element subsets of this set,
i.e., each of its k-element combination, stored in an array list.
- subsets(SortedSet<E>, int) - Static method in class org.mathIT.algebra.OrderedSet
-
Returns the k-element subsets of a set s,
i.e., each k-element combination of s,
stored in an array list.
- subsets(int) - Method in class org.mathIT.algebra.Set
-
Returns the k-element subsets of this set,
i.e., each of its k-element combination, stored in an array list.
- subsets(Set<E>, int) - Static method in class org.mathIT.algebra.Set
-
Returns the k-element subsets of a set s,
i.e., each k-element combination of s,
stored in an array list.
- subsets(SortedSet<T>, int) - Static method in class org.mathIT.numbers.Combinatorics
-
Returns the k-element subsets of a set s,
i.e., each k-element combination of s,
stored in an array list.
- subtract(double[], double[]) - Static method in class org.mathIT.numbers.Complex
-
subtracts two complex numbers x and y.
- subtract(Complex) - Method in class org.mathIT.numbers.Complex
-
subtracts z from this complex number.
- subtract(Quaternion) - Method in class org.mathIT.numbers.Quaternion
-
Subtracts y from this quaternion.
- subtract(Rational) - Method in class org.mathIT.numbers.Rational
-
Returns the rational number k = m - n where
m is this rational number.
- sum(Collection<Integer>) - Static method in class org.mathIT.numbers.Numbers
-
Returns the sum of the integers of the specified list.
- surjections(int, int) - Static method in class org.mathIT.numbers.Combinatorics
-
Returns a list of all surjections f: {0, 1, ..., n-1} →
{0, 1 ..., k-1}, each one of which encoded as an array such that
f(x) = n[x]
∈ {0, 1 ..., k-1}.
- szstnr(double, double) - Static method in class org.mathIT.statistics.Probability
-
Returns p minus the cumulative standardized normal of x.
- szstud(double, double, int) - Static method in class org.mathIT.statistics.Probability
-
returns p minus the cumulative Student distribution of (x, n).