Uses of Class
mathcomp.la.Vector

Packages that use Vector
mathcomp.assemble Contains essential assembler classes. 
mathcomp.assemble.cfd Provides the assembly of Stokes and Navier-Stokes equations using Mini-Elements. 
mathcomp.assemble.convdiff Convection diffusion problems. 
mathcomp.assemble.discontinuousgalerkin Discontinuous galerkin problems. 
mathcomp.assemble.minimalsurface Minimal surface problems. 
mathcomp.gridgeom Contains the geometric architecture and refinement. 
mathcomp.gui GUI-Implementation. 
mathcomp.gui.cfd Provides GUI features for flow problems. 
mathcomp.io Classes for export. 
mathcomp.la Contains Linear Algebra Classes and the Index Infrastructure. 
mathcomp.la.external Linear solvers from other projects, partially native. 
mathcomp.la.solve Linear algebra Solvers. 
mathcomp.run Provides run classes that govern the alogorithms for entire calculation processes. 
mathcomp.util.cfd Provides some utils for flow problems. 
 

Uses of Vector in mathcomp.assemble
 

Fields in mathcomp.assemble declared as Vector
 Vector[] LagrangeLinearAssembler.gradVector
          Because the gradient of a linear basis function is constant, we can calculate this gradient for every element once in a pre-processing way.
 

Methods in mathcomp.assemble that return Vector
 Vector Assembler.addDirichletNodes(Vector sol)
          Completes the solution vector by adding the values at the dirichlet nodes
 Vector Assembler.getY()
           
 

Methods in mathcomp.assemble with parameters of type Vector
 Vector Assembler.addDirichletNodes(Vector sol)
          Completes the solution vector by adding the values at the dirichlet nodes
 Surface[] Assembler.createSurfaces(Vector x)
          Generates and returns an array of Surface Objects.
 Surface[] Assembler.createSurfaces(Vector x, Vector fineSolution)
           
 double[] MiniAssembler.evalApproxGradient(Node n, Triangle t, Vector x)
           
 double[] LagrangeSquareAssembler.evalApproxGradient(Node gaussRef, Triangle t, Vector x)
           
 double[] LagrangeLinearAssembler.evalApproxGradient(Node n, Triangle t, Vector x)
          For linear functions we add the gradients of the scaled basisfunction on real
 double[] Assembler.evalApproxGradient(Node n, Triangle t, Vector x)
          For H1 error calculations we need to know the gradient of the approximated solution in a node n.
 double MiniAssembler.evalApproxSolution(Node n, Triangle t, Vector x)
           
 double LagrangeSquareAssembler.evalApproxSolution(Node n, Triangle t, Vector x)
           
 double LagrangeLinearAssembler.evalApproxSolution(Node n, Triangle t, Vector x)
           
abstract  double Assembler.evalApproxSolution(Node n, Triangle t, Vector x)
          Evaluates the FEM solution in a Node.
 void ErrorCalculatorOverkill.setFineSolution(Vector fine)
           
 void ErrorCalculator.setFineSolution(Vector fineSolution)
           
 void ErrorCalculatorOverkill.setSolution(Vector sol)
           
 void ErrorCalculatorCompare.setSolution(Vector sol)
           
 void ErrorCalculator.setSolution(Vector solution)
          Sets a solution to this ErrorCalculator.
 void Assembler.setY(Vector vector)
           
 

Uses of Vector in mathcomp.assemble.cfd
 

Fields in mathcomp.assemble.cfd declared as Vector
 Vector NSMiniFPIAssembler.oldSolution
           
 Vector NSMiniFPIAssembler.stokesY
           
 

Methods in mathcomp.assemble.cfd that return Vector
 Vector NavierStokesAssembler.addDirichletNodes(Vector sol)
           
 Vector NSMiniFPIAssembler.getOldSolution()
           
 Vector NavierStokesAssembler.getOldSolution()
           
 

Methods in mathcomp.assemble.cfd with parameters of type Vector
 Vector NavierStokesAssembler.addDirichletNodes(Vector sol)
           
 double[] NSMiniAssembler.evalApproxGradientU1(Node n, Triangle t, Vector x)
           
 double[] NSMiniAssembler.evalApproxGradientU2(Node n, Triangle t, Vector x)
           
 double NSMiniAssembler.evalApproxSolutionPressure(Node n, Triangle t, Vector x)
           
 double NSMiniAssembler.evalApproxSolutionU1(Node n, Triangle t, Vector x)
           
 double NSMiniAssembler.evalApproxSolutionU2(Node n, Triangle t, Vector x)
           
 boolean NSMiniFPIAssembler.isToContinue(Vector x)
           
 boolean NSMiniOseenAssembler.isToContinue(Vector x)
           
 void NSMiniFPIAssembler.setOldSolution(Vector oldSolution)
           
 void NSMiniFPIAssembler.setOldSolution(Vector x, Vector yy)
           
 void NavierStokesAssembler.setOldSolution(Vector x, Vector yy)
           
 

