Skip navigation links
jas4pp: Data AnalysisEnvironment

See: Description

Packages 
Package Description
cern.clhep
A Java port of CLHEP 1.4.0 (C++) - A Class Library for High Energy Physics; still quite incomplete - should probably find a way to take cern.clhep out of this distribution and merge cern.clhep with hep.lcd (SLAC).
cern.colt
Core base classes; Operations on primitive arrays such as sorting, partitioning and permuting.
cern.colt.bitvector
Bit vectors and bit matrices.
cern.colt.buffer
Fixed sized (non resizable) streaming buffers connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.function
Core interfaces for functions, comparisons and procedures on objects and primitive data types.
cern.colt.list
Resizable lists holding objects or primitive data types such as int, double, etc.
cern.colt.list.adapter
List adapters that make Colt lists compatible with the JDK 1.2 Collections Framework.
cern.colt.map
Automatically growing and shrinking maps holding objects or primitive data types such as int, double, etc.
cern.colt.matrix
Matrix interfaces and factories; efficient and flexible dense and sparse 1, 2, 3 and d-dimensional matrices holding objects or primitive data types such as int, double, etc; Templated, fixed sized (not dynamically resizable); Also known as multi-dimensional arrays or Data Cubes.
cern.colt.matrix.bench
Matrix benchmarks.
cern.colt.matrix.doublealgo
Double matrix algorithms such as print formatting, sorting, partitioning and statistics.
cern.colt.matrix.impl
Matrix implementations; You normally need not look at this package, because all concrete classes implement the abstract interfaces of cern.colt.matrix, without subsetting or supersetting.
cern.colt.matrix.linalg
Linear Algebraic matrix computations operating on DoubleMatrix2D and DoubleMatrix1D.
cern.colt.matrix.objectalgo
Object matrix algorithms such as print formatting, sorting, partitioning and statistics.
cern.hep.aida.bin
Multisets (bags) with efficient statistics operations defined upon; This package requires the Colt distribution.
cern.hep.aida.ref
Reference implementation of the AIDA histogram interfaces.
cern.jet.math
Tools for basic and advanced mathematics: Arithmetics and Algebra, Polynomials and Chebyshev series, Bessel and Airy functions, Function Objects for generic function evaluation, etc.
cern.jet.random
Large variety of probability distributions featuring high performance generation of random numbers, CDF's and PDF's.
cern.jet.random.engine
Engines generating strong uniformly distributed pseudo-random numbers; Needed by all JET probability distributions since they rely on uniform random numbers to generate random numbers from their own distribution.
cern.jet.random.sampling
Samples (picks) random subsets of data sequences.
cern.jet.stat
Tools for basic and advanced statistics: Estimators, Gamma functions, Beta functions, Probabilities, Special integrals, etc.
cern.jet.stat.quantile
Scalable algorithms and data structures to compute approximate quantiles over very large data sequences.
colt.hep.aida
Interfaces for compact, extensible, modular and performant histogramming functionality.
corejava
C-like number formatting that follows printf conventions.
fitter  
graph  
hep.lcio.data
The package hep.lcio.data has been removed - interfaces are now all defined in hep.lcio.event.
hep.lcio.event
Primary user interface for LCIO.
hep.lcio.example
Simple usage examples.
hep.lcio.exceptions
Exceptions thrown by LCIO.
hep.lcio.implementation.event  
hep.lcio.implementation.io
Default IO implementation.
hep.lcio.implementation.sio
SIO specific LCIO implementation.
hep.lcio.io
Interfaces for IO library.
hep.lcio.test  
hep.lcio.util
Utilities for use with LCIO.
hep.physics.event
Basic HEP event classes.
hep.physics.event.generator
Event generator infrastructure
hep.physics.event.generator.diagnostic
Diagnostic event generator
hep.physics.filter
Particle selection utilities.
hep.physics.jet
Jet finding and event shape utilities.
hep.physics.matrix
Simple matrix package.
hep.physics.particle
Simple HEP particle classes.
hep.physics.particle.properties
Simple HEP particle property classes.
hep.physics.stdhep.convert
A package which can be used to convert between StdhepEvents and the much more OO HepEvent representation.
hep.physics.vec
General classes for operating on 3- and 4- vectors.
hephysics.hepsim  
hephysics.jet
Java implementation of the longitudinally invariant kT, Cambridge/Aachen and anti-KT clustering algorithms using the recombination method.
hephysics.matrix
Simple matrix package.
hephysics.particle
Define various Lorentz-type particles.
hephysics.vec
Lorentz-type vectors and transformations.
j4np.physics  
Jama  
Jama.examples  
Jama.test  
Jama.util  
Jampack  
jhepsim  
jhplot
Main SCaVis numerical and graphical package
jhplot.fit
Predefined fit functions for the fit panel (HFit).
jhplot.gui
Commong GUI components
jhplot.io
jHPlot IO classes
jhplot.io.db  
jhplot.io.images  
jhplot.math
Math calculations and random numbers.
jhplot.math.exp4j  
jhplot.math.exp4j.function  
jhplot.math.exp4j.operator  
jhplot.math.exp4j.shuntingyard  
jhplot.math.exp4j.tokenizer  
jhplot.math.io
IO package for math (based on jmathtools).
jhplot.math.kalman  
jhplot.math.kalman.jama  
jhplot.math.num
Common classes used throughout numerics4j.
jhplot.math.num.integration
Function interfaces.
jhplot.math.num.pdf
Statistical distributions.
jhplot.math.num.random
Random number generators and random variable generators.
jhplot.math.num.root
Function interfaces.
jhplot.math.num.special
Elementary functions not provided by the Java™.
jhplot.math.pca
A library implementing Principal Component Analysis (PCA) data transformation; in majority of cases the only class that the library's user should be interested in is the class.
jhplot.math.pca.covmatrixevd
A package containing two different implementations of the data's covariance matrix eigenvalue decomposition.
jhplot.root
Access to ROOT files (based on Tony Johnson's RootHistogramBrowser).
jhplot.security
MD5 hash for objects or data files
jhplot.shapes
SCaVis package to draw java 2D primitives
jhplot.stat  
jhplot.stat.limit  
jhplot.utils
Useful classes for verious manipulations and integration with SCaVis
jminhep.algorithms  
jminhep.clcontrol  
jminhep.cluster
jHepWork package for a cluster analysis.
jminhep.gui  
jminhep.utils  
jplot  
jplot.panels  
jplot3d  
jplot3d.draw  
jplot3dp  
jplot3dp.MathParser  
net.jafama  
net.java.dev.colorchooser  
org.apache.commons.io
This package defines utility classes for working with streams, readers, writers and files.
org.apache.commons.io.comparator
This package provides various Comparator implementations for Files.
org.apache.commons.io.file
This package provides extensions in the realm of java.nio.file.
org.apache.commons.io.filefilter
This package defines an interface (IOFileFilter) that combines both FileFilter and FilenameFilter.
org.apache.commons.io.function
This package defines IO-only related functional interfaces for lambda expressions and method references.
org.apache.commons.io.input
This package provides implementations of input classes, such as InputStream and Reader.
org.apache.commons.io.input.buffer
This package provides implementations of buffered input classes, such as CircularBufferInputStream and PeekableInputStream.
org.apache.commons.io.monitor
This package provides a component for monitoring file system events (directory and file create, update and delete events).
org.apache.commons.io.output
This package provides implementations of output classes, such as OutputStream and Writer.
org.apache.commons.io.serialization
This package provides a framework for controlling the deserialization of classes.
org.apache.commons.math3
Common classes used throughout the commons-math library.
org.apache.commons.math3.analysis
Parent package for common numerical analysis procedures, including root finding, function interpolation and integration.
org.apache.commons.math3.analysis.differentiation
This package holds the main interfaces and basic building block classes dealing with differentiation.
org.apache.commons.math3.analysis.function
The function package contains function objects that wrap the methods contained in Math, as well as common mathematical functions such as the gaussian and sinc functions.
org.apache.commons.math3.analysis.integration
Numerical integration (quadrature) algorithms for univariate real functions.
org.apache.commons.math3.analysis.integration.gauss
Gauss family of quadrature schemes.
org.apache.commons.math3.analysis.interpolation
Univariate real functions interpolation algorithms.
org.apache.commons.math3.analysis.polynomials
Univariate real polynomials implementations, seen as differentiable univariate real functions.
org.apache.commons.math3.analysis.solvers
Root finding algorithms, for univariate real functions.
org.apache.commons.math3.complex
Complex number type and implementations of complex transcendental functions.
org.apache.commons.math3.dfp
Decimal floating point library for Java
org.apache.commons.math3.distribution
Implementations of common discrete and continuous distributions.
org.apache.commons.math3.distribution.fitting
Fitting of parameters against distributions.
org.apache.commons.math3.exception
Specialized exceptions for algorithms errors.
org.apache.commons.math3.exception.util
Classes supporting exception localization.
org.apache.commons.math3.filter
Implementations of common discrete-time linear filters.
org.apache.commons.math3.fitting
Classes to perform curve fitting.
org.apache.commons.math3.fitting.leastsquares
This package provides algorithms that minimize the residuals between observations and model values.
org.apache.commons.math3.fraction
Fraction number type and fraction number formatting.
org.apache.commons.math3.genetics
This package provides Genetic Algorithms components and implementations.
org.apache.commons.math3.geometry
This package is the top level package for geometry.
org.apache.commons.math3.geometry.enclosing
This package provides interfaces and classes related to the smallest enclosing ball problem.
org.apache.commons.math3.geometry.euclidean.oned
This package provides basic 1D geometry components.
org.apache.commons.math3.geometry.euclidean.threed
This package provides basic 3D geometry components.
org.apache.commons.math3.geometry.euclidean.twod
This package provides basic 2D geometry components.
org.apache.commons.math3.geometry.euclidean.twod.hull
This package provides algorithms to generate the convex hull for a set of points in an two-dimensional euclidean space.
org.apache.commons.math3.geometry.hull
This package provides interfaces and classes related to the convex hull problem.
org.apache.commons.math3.geometry.partitioning
This package provides classes to implement Binary Space Partition trees.
org.apache.commons.math3.geometry.partitioning.utilities
This package provides multidimensional ordering features for partitioning.
org.apache.commons.math3.geometry.spherical.oned
This package provides basic geometry components on the 1-sphere.
org.apache.commons.math3.geometry.spherical.twod
This package provides basic geometry components on the 2-sphere.
org.apache.commons.math3.linear
Linear algebra support.
org.apache.commons.math3.ml
Base package for machine learning algorithms.
org.apache.commons.math3.ml.clustering
Clustering algorithms.
org.apache.commons.math3.ml.clustering.evaluation
Cluster evaluation methods.
org.apache.commons.math3.ml.distance
Common distance measures.
org.apache.commons.math3.ml.neuralnet
Neural networks.
org.apache.commons.math3.ml.neuralnet.oned
One-dimensional neural networks.
org.apache.commons.math3.ml.neuralnet.sofm
Self Organizing Feature Map.
org.apache.commons.math3.ml.neuralnet.sofm.util
Miscellaneous utilities.
org.apache.commons.math3.ml.neuralnet.twod
Two-dimensional neural networks.
org.apache.commons.math3.ml.neuralnet.twod.util
Utilities to visualize two-dimensional neural networks.
org.apache.commons.math3.ode
This package provides classes to solve Ordinary Differential Equations problems.
org.apache.commons.math3.ode.events
This package provides classes to handle discrete events occurring during Ordinary Differential Equations integration.
org.apache.commons.math3.ode.nonstiff
This package provides classes to solve non-stiff Ordinary Differential Equations problems.
org.apache.commons.math3.ode.sampling
This package provides classes to handle sampling steps during Ordinary Differential Equations integration.
org.apache.commons.math3.optim
Generally, optimizers are algorithms that will either minimize or maximize a scalar function, called the objective function.
org.apache.commons.math3.optim.linear
Optimization algorithms for linear constrained problems.
org.apache.commons.math3.optim.nonlinear.scalar
Algorithms for optimizing a scalar function.
org.apache.commons.math3.optim.nonlinear.scalar.gradient
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This package provides optimization algorithms that do not require derivatives.
org.apache.commons.math3.optim.nonlinear.vector
Algorithms for optimizing a vector function.
org.apache.commons.math3.optim.nonlinear.vector.jacobian
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optim.univariate
One-dimensional optimization algorithms.
org.apache.commons.math3.optimization
All classes and sub-packages of this package are deprecated.
org.apache.commons.math3.optimization.direct
This package provides optimization algorithms that don't require derivatives.
org.apache.commons.math3.optimization.fitting
This package provides classes to perform curve fitting.
org.apache.commons.math3.optimization.general
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optimization.linear
This package provides optimization algorithms for linear constrained problems.
org.apache.commons.math3.optimization.univariate
Univariate real functions minimum finding algorithms.
org.apache.commons.math3.primes
Methods related to prime numbers like primality test, factor decomposition.
org.apache.commons.math3.random
Random number and random data generators.
org.apache.commons.math3.special
Implementations of special functions such as Beta and Gamma.
org.apache.commons.math3.stat
Data storage, manipulation and summary routines.
org.apache.commons.math3.stat.clustering
All classes and sub-packages of this package are deprecated.
org.apache.commons.math3.stat.correlation
Correlations/Covariance computations.
org.apache.commons.math3.stat.descriptive
Generic univariate summary statistic objects.
org.apache.commons.math3.stat.descriptive.moment
Summary statistics based on moments.
org.apache.commons.math3.stat.descriptive.rank
Summary statistics based on ranks.
org.apache.commons.math3.stat.descriptive.summary
Other summary statistics.
org.apache.commons.math3.stat.inference
Classes providing hypothesis testing.
org.apache.commons.math3.stat.interval
Classes providing binomial proportion confidence interval construction.
org.apache.commons.math3.stat.ranking
Classes providing rank transformations.
org.apache.commons.math3.stat.regression
Statistical routines involving multivariate data.
org.apache.commons.math3.transform
Implementations of transform methods, including Fast Fourier transforms.
org.apache.commons.math3.util
Convenience routines and common data structures used throughout the commons-math library.
org.freehep.math.minuit
User API for the JMinuit package.
org.jfree.chart
Core classes, including JFreeChart and ChartPanel.
org.jfree.chart.annotations
A framework for adding annotations to charts.
org.jfree.chart.axis
Axis classes and interfaces.
org.jfree.chart.block
Blocks and layout classes used extensively by the LegendTitle class.
org.jfree.chart.demo
Some basic demos to get you started.
org.jfree.chart.editor
Provides a simple (but so far incomplete) framework for editing chart properties.
org.jfree.chart.encoders
Classes related to the encoding of charts to different image formats.
org.jfree.chart.entity
Classes representing components of (or entities in) a chart.
org.jfree.chart.event
Event classes and listener interfaces, used to provide a change notification mechanism so that charts are automatically redrawn whenever changes are made to any chart component.
org.jfree.chart.fx
Core classes that provide JavaFX support for JFreeChart.
org.jfree.chart.fx.demo
Basic demo applications showing the use of JFreeChart in JavaFX.
org.jfree.chart.fx.interaction
Contains classes that implement most of the interactivity for the ChartViewer and ChartCanvas components.
org.jfree.chart.imagemap
Classes, including ImageMapUtilities, for creating HTML image maps.
org.jfree.chart.labels
Generators and other classes used for the display of item labels and tooltips.
org.jfree.chart.needle
A range of objects that can be used to represent the needle on a CompassPlot.
org.jfree.chart.panel
Classes related to the ChartPanel class.
org.jfree.chart.plot
Plot classes and related interfaces.
org.jfree.chart.plot.dial
Classes for creating dial plots.
org.jfree.chart.renderer
Core support for the plug-in renderers used by the CategoryPlot and XYPlot classes.
org.jfree.chart.renderer.category
Plug-in renderers for the CategoryPlot class.
org.jfree.chart.renderer.xy
Plug-in renderers for the XYPlot class.
org.jfree.chart.resources
Localised resources for the JFreeChart class library.
org.jfree.chart.servlet
Classes for providing useful servlet and JSP functionality.
org.jfree.chart.title
Classes used to display chart titles and subtitles.
org.jfree.chart.urls
Classes for adding URLS to charts for HTML image map generation.
org.jfree.chart.util
Utility classes used by JFreeChart.
org.jfree.data
The base package for classes that represent various types of data.
org.jfree.data.category
A package containing the CategoryDataset interface and related classes.
org.jfree.data.contour
Datasets used by the ContourPlot class.
org.jfree.data.function
Representation for simple functions.
org.jfree.data.gantt
Data interfaces and classes for Gantt charts.
org.jfree.data.general
Data interfaces and classes.
org.jfree.data.io
Miscellaneous support for input/output of data.
org.jfree.data.jdbc
Dataset classes that fetch data from a database via JDBC.
org.jfree.data.resources
Resource bundles for items that require localisation.
org.jfree.data.statistics
Classes for representing statistical data.
org.jfree.data.time
Interfaces and classes for time-related data.
org.jfree.data.time.ohlc
Classes for representing financial data in open-high-low-close form.
org.jfree.data.xml
Support for reading datasets from XML files.
org.jfree.data.xy
A package containing the XYDataset interface and related classes.
org.jlab.groot.base  
org.jlab.groot.data  
org.jlab.groot.demo  
org.jlab.groot.fitter  
org.jlab.groot.graphics  
org.jlab.groot.group  
org.jlab.groot.io  
org.jlab.groot.math  
org.jlab.groot.matrix  
org.jlab.groot.studio  
org.jlab.groot.tree  
org.jlab.groot.ui  
org.lsmp.djep.djep
Classes to perform differentiation of equations and various utility classes.
org.lsmp.djep.djep.diffRules
Rules specifying how to differentiate functions.
org.lsmp.djep.groupJep
A version of JEP which can work over an arbitary group.
org.lsmp.djep.groupJep.function
PostfixMathCommands which implement the group operations.
org.lsmp.djep.groupJep.groups
Some predefined groups.
org.lsmp.djep.groupJep.interfaces
Interfaces defining behavious a group implements.
org.lsmp.djep.groupJep.values
Objects representing the elements of a group.
org.lsmp.djep.jama
Wrapper for JAMA matrix operations for use in vectorJep and matrixJep.
org.lsmp.djep.matrixJep
Advanced vector and matrix handeling.
org.lsmp.djep.matrixJep.function
A few functions necessary for advanced matrix operations.
org.lsmp.djep.matrixJep.nodeTypes
Subclasses the AST nodes to work with vectors and matricies.
org.lsmp.djep.mrpe
Experimental fast evaluation routines for vectors and matrices.
org.lsmp.djep.rewrite
Experimental functions for tree manipulation, package may be dropped.
org.lsmp.djep.rpe
Experimental fast evaluation routines.
org.lsmp.djep.sjep
An advanced simplification/expansion/comparison algorithm.
org.lsmp.djep.vectorJep
Basic handeling of Vectors and Matricies.
org.lsmp.djep.vectorJep.function
Functions and operators for working with vectors and matricies.
org.lsmp.djep.vectorJep.values
Objects representing the values of Scalers, Vectors, Matricies and Tensors.
org.lsmp.djep.xjep
Simplification, deep copying, printing and various utilities.
org.lsmp.djep.xjep.function
Functions for use in XJep.
org.lsmp.djepExamples
Various example applications illustrating the use of most features.
org.lsmp.djepJUnit
JUnit tests to check that everything works correctly.
org.nfunk.jep
Provides the main parsing classes including JEP and Parser as well as related classes such as node classes.
org.nfunk.jep.evaluation
An experimental fast evaluator which "compiles" an expression into a set of CommandElement objects rather than traversing the parse tree.
org.nfunk.jep.function
Provides function and operator classes.
org.nfunk.jep.type
Provides number factories and special type classes.
org.nfunk.jepexamples
A set of examples using JEP.
org.nfunk.jeptesting
Testing classes using the junit unit testing component.
proeic.io  
promc.io  
pronlo.io  
proreco.io  
root
Access to ROOT files (based on Tony Johnson's RootHistogramBrowser).
test  

jas4pp: Data AnalysisEnvironment

Jas4pp is Java Analysis Studio for Particle Physics. This program is based on Java Analysis Studio, JAS3, but extends this program for particle physics. Jas4pp was designed at ANL for detector performance and physics studies of future circular-collider experiments. Main reference: S.V. Chekanov, G. Gavalian and N. A. Graf, “Jas4pp - a Data-Analysis Framework for Physics and Detector Studies” arXiv:2011.05329, Comp. Physics. Comm. 262 (2021) 107857, ANL-HEP-164101, SLAC-PUB-17569

This program is supported by the HEP/ANL (USA).

Skip navigation links

Jas4pp 1.5 © Java Analysis Studio for Particle Physics