Uses of Class
mathcomp.gridgeom.Triangle

Packages that use Triangle
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.filament Combines the Immersed Boundary Method with FEM to treat filaments in fluid flow. 
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.util.cfd Provides some utils for flow problems. 
 

Uses of Triangle in mathcomp.assemble
 

Methods in mathcomp.assemble that return Triangle
 Triangle ErrorCalculator.findTriangle(Node n)
           
 

Methods in mathcomp.assemble with parameters of type Triangle
abstract  double AssemblerPair.assemblePair(Grid g, Triangle t, Matrix m, java.lang.Object u1, java.lang.Object v1)
          The concrete matrix-entry-assemble method returning the double value to the two DOF Objects u1 and v1.
 double[] LagrangeCubicAssembler.calcCubicBasisCoeffs(Triangle t, int loaclNum)
           
 void LagrangeSquareAssembler.createDofExport(Triangle t, java.lang.Object[] result)
           
 void LagrangeLinearAssembler.createDofExport(Triangle t, java.lang.Object[] result)
           
 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.
 Matrix Assembler.getElementMatrix(Triangle t)
          Return the Element Matrix of this Assembler
 java.util.List LagrangeSquareAssembler.getLdof(Triangle t, java.util.List ldof)
           
 int MiniAssembler.getLocalNodeNumber(Triangle t, Node n)
           
 int LagrangeSquareAssembler.getLocalNodeNumber(Triangle t, Node n)
          Gets the local Node number to a Node on a quadratic triangle element.
 

Uses of Triangle in mathcomp.assemble.cfd
 

Methods in mathcomp.assemble.cfd with parameters of type Triangle
 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)
           
 int NSMiniAssembler.getLocalNodeNumber(Triangle t, Node n)
          Returns the local Node number to a Node on triangle element.
 

Uses of Triangle in mathcomp.assemble.convdiff
 

Methods in mathcomp.assemble.convdiff with parameters of type Triangle
 double AbstractCDA.approxConvectionIntegral(Triangle t, Node v, Node u)
          Important that to the (i,j) matrix entry we take the "i-th basisfunc for v" and "jth for u".
 double CDH_EF_Flux.approxLHS(Triangle t, Node u, Node v)
           
 double CDH_Weighted.approxLHS(Triangle t, Node u, Node v)
           
 double SkewAdvection_RFB.approxLHS(Triangle t, Node u, Node v)
           
 double RotFlow_RFB.approxLHS(Triangle t, Node u, Node v)
           
 double CDH_WBF.approxLHS(Triangle t, Node u, Node v)
           
 double CDH_RFB.approxLHS(Triangle t, Node u, Node v)
           
 double AbstractCDA_Square.approxLHS(Triangle t, Node u, Node v)
          Important that to the (i,j) matrix entry we take the "i-th basisfunc for v" and "jth for u".
 double AbstractCDA_Mini.approxLHS(Triangle t, Node u, Node v)
           
 double AbstractCDA_cV.approxLHS(Triangle t, Node u, Node v)
           
 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)
           
 double CDH_HVM.evalTau(Triangle t, Node u, Node Xb)
           
 double CDH_WBF.evalWeightedBasisFunc(Triangle t, Node n, int local)
           
 double[] CDH_EF_Flux.getAverageFlux(Triangle t, int local)
           
 double[] CDH_Weighted.getAverageFlux(Triangle t, int local)
           
 double[] CDH_WBF.getAverageFlux(Triangle t, int local)
           
 double SkewAdvection_RFB.getBdotN(Triangle t, int local)
           
 double RotFlow_RFB.getBdotN(Triangle t, int local)
           
 double CDH_RFB.getBdotN(Triangle t, int local)
           
 double AbstractCDA_Square.getDelta(Triangle t)
           
 double AbstractCDA_Mini.getDelta(Triangle t)
           
 double AbstractCDA.getFlowSegment(Triangle t)
           
 int CDH_Weighted.getLocalNodeNumber(Triangle t, Node n)
           
 double CDH_HVM.getStabilizerTermRight(Triangle t, Node u)
           
 double Raithby_SUPG.getStabilizerTermRight(Triangle t, Node u)
           
 double CDH_SUPG.getStabilizerTermRight(Triangle t, Node u)
           
 double CDH_HVM.getStabTerm(Triangle t, Node u, Node v)
           
 double AbstractCDA.getTau(Triangle t)
           
 Node SkewAdvection_RFB.getXminus(Triangle t, Node z)
           
 Node RotFlow_RFB.getXminus(Triangle t, Node z)
           
 Node CDH_RFB.getXminus(Triangle t, Node z)
           
 void SkewAdvection_RFB.markInOrOutBoundaries(Triangle t)
           
 void RotFlow_RFB.markInOrOutBoundaries(Triangle t)
           
 void CDH_RFB.markInOrOutBoundaries(Triangle t)
           
 

Uses of Triangle in mathcomp.assemble.discontinuousgalerkin
 

Methods in mathcomp.assemble.discontinuousgalerkin with parameters of type Triangle
 void TimeDependentAssembler.computeLimiter0(Vector v, Vector result, Triangle t)
           
 double DGAssembler.evalApproxSolution(Node n, Triangle t, Vector x)
           
 int Edges.getOrientation(Triangle t, int i)
           
 

Uses of Triangle in mathcomp.assemble.filament
 

Methods in mathcomp.assemble.filament that return Triangle
 Triangle FilamentAssembler.getTriangleFromNode(Node n)
           
 

Uses of Triangle in mathcomp.assemble.minimalsurface
 