Uses of Vector in mathcomp.assemble.convdiff
 

Methods in mathcomp.assemble.convdiff with parameters of type Vector
 double[] CDH_WBF.evalApproxGradient(Node n, Triangle t, Vector x)
          TODO adjust linear to weighted gradients
 double CDH_WBF.evalApproxSolution(Node n, Triangle t, Vector x)
           
 

Uses of Vector in mathcomp.assemble.discontinuousgalerkin
 

Methods in mathcomp.assemble.discontinuousgalerkin that return Vector
 Vector TimeDependentAssembler.adaptiveLimiter(Vector v, double time)
           
 Vector TimeDependentAssembler.limiter(Vector v, double time)
           
 Vector TimeDependentAssembler.meanValueLimiter(Vector v)
           
 

Methods in mathcomp.assemble.discontinuousgalerkin with parameters of type Vector
 Vector TimeDependentAssembler.adaptiveLimiter(Vector v, double time)
           
 void TimeDependentAssembler.computeLimiter0(Vector v, Vector result, Triangle t)
           
 Surface[] DGAssembler.createSurfaces(Vector x)
           
 double DGAssembler.evalApproxSolution(Node n, Triangle t, Vector x)
           
static void Export.exportSolution(Assembler ass, Vector x, java.lang.String filename)
           
 Vector TimeDependentAssembler.limiter(Vector v, double time)
           
 Vector TimeDependentAssembler.meanValueLimiter(Vector v)
           
 void TimeDependentAssembler.setVectorPiU(Vector v)
           
 void TimeDependentAssembler.setVectorU(Vector v)
           
static void Export.writeToWriter(Assembler ass, Vector x, java.io.PrintWriter pwU)
           
 

Uses of Vector in mathcomp.assemble.minimalsurface
 

Methods in mathcomp.assemble.minimalsurface with parameters of type Vector
 double[] MinimalSurfaceAssembler.evalApproxGradient(Triangle t, Vector x)
           
 boolean NewtonAssembler.isToContinue(Vector x)
           
 boolean FixedPointAssembler.isToContinue(Vector x)
           
 void NewtonAssembler.setOldSolution(Vector x, Vector yy)
           
 void FixedPointAssembler.setOldSolution(Vector x, Vector yy)
           
 

Uses of Vector in mathcomp.gridgeom
 

Methods in mathcomp.gridgeom that return Vector
static Vector[] Transformation.getGradVector(Triangle t, Vector[] toFillVector)
           
 

Methods in mathcomp.gridgeom with parameters of type Vector
static void Transformation.fillGradVector(Triangle t, Vector[] toFillVector)
          For every triangle preprocessed method to calculate the gradVector.
static double AdaptiveRefiner.getGradientLength(Node n, Triangle t, Vector x)
           
static Vector[] Transformation.getGradVector(Triangle t, Vector[] toFillVector)
           
static java.util.Map AdaptiveRefiner.getHighGradientTriangles(Grid grid, Vector x)
           
static double[] AdaptiveRefiner.getMeanAndMaxGradient(Grid grid, Vector x)
           
 

Uses of Vector in mathcomp.gui
 

Methods in mathcomp.gui that return Vector
 Vector GeneralMain.getLastX()
           
 Vector GridRenderer.getVectorFieldApprox()
           
 

Methods in mathcomp.gui with parameters of type Vector
 void GeneralMain.setLastX(Vector lastX)
           
 void GridRenderer.setVectorFieldApprox(Vector vectorFieldApprox)
           
 

Constructors in mathcomp.gui with parameters of type Vector
Main.MatrixTableModel(Matrix m, Vector y)
           
 

Uses of Vector in mathcomp.gui.cfd
 

Methods in mathcomp.gui.cfd with parameters of type Vector
 float[] GradientGridRenderer.calcUpperAndLowerBounds(Vector v)
           
 Surface JCFD.createSingleSurfaces(Vector x)
           
 void GradientGridRenderer.setData(Vector x_IN, Grid g, int mode)
           
 

Uses of Vector in mathcomp.io
 

Methods in mathcomp.io that return Vector
static Vector Import.loadFineSolution(Index index, java.io.File file)
           
 

Methods in mathcomp.io with parameters of type Vector
static void ExportGen.export(Assembler ass, Vector solution, java.lang.String gridfile, java.lang.String solFile)
           
