![]() |
PSS Math Module
MATLAB toolboxes for aerospace analysis
|
▼ Core | |
▼ Math | |
► Analysis | Numerical analysis functions |
Armijo.m | Use the Armijo rule to compute a stepsize, alpha: |
AutoCorr.m | Generates the autocorrelation function for the input sequence |
Binomial.m | The binomial expansion of (x + y)^n |
CFract.m | Computes the value of a continued fraction of the form |
CHarm.m | Generate a series of cosine harmonics of the arguments |
CHarmD.m | Generate a series of cosine harmonics of the arguments |
DLyapG.m | Check the dimensions for consistency |
FitPair.m | Demo |
FourierSeries.m | If no inputs do a demo |
Heavisde.m | Heavside function |
HypgF1.m | Beta 1 |
HypgFr.m | Beta 1 |
HypgMr.m | Beta 1 |
Interp1D.m | Performs a linear interpolation: |
InterpolateCircle.m | Interpolates between x1 and x2 when x1 and x2 lie in a circle |
IntExpR.m | Find the delta Xs |
IntExt.m | Find the delta Xs and delta Ys |
Jacobian.m | Compute the value of the function f at the set point |
JacobianODE.m | Compute the value of the function f at the set point |
JCart2Sp.m | At the poles |
JSp2Cart.m | Jacobian for converting from spherical to cartesian coordinates |
LogBaseN.m | Demo |
Logistic.m | Demo |
LyapG.m | Check the dimensions for consistency |
MakeDistribution.m | Generate a list of random variables with some specified distribution |
NewStats.m | Calculates the new standard deviation and average |
NewtonsMethod.m | Defaults |
OptimalTrajectory.m | Demo |
Pade.m | Create a Padé approximant of exp(sT) |
PAL.m | Error Testing |
PDAL.m | Error Testing |
PGauss.m | Error Testing |
SCHarm.m | Generate a series of sine and cosine harmonics of the arguments |
SCHarmD.m | Generate a series of sine and cosine harmonics of the arguments |
SCSeries.m | Compute a series a + sum(bn sin(n wo t)) + sum(cn cos(n wo t)) |
SHarm.m | Generate a series of sine harmonics of the arguments |
SHarmD.m | Generate a series of sine harmonics of the arguments |
Simplex.m | Built-in Demo |
Simplex2.m | Constants |
SimplexOld.m | Constants |
SimplexScaling.m | Create the new arrays |
SphJacobian.m | Useful combinations |
SubPoly.m | Subtract two polynomials so that c = a - b |
WaveletMorlet.m | Performs a wavelet transform using a Morlet Wavelet |
WorstFirstAssignment.m | Initialize |
► AStar | Optimal path planning using A* algorithm |
AStarSearch.m | Finds the optimal path using A* |
DeltaAngleForNewRADec.m | Demo |
GenerateGrid.m | Demo |
GlobeGrid.m | Demo |
GridPathCost.m | PSS internal file version information |
GridSuccessorNodes.m | The grid is in a one dimensional array |
GridTraverseCost.m | Diagonal costs are more than straight cost |
ManeuverCost.m | PSS internal file version information |
ManeuverCost3D.m | PSS internal file version information |
ManeuverSuccessorNodes.m | First branch for north pole, second for south pole |
ManeuverSuccessorNodes3D.m | Adjust the node for the level |
SphericalGrid.m | Demo |
TransformGridCoordinates.m | First path is 1D to 2 |
► Demos | Math Demos |
► Analysis | Analysis demos |
SimplexConstraintRelaxationDemo.m | Solve an infeasible LP with simplex through constraint relaxation Published Demo |
SimplexScalingDemo.m | Solve a linear program with Simplex |
THyperG.m | Demonstrate hypergeometric functions |
► AStar | AStar demos |
AStarSearch3DManeuverDemo.m | Demonstrate A* for a close orbital maneuver |
AStarSearchGrid1Demo.m | Test AStarSearch using a grid with obstacles |
AStarSearchGrid2Demo.m | Test AStarSearch using a grid with more obstacles |
AStarSearchManeuverDemo.m | Demonstrate A* for a close orbital maneuver |
AStarSearchOrderGridDemo.m | Test AStarSearch using a grid with randomly placed obstacles |
AStarSearchRandomGridDemo.m | Test AStarSearch using a grid with randomly placed obstacles |
► FDIR | FDIR demos |
DCMotorSim.m | Simulates 2 DC Motors with failure detection logic |
DetectionFilterBuilderDemo.m | Simulate a detection filter using the DetectionFilterBuilder GUI |
FDIROLASim.m | Test Fault Diagnosis using online approximators |
OrbitFDIRDemo.m | Demonstrate an orbit detection filter for a spacecraft with one thruster |
OrbitFDIRPulseDemo.m | Demonstrate an orbit detection filter with random thrust pulses |
SpinnerFDIRDemo.m | Demonstrate a detection filter for a spinning spacecraft |
► Probability | Probability demos |
DoggyProblem.m | Demonstrate the BinomialTheorem for the doggy problem |
GunProblem.m | Demonstrate the BinomialTheorem for the gun problem |
► FDIR | Detection filters including a nonlinear spring example |
BuildLinearDF.m | Convert to statespace form |
DCMotorDetectionFilter.m | Implements a DC motor detection filter |
DCMotorFailures.m | Triggers a failure at time tFail |
DCMotorParitySpace.m | Computes the residuals for two DC motors |
DetectionFilter.m | Extract the state space matrices |
DetectionFilterBuild.m | Get the state matrices |
DetectionFilterBuilder.m | PSS internal file version information |
DetectionFilterSimulation.m | Actuators |
DetectionFilterUnnormalized.m | Extract the state space matrices |
DualDCMotors.m | Simulates two DC motors |
NonlinearEstimator.m | Implements an online approximator for a spring mass damper system |
NonlinearSpring.m | Right-hand-side of a nonlinear spring dynamics model |
NonlinearSpringFault.m | Nonlinear spring fault |
NormalizeMatrix.m | Normalizes a state space system for use with a detection filter |
OnlineApproximator.m | PSS internal file version information |
ProbabilityOfFailure.m | Demo |
RadialBasisFunction.m | Implements a radial basis function for online estimators |
TMatrix.m | Example is an L1011 |
► Geometry | Geometric routines |
AngleSepFromRotation.m | Demo |
BilinearInterpolation.m | Demo |
FindValidAngleRange.m | Find valid range of rotation angles that satisfy separation constraints |
FitEllipse.m | Demo |
InsideAngleRange.m | Demo |
IntersectLineAndCone.m | Compute the intersection of a line and a cone |
IntersectLineAndEllipsoid.m | Compute the intersection of a line and ellipsoid |
MergeAngleRange.m | Demo |
Perpendicular.m | Demo |
PointInGridInTriangle.m | Demo |
PointInPolygon.m | Demo |
PointInTriangle.m | Demo |
SegmentIntersection.m | Demo |
SurfaceAreaEllipsoid.m | First and second kind |
UnitVectorAverage.m | Demo |
Help | |
► Integration | Custom numerical integration routines |
Euler.m | PSS internal file version information |
FracDI.m | Fractional order derivative or integral |
RK2.m | Second order Runge-Kutta |
RK4.m | PSS internal file version information |
RK45.m | Constants |
RK4TI.m | PSS internal file version information |
TwoDSimpsonIntegration.m | Uses 2D Simpson's Rule to integrate an area |
► Linear | Linear Algebra |
BlockDiagonal.m | Generate a block diagonal matrix |
ColCompR.m | PSS internal file version information |
ComplexToReal.m | Demo |
Cross.m | Vector cross product for multicolum arrays |
DelLZ.m | PSS internal file version information |
Dot.m | Dot product with support for arrays |
DUnit.m | Check input lists |
DupVect.m | Duplicate vector n times |
Factorl.m | Computes the factorial matrix for a matrix |
GenSub.m | PSS internal file version information |
GJInv.m | Append the identity matrix |
Inv3x3.m | The determinant |
InvP.m | Find indices for the other rows |
IsSing.m | PSS internal file version information |
IsZero.m | PSS internal file version information |
LeastSq.m | Make x and y columns |
Mag.m | Magnitude of a set of vectors |
Orthogonalize.m | Demonstration output |
Product.m | PSS internal file version information |
RowCompU.m | Computes the upper row compression of a matrix |
Sep.m | PSS internal file version information |
Skew.m | Converts a vector into a skew symmetric matrix |
SkewSq.m | Computes the product of two skew symmetric matrices derive from vectors |
SkewSymm.m | PSS internal file version information |
SumC.m | PSS internal file version information |
SumV.m | PSS internal file version information |
SXV.m | Multiplies a scalar times a vector |
Unit.m | Start with NaN |
► MathUtils | Generic math utilities |
DeltaEig.m | Simple example |
FindIfInBetween.m | Demo |
FloatToTwosComplement.m | Demo |
FTrunc.m | PSS internal file version information |
Odd.m | PSS internal file version information |
R2P5.m | Demo |
Ramp.m | PSS internal file version information |
Ramps.m | Demo |
RoundN.m | PSS internal file version information |
TriangleWave.m | Demo |
TwosComplementToFloat.m | Demo |
► Probability | Probability including Markov, Gaussian routines |
BinomialTheorem.m | Computes the binomial theorem |
CableTensionExample.m | PSS internal file version information |
Combinations.m | PSS internal file version information |
ConfidenceInterval.m | Computes the confidence interval |
CovarianceRHS.m | Generates the covariance derivative |
CRand.m | Covariance matrix transformation |
EMarkov.m | PSS internal file version information |
ErrorCombination.m | Demo |
GaussianCPDF.m | Cumulative probability density function for a Gaussian |
GaussianPDF.m | PSS internal file version information |
GaussianRSG.m | Gaussian Random Sequence Generator Using the Box-Mueller Transform |
Markov.m | Put everything into columns |
NormalDistribution.m | Demo |
Random.m | PSS internal file version information |
RandP.m | Demo |
RandPM.m | PSS internal file version information |
RandPN.m | Demo |
RMarkov.m | PSS internal file version information |
SignTest.m | Demo |
SMarkov.m | PSS internal file version information |
► Solvers | Solvers and root finding |
BisectionZero.m | Check for no boundary crossing first |
LEPDS.m | Find g and d where g*diag(d)*g' = a |
LSSVD.m | Condition number |
ModNewt.m | Check for the maximum number of iterations |
NewtRaph.m | Defaults |
NLEqSolver.m | PSS internal file version information |
NLEqSolverWrapper.m | Defaults |
Secant.m | Check for the maximum number of iterations |
► Trigonometry | Trigonometry |
ACosD.m | PSS internal file version information |
ACot2.m | PSS internal file version information |
ACot2D.m | PSS internal file version information |
ACotD.m | PSS internal file version information |
ACscD.m | PSS internal file version information |
ASecD.m | PSS internal file version information |
ASinD.m | PSS internal file version information |
ATan2D.m | Inverse tangent -180 < z < 180 |
ATanD.m | Inverse tangent with output in degrees |
CosD.m | PSS internal file version information |
CosX.m | PSS internal file version information |
CotD.m | PSS internal file version information |
CscD.m | PSS internal file version information |
DeltCirc.m | Reduce to +/- 2 pi |
LinearSinCosToQuadCos.m | Demo |
SecD.m | Secant |
SinD.m | PSS internal file version information |
SinX.m | PSS internal file version information |
SolveLinearSinCos.m | Demo |
TanD.m | PSS internal file version information |
TrigReduction.m | Demo |
UnwrapPhase.m | PSS internal file version information |
VerSin.m | Produces a smoothly varying function from 0 to xMax |
WrapPhase.m | PSS internal file version information |