Methods in mathcomp.assemble.minimalsurface with parameters of type Triangle
 void L2Interpolation.assembleElement(Triangle t)
           
 double[] MinimalSurfaceAssembler.evalApproxGradient(Triangle t, Vector x)
           
 

Uses of Triangle in mathcomp.gridgeom
 

Methods in mathcomp.gridgeom that return Triangle
 Triangle Grid.addNewTriangle(Node[] nodes)
          Adds a new Triangle based on nodes.
 Triangle Grid.getNeighbour(Triangle t, int i)
          Returns the Triangle adjacent to t on side i.
 Triangle Edge.getOtherTriangle(Triangle r)
           
 Triangle Edge.getTriangle(int i)
           
 

Methods in mathcomp.gridgeom with parameters of type Triangle
 void Edge.addTriangle(Triangle n)
           
 Edge GridRefiner.RedRefinement.edge(Triangle t, int i)
           
 Edge GridRefiner.GreenRefinement.edge(Triangle t, int i)
           
 Edge GridRefiner.YellowRefinement.edge(Triangle t, int i)
           
 int GridRefiner.RedRefinement.edgeNum(Triangle t)
           
 int GridRefiner.GreenRefinement.edgeNum(Triangle t)
           
 int GridRefiner.YellowRefinement.edgeNum(Triangle t)
           
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)
           
 int Grid.getIndex(Triangle t, Triangle neighbour)
          Returns the index of the edge of t which is common.
 Node Grid.getMiddleNodeForEdge(Triangle t, int index)
           
 Triangle Grid.getNeighbour(Triangle t, int i)
          Returns the Triangle adjacent to t on side i.
 Triangle Edge.getOtherTriangle(Triangle r)
           
static Node Transformation.getRealFromRef(Triangle t, Node v_onRef)
          Returns the coordinates of v_onRef in x coordinates.
static Node Transformation.getRefFromReal(Triangle t, Node v_onReal)
          Returns the coordinates of v_onReal in eta coordinates.
 Node Grid.getSchwerpunkt(Triangle t)
          Calculates the average of the nodes of t.
 mathcomp.gridgeom.GridRefiner.TriangleRefiner GridRefiner.getState(Triangle t)
           
 double Grid.getTriangleInfo(Triangle t)
          Each triangle has a possible info associated with it.
 boolean Grid.isMarkedGreen(Triangle t)
           
static double[] Transformation.mapGradientRealToRef(Triangle t, double xg, double yg)
           
static double[] Transformation.mapGradientRefToReal(Triangle t, double xg, double yg)
           
 void GridRefiner.move(Node k, Triangle t, int i)
           
 void Grid.putMarkedGreen(Triangle t)
           
 void GridRefiner.RedRefinement.refine(Triangle t, Grid newGrid, GridRefiner gr)
           
 void GridRefiner.GreenRefinement.refine(Triangle t, Grid newGrid, GridRefiner gr)
           
 void GridRefiner.YellowRefinement.refine(Triangle t, Grid newGrid, GridRefiner g)
           
 void Grid.removeMarkedGreen(Triangle t)
           
 void Edge.replaceTriangle(Triangle o, Triangle n)
           
 void Triangle.setEdgeWithReplacing(int i, Triangle old, Edge e)
           
 void Edge.setOtherTriangle(Triangle o, Triangle n)
           
 mathcomp.gridgeom.GridRefiner.TriangleRefiner GridRefiner.setState(Triangle t, mathcomp.gridgeom.GridRefiner.TriangleRefiner state)
           
 void Grid.setTriangleInfo(Triangle t, double d)
           
 

Constructors in mathcomp.gridgeom with parameters of type Triangle
Triangle(Triangle old)
           
 

Uses of Triangle in mathcomp.gui
 

Methods in mathcomp.gui that return Triangle
static Triangle Util.findTriangle(Grid g, Node n)
           
 Triangle GridRenderer.findTriangle(java.awt.geom.Point2D p)
           
 

Methods in mathcomp.gui with parameters of type Triangle
static void Util.ensureEdge(Triangle currentTriangle, Node n, double EPS, double R2_DAMPER, boolean output)
           
 java.awt.Color GridRenderer.getColor(Triangle t)
           
 java.awt.Color GradientGridVisualizer.getColor(Triangle t)
           
 Matrix GeneralMain.getElementMatrix(Triangle t)
           
static GhostNode Util.getValidGhostNode(Triangle t, Node n_in, Node n_out)
           
static boolean Util.inside(Triangle t, Node n)
           
static boolean Util.inside(Triangle t, java.awt.geom.Point2D p)
           
 void GridRenderer.setColor(Triangle t, java.awt.Color c)
           
 

Uses of Triangle in mathcomp.gui.cfd
 

Methods in mathcomp.gui.cfd with parameters of type Triangle
 float GradientGridRenderer.evalApproxFunction(Node n, Triangle t, float d0, float d1, float d2)
           
 double[] GradientGridRenderer.evalApproxGradient(Triangle t, float d0, float d1, float d2)
           
 

Uses of Triangle in mathcomp.util.cfd
 

Fields in mathcomp.util.cfd declared as Triangle
 Triangle[] MatlabImport.triangles
           
 

Methods in mathcomp.util.cfd that return Triangle
 Triangle[] MatlabImport.getTriangles()
           
 

Methods in mathcomp.util.cfd with parameters of type Triangle
 double ParticlePath.evalApproxSolution(Node n, Triangle t, int comp)
           
static double SolutionAnalyzer.evalApproxSolution(Node n, Triangle t, Vector x, int component)