static void MatlabExport.exportMiniCFD(Assembler ass, Vector x, java.lang.String fileName)
           
static void MatlabExport.exportScalar2D(java.io.File file, Vector x)
           
static void MatlabExport.exportSolutionMiniElements(Assembler ass, Vector x, java.lang.String fileName)
           
static void MatlabExport.exportStokesSolution(Assembler ass, Vector x)
           
static void MatlabExport.exportVector(Vector v, Assembler ass, java.lang.String fileName)
           
 

Uses of Vector in mathcomp.la
 

Subclasses of Vector in mathcomp.la
 class MapVector
           
 

Methods in mathcomp.la that return Vector
 Vector Vector.add(Vector v, Vector res)
          Performs res := this + v and returns res.
 Vector Vector.addScaled(Vector v, double alpha, Vector res)
          Performs res := this + alpha*v and returns res.
abstract  Vector Vector.copy()
          Creates a copy of this vector.
 Vector MapVector.copy()
           
 Vector Index.createVector()
          Creates a new Vector indexed by this Index.
 Vector CollectionIndex.createVector()
          Creates a new MapVector based on this index.
 Vector Matrix.map(Vector v, Vector ret)
          Performs ret := this*v, i.e.
 Vector Vector.scale(double alpha, Vector res)
          Performs res := alpha*this and returns res.
 

Methods in mathcomp.la with parameters of type Vector
 Vector Vector.add(Vector v, Vector res)
          Performs res := this + v and returns res.
 Vector Vector.addScaled(Vector v, double alpha, Vector res)
          Performs res := this + alpha*v and returns res.
 void Vector.copyFrom(Vector v)
          Puts v into this, this := v.
 double Matrix.map(Vector v, java.lang.Object row)
           
 Vector Matrix.map(Vector v, Vector ret)
          Performs ret := this*v, i.e.
 Vector Vector.scale(double alpha, Vector res)
          Performs res := alpha*this and returns res.
 double Vector.scalProd(Vector v)
          Returns the scalar product of this and v.
 

Uses of Vector in mathcomp.la.external
 

Methods in mathcomp.la.external that return Vector
static Vector Umfpack.arrayToVector(double[] d, IndexToInteger i2i)
           
static Vector JMP.convert(jmp.ElementalAccessVector v, IndexToInteger i2i)
           
 Vector JMPSolver.solve()
           
 Vector AbstractHBSolver.solve()
           
 

Methods in mathcomp.la.external with parameters of type Vector
static jmp.Vector JMP.convert(Vector v, IndexToInteger i2i)
           
static double[] Umfpack.vectorToArray(Vector v, IndexToInteger i2i)
           
 

Uses of Vector in mathcomp.la.solve
 

Methods in mathcomp.la.solve that return Vector
 Vector Solver.getX()
           
 Vector AbstractSolver.getX()
           
 Vector AbstractSolver.getY()
           
 Vector Solver.solve()
           
 Vector GaussSolver.solve()
           
 

Methods in mathcomp.la.solve with parameters of type Vector
 void AbstractSolver.setX(Vector vector)
           
 void Solver.setY(Vector y)
           
 void AbstractSolver.setY(Vector vector)
           
 

Uses of Vector in mathcomp.run
 

Methods in mathcomp.run that return Vector
 Vector AssemblerRun.getX()
           
 

Methods in mathcomp.run with parameters of type Vector
 double[] NSIteratedAssemblerRun.calcPressureDifference(Vector sol)
           
 boolean IteratedAssembler.isToContinue(Vector x)
          this method defines if the iterative solver stops or continues.
 void IteratedAssembler.setOldSolution(Vector x, Vector yy)
          This method is used to set the previous iteration that is used to calculate the new iteration
 void AssemblerRun.setX(Vector x)
           
 

Constructors in mathcomp.run with parameters of type Vector
AssemblerRun(Vector fineSolution)
           
 

Uses of Vector in mathcomp.util.cfd
 

Fields in mathcomp.util.cfd declared as Vector
 Vector MatlabImport.sol
           
 

Methods in mathcomp.util.cfd that return Vector
 Vector MatlabImport.getSol()
           
 

Methods in mathcomp.util.cfd with parameters of type Vector
static double SolutionAnalyzer.evalApproxSolution(Node n, Triangle t, Vector x, int component)
           
 double SolutionAnalyzer.getAbsComponentMax(Node[] nodes, Vector sol1, Vector sol2, int component)
           
static double SolutionAnalyzer.getL2FromVectors(Grid grid, Vector v1, Vector v2, int comp)
           
 void ParticlePath.setSol(Vector sol)