Uses of Class
org.biojava.nbio.structure.jama.Matrix
Package
Description
Interfaces and classes for protein structure (PDB).
Classes for the alignment of structures.
Classes related to the implementation of the CE alignment algorithm, here called jCE.
Utility methods for better interaction with Jmol.
Helper classes for structural alignment.
Classes for the pairwise alignment of structures.
A few convenience classes to view protein structures with Jmol (if it is on the classpath),
to calculate a protein structure alignment and to investigate the internals of the protein structure alignment algorithm.
Matrix package for from JAMA
-
Uses of Matrix in org.biojava.nbio.structure
Modifier and TypeMethodDescriptionstatic final Matrix
Calc.matrixFromEuler
(double heading, double attitude, double bank) This conversion uses NASA standard aeroplane conventions as described on page: http://www.euclideanspace.com/maths/geometry/rotations/euler/index.htm Coordinate System: right hand Positive angle: right hand Order of euler angles: heading first, then attitude, then bank. matrix row column ordering: [m00 m01 m02] [m10 m11 m12] [m20 m21 m22]Modifier and TypeMethodDescriptionstatic javax.vecmath.Matrix4d
Calc.getTransformation
(Matrix rot, Atom trans) Convert JAMA rotation and translation to a Vecmath transformation matrix.static final double[]
Calc.getXYZEuler
(Matrix m) Convert a rotation Matrix to Euler angles.static final double[]
Calc.getZYZEuler
(Matrix m) Gets euler angles for a matrix given in ZYZ convention.static final void
calculate structure + Matrix coodinates ...static void
static final void
Rotate an Atom around a Matrix object.static final void
Rotate a group object.static final void
Rotate a structure object. -
Uses of Matrix in org.biojava.nbio.structure.align
Modifier and TypeMethodDescriptionStructurePairAligner.getDistMat()
return the difference of distance matrix between the two structures -
Uses of Matrix in org.biojava.nbio.structure.align.ce
Modifier and TypeMethodDescriptionCECalculator.getRotationMatrix()
Gets the rotation matrix from the last call tocalc_rmsd
.CeCalculatorEnhanced.getRotationMatrix()
Gets the rotation matrix from the last call tocalc_rmsd
. -
Uses of Matrix in org.biojava.nbio.structure.align.gui.jmol
Modifier and TypeMethodDescriptionAbstractAlignmentJmol.getDistanceMatrices()
Returns a List of internal Distance Matrices, one for each structure in the alignment.MultipleAlignmentJmol.getDistanceMatrices()
StructureAlignmentJmol.getDistanceMatrices()
-
Uses of Matrix in org.biojava.nbio.structure.align.helper
Modifier and TypeMethodDescriptionstatic Matrix
AlignUtils.getDistanceMatrix
(Atom[] ca1, Atom[] ca2) Matrix of all distances between two sets of Atoms. -
Uses of Matrix in org.biojava.nbio.structure.align.model
Modifier and TypeMethodDescriptionMatrix[]
AFPChain.getBlockRotationMatrix()
AFPChain.getDisTable1()
AFPChain.getDisTable2()
AFPChain.getDistanceMatrix()
A matrix with ca1length rows and ca2length columns.AFP.getM()
Modifier and TypeMethodDescriptionvoid
AFPChain.setBlockRotationMatrix
(Matrix[] blockRotationMatrix) void
AFPChain.setDisTable1
(Matrix disTable1) void
AFPChain.setDisTable2
(Matrix disTable2) void
AFPChain.setDistanceMatrix
(Matrix distanceMatrix) A matrix with ca1length rows and ca2length columns.void
-
Uses of Matrix in org.biojava.nbio.structure.align.multiple
Modifier and TypeMethodDescriptionMultipleAlignmentEnsemble.getDistanceMatrix()
Returns the List containing the interatomic distance Matrix of each structure.MultipleAlignmentEnsembleImpl.getDistanceMatrix()
-
Uses of Matrix in org.biojava.nbio.structure.align.multiple.util
Modifier and TypeMethodDescriptionstatic Matrix
MultipleAlignmentTools.getAverageResidueDistances
(List<Atom[]> transformed) The average residue distance Matrix contains the average distance from each residue to all other residues aligned with it.static Matrix
MultipleAlignmentTools.getAverageResidueDistances
(MultipleAlignment msa) The average residue distance Matrix contains the average distance from each residue to all other residues aligned with it.static Matrix
MultipleAlignmentTools.getRMSDMatrix
(MultipleAlignment msa) Calculate the RMSD matrix of a MultipleAlignment, that is, entry (i,j) of the matrix contains the RMSD between structures i and j. -
Uses of Matrix in org.biojava.nbio.structure.align.pairwise
Modifier and TypeMethodDescriptionAlternativeAlignment.getDistanceMatrix()
The distance matrix this alignment is based onstatic Matrix
AlternativeAlignment.getDistanceMatrix
(Atom[] ca1, Atom[] ca2) FragmentPair.getRot()
AlternativeAlignment.getRotationMatrix()
returns the rotation matrix that needs to be applied to structure 2 to rotate on structure 1Modifier and TypeMethodDescriptionstatic Alignable
AligNPE.align_NPE
(Matrix sim, StrucAligParameters params) Align without penalizing end-gaps.static boolean
FragmentJoiner.reduceFragments
(List<FragmentPair> fragments, FragmentPair f, Matrix rmsmat) In helices often many similar fragments can be found.void
AlternativeAlignment.setDistanceMatrix
(Matrix distanceMatrix) The distance matrix this alignment is based onvoid
-
Uses of Matrix in org.biojava.nbio.structure.align.util
Modifier and TypeMethodDescriptionRotationAxis.getFullMatrix()
Returns a matrix that describes both rotation and translation.RotationAxis.getRotationMatrix()
Get the rotation matrix corresponding to this axisRotationAxis.getRotationMatrix
(double theta) Get the rotation matrix corresponding to a rotation about this axisstatic Matrix
Modifier and TypeMethodDescriptionstatic double
Calculate the rotation angle for a given matrixstatic void
only shift CA positions.ModifierConstructorDescriptionRotationAxis
(Matrix rotation, Atom translation) Determine the location of the rotation axis based on a rotation matrix and a translation vector -
Uses of Matrix in org.biojava.nbio.structure.geometry
Modifier and TypeMethodDescriptionstatic Matrix
CalcPoint.formMatrix
(javax.vecmath.Point3d[] a, javax.vecmath.Point3d[] b) static Matrix
Matrices.getRotationJAMA
(javax.vecmath.Matrix4d transform) Convert a transformation matrix into a JAMA rotation matrix.Modifier and TypeMethodDescriptionstatic javax.vecmath.Matrix4d
Matrices.getTransformation
(Matrix rot, Matrix trans) Convert JAMA rotation and translation to a Vecmath transformation matrix. -
Uses of Matrix in org.biojava.nbio.structure.gui
-
Uses of Matrix in org.biojava.nbio.structure.jama
Modifier and TypeMethodDescriptionMatrix.arrayLeftDivide
(Matrix B) Element-by-element left division, C = A.Matrix.arrayLeftDivideEquals
(Matrix B) Element-by-element left division in place, A = A.Matrix.arrayRightDivide
(Matrix B) Element-by-element right division, C = A.Matrix.arrayRightDivideEquals
(Matrix B) Element-by-element right division in place, A = A.Matrix.arrayTimes
(Matrix B) Element-by-element multiplication, C = A.Matrix.arrayTimesEquals
(Matrix B) Element-by-element multiplication in place, A = A.static Matrix
Matrix.constructWithCopy
(double[][] A) Construct a matrix from a copy of a 2-D array.Matrix.copy()
Make a deep copy of a matrixEigenvalueDecomposition.getD()
Return the block diagonal eigenvalue matrixQRDecomposition.getH()
Return the Householder vectorsCholeskyDecomposition.getL()
Return triangular factor.LUDecomposition.getL()
Return lower triangular factorMatrix.getMatrix
(int[] r, int[] c) Get a submatrix.Matrix.getMatrix
(int[] r, int j0, int j1) Get a submatrix.Matrix.getMatrix
(int i0, int i1, int[] c) Get a submatrix.Matrix.getMatrix
(int i0, int i1, int j0, int j1) Get a submatrix.QRDecomposition.getQ()
Generate and return the (economy-sized) orthogonal factorQRDecomposition.getR()
Return the upper triangular factorSingularValueDecomposition.getS()
Return the diagonal matrix of singular valuesLUDecomposition.getU()
Return upper triangular factorSingularValueDecomposition.getU()
Return the left singular vectorsEigenvalueDecomposition.getV()
Return the eigenvector matrixSingularValueDecomposition.getV()
Return the right singular vectorsstatic Matrix
Matrix.identity
(int m, int n) Generate identity matrixMatrix.inverse()
Matrix inverse or pseudoinverseC = A - BMatrix.minusEquals
(Matrix B) A = A - BC = A + BMatrix.plusEquals
(Matrix B) A = A + Bstatic Matrix
Matrix.random
(int m, int n) Generate matrix with random elementsstatic Matrix
Matrix.read
(BufferedReader input) Read a matrix from a stream.Solve A*X = BSolve A*X = BSolve A*X = BLeast squares solution of A*X = BMatrix.solveTranspose
(Matrix B) Solve X*A = B, which is also A'*X' = B'Matrix.times
(double s) Multiply a matrix by a scalar, C = s*ALinear algebraic matrix multiplication, A * BMatrix.timesEquals
(double s) Multiply a matrix by a scalar in place, A = s*AMatrix.transpose()
Matrix transpose.Matrix.uminus()
Unary minusModifier and TypeMethodDescriptionMatrix.arrayLeftDivide
(Matrix B) Element-by-element left division, C = A.Matrix.arrayLeftDivideEquals
(Matrix B) Element-by-element left division in place, A = A.Matrix.arrayRightDivide
(Matrix B) Element-by-element right division, C = A.Matrix.arrayRightDivideEquals
(Matrix B) Element-by-element right division in place, A = A.Matrix.arrayTimes
(Matrix B) Element-by-element multiplication, C = A.Matrix.arrayTimesEquals
(Matrix B) Element-by-element multiplication in place, A = A.C = A - BMatrix.minusEquals
(Matrix B) A = A - BC = A + BMatrix.plusEquals
(Matrix B) A = A + Bvoid
Set a submatrix.void
Set a submatrix.void
Set a submatrix.void
Set a submatrix.Solve A*X = BSolve A*X = BSolve A*X = BLeast squares solution of A*X = BMatrix.solveTranspose
(Matrix B) Solve X*A = B, which is also A'*X' = B'Linear algebraic matrix multiplication, A * BModifierConstructorDescriptionCholesky algorithm for symmetric and positive definite matrix.Check for symmetry, then construct the eigenvalue decomposition Structure to access D and V.LU Decomposition provides a data structure to access L, U and piv.QR Decomposition, computed by Householder reflections. provides a data structure to access R and the Householder vectors and compute Q.Construct the singular value decomposition. -
Uses of Matrix in org.biojava.nbio.structure.symmetry.utils
Modifier and TypeMethodDescriptionstatic Matrix
SymmetryTools.blankOutCEOrig
(Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix origM, int blankWindowSize) static Matrix
SymmetryTools.blankOutPreviousAlignment
(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize) SymmetryTools.getDkMatrix
(Atom[] ca1, Atom[] ca2, int fragmentLength, double[] dist1, double[] dist2, int rows, int cols) static Matrix
SymmetryTools.getDkMatrix
(Atom[] ca1, Atom[] ca2, int k, int fragmentLength) static Matrix
SymmetryTools.grayOutCEOrig
(Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix origM, int blankWindowSize, double[] gradientPolyCoeff, double gradientExpCoeff) Grays out the main diagonal of a duplicated distance matrix.static Matrix
SymmetryTools.grayOutPreviousAlignment
(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize, double[] gradientPolyCoeff, double gradientExpCoeff) Modifier and TypeMethodDescriptionstatic Matrix
SymmetryTools.blankOutCEOrig
(Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix origM, int blankWindowSize) static Matrix
SymmetryTools.blankOutPreviousAlignment
(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize) static Matrix
SymmetryTools.grayOutCEOrig
(Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix origM, int blankWindowSize, double[] gradientPolyCoeff, double gradientExpCoeff) Grays out the main diagonal of a duplicated distance matrix.static Matrix
SymmetryTools.grayOutPreviousAlignment
(AFPChain afpChain, Atom[] ca2, int rows, int cols, CECalculator calculator, Matrix max, int blankWindowSize, double[] gradientPolyCoeff, double gradientExpCoeff)