Index
All Classes and Interfaces|All Packages
B
- bandPass(double[], double, double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev1
-
Applies a band-pass Chebyshev Type I filter.
- bandPass(double[], double, double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev2
-
Applies a band-pass Chebyshev Type II filter.
- bandStop(double[], double, double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev1
-
Applies a band-stop Chebyshev Type I filter.
- bandStop(double[], double, double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev2
-
Applies a band-stop Chebyshev Type II filter.
- blackman(int) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a symmetric Blackman window of length M.
- blackman(int, boolean) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a Blackman window of length M.
- Butterworth - Class in com.hissain.jscipy.signal.filter
-
Implements Butterworth filter operations, including `filtfilt` for zero-phase filtering.
- Butterworth() - Constructor for class com.hissain.jscipy.signal.filter.Butterworth
C
- cheby1_filtfilt(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.Signal
-
Applies a zero-phase Chebyshev Type I low-pass filter (forward and backward).
- cheby1_lfilter(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.Signal
-
Applies a standard (causal) Chebyshev Type I low-pass filter.
- cheby2_filtfilt(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.Signal
-
Applies a zero-phase Chebyshev Type II low-pass filter (forward and backward).
- cheby2_lfilter(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.Signal
-
Applies a standard (causal) Chebyshev Type II low-pass filter.
- Chebyshev1 - Class in com.hissain.jscipy.signal.filter
-
Chebyshev Type I Filter implementation.
- Chebyshev2 - Class in com.hissain.jscipy.signal.filter
-
Chebyshev Type II Filter implementation.
- com.hissain.jscipy - package com.hissain.jscipy
- com.hissain.jscipy.signal - package com.hissain.jscipy.signal
- com.hissain.jscipy.signal.fft - package com.hissain.jscipy.signal.fft
- com.hissain.jscipy.signal.filter - package com.hissain.jscipy.signal.filter
- com.hissain.jscipy.signal.math - package com.hissain.jscipy.signal.math
- compute(double, double) - Method in interface com.hissain.jscipy.signal.math.RK4Solver.DifferentialEquation
- conjugate() - Method in class com.hissain.jscipy.signal.JComplex
-
Returns the conjugate of this complex number.
- CONSTANT - Enum constant in enum class com.hissain.jscipy.signal.DetrendType
-
Removes a constant trend (mean) from the signal.
- ConvolutionMode - Enum Class in com.hissain.jscipy.signal
-
Enum representing the mode of convolution.
- convolve(double[], double[], ConvolutionMode) - Static method in class com.hissain.jscipy.signal.Signal
-
Convolves two signals using the specified mode.
D
- detrend(double[], DetrendType) - Static method in class com.hissain.jscipy.signal.Signal
-
Removes a linear or constant trend from the signal.
- DetrendType - Enum Class in com.hissain.jscipy.signal
-
Enum representing the type of detrending.
F
- f - Variable in class com.hissain.jscipy.signal.WelchResult
-
Array of sample frequencies.
- fft(double[]) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the forward FFT of a real-valued signal.
- fft(double[]) - Static method in class com.hissain.jscipy.signal.Signal
-
Computes the forward FFT of a real-valued signal.
- FFT - Class in com.hissain.jscipy.signal.fft
-
A class for performing Fast Fourier Transforms (FFT) and Short-Time Fourier Transforms (STFT).
- FFT() - Constructor for class com.hissain.jscipy.signal.fft.FFT
-
Constructs a new FFT object.
- filter(double[], double, double, int) - Method in class com.hissain.jscipy.signal.filter.Butterworth
-
Applies a Butterworth low-pass filter to a signal.
- filter(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev1
-
Applies a causal Chebyshev Type I low-pass filter (lfilter).
- filter(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev2
-
Applies a causal Chebyshev Type II low-pass filter (lfilter).
- filtfilt(double[], double, double, int) - Method in class com.hissain.jscipy.signal.filter.Butterworth
-
Applies a zero-phase digital filter forward and backward to a signal.
- filtfilt(double[], double, double, int) - Static method in class com.hissain.jscipy.signal.Signal
-
Applies a zero-phase Butterworth low-pass filter (forward and backward).
- filtfilt(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev1
-
Applies a zero-phase Chebyshev Type I low-pass filter (filtfilt).
- filtfilt(double[], double, double, int, double) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev2
-
Applies a zero-phase Chebyshev Type II low-pass filter (filtfilt).
- find_peaks(double[]) - Static method in class com.hissain.jscipy.signal.Signal
-
Finds peaks in a signal with default parameters.
- find_peaks(double[], Double, Integer, Double) - Static method in class com.hissain.jscipy.signal.Signal
-
Finds peaks in a signal with optional parameters.
- FULL - Enum constant in enum class com.hissain.jscipy.signal.ConvolutionMode
-
The output is the full discrete linear convolution of the inputs.
G
- getImaginary() - Method in class com.hissain.jscipy.signal.JComplex
-
Gets the imaginary part of this complex number.
- getReal() - Method in class com.hissain.jscipy.signal.JComplex
-
Gets the real part of this complex number.
H
- hamming(int) - Static method in class com.hissain.jscipy.signal.Signal
-
Returns a Hamming window of length M.
- hamming(int) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a symmetric Hamming window of length M.
- hamming(int, boolean) - Static method in class com.hissain.jscipy.signal.Signal
-
Returns a Hamming window of length M.
- hamming(int, boolean) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a Hamming window of length M.
- hanning(int) - Static method in class com.hissain.jscipy.signal.Signal
-
Returns a Hanning window of length M.
- hanning(int) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a symmetric Hanning window of length M.
- hanning(int, boolean) - Static method in class com.hissain.jscipy.signal.Signal
-
Returns a Hanning window of length M.
- hanning(int, boolean) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a Hanning window of length M.
- highPass(double[], double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev1
-
Applies a high-pass Chebyshev Type I filter.
- highPass(double[], double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev2
-
Applies a high-pass Chebyshev Type II filter.
- hilbert(double[]) - Method in class com.hissain.jscipy.signal.fft.Hilbert
-
Computes the analytic signal of a real-valued input array.
- Hilbert - Class in com.hissain.jscipy.signal.fft
-
Provides a method to compute the analytic signal using the Hilbert transform.
- Hilbert() - Constructor for class com.hissain.jscipy.signal.fft.Hilbert
-
Constructs a Hilbert transformer.
I
- ifft(JComplex[]) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the inverse FFT of a complex-valued signal.
- ifft(JComplex[]) - Static method in class com.hissain.jscipy.signal.Signal
-
Computes the inverse FFT of a complex-valued signal.
- imag - Variable in class com.hissain.jscipy.signal.JComplex
-
The imaginary part of the complex number.
- interp1d_cubic(double[], double[], double[]) - Static method in class com.hissain.jscipy.signal.Signal
-
Performs cubic spline interpolation on the given data points.
- interp1d_linear(double[], double[], double[]) - Static method in class com.hissain.jscipy.signal.Signal
-
Performs linear interpolation on the given data points.
- irfft(JComplex[], int) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the inverse FFT of a real-valued signal.
- irfft(JComplex[], int) - Static method in class com.hissain.jscipy.signal.Signal
-
Computes the inverse FFT of a real-valued signal (IRFFT).
- istft(JComplex[][]) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the Inverse Short-Time Fourier Transform (ISTFT) with default parameters.
- istft(JComplex[][], Integer, Integer, Integer, double[], String, Integer) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the Inverse Short-Time Fourier Transform (ISTFT).
J
- JComplex - Class in com.hissain.jscipy.signal
-
Represents a complex number with real and imaginary parts.
- JComplex(double, double) - Constructor for class com.hissain.jscipy.signal.JComplex
-
Constructs a new complex number.
K
- kaiser(int, double) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a symmetric Kaiser window of length M with shape parameter beta.
- kaiser(int, double, boolean) - Static method in class com.hissain.jscipy.signal.Windows
-
Returns a Kaiser window of length M with shape parameter beta.
L
- lfilter(double[], double, double, int) - Static method in class com.hissain.jscipy.signal.Signal
-
Applies a standard (causal) Butterworth low-pass filter.
- LINEAR - Enum constant in enum class com.hissain.jscipy.signal.DetrendType
-
Removes a linear trend from the signal.
- lowPass(double[], double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev1
-
Applies a low-pass Chebyshev Type I filter.
- lowPass(double[], double, double, int, double, boolean) - Static method in class com.hissain.jscipy.signal.filter.Chebyshev2
-
Applies a low-pass Chebyshev Type II filter.
M
- main(String[]) - Static method in class com.hissain.jscipy.Main
- main(String[]) - Static method in class com.hissain.jscipy.signal.filter.Butterworth
-
Main method for command-line execution of the Butterworth filter.
- main(String[]) - Static method in class com.hissain.jscipy.signal.math.RK4Solver
-
Main method for command-line execution of the RK4Solver.
- Main - Class in com.hissain.jscipy
- Main() - Constructor for class com.hissain.jscipy.Main
- medfilt(double[], int) - Method in class com.hissain.jscipy.signal.filter.MedFilt
-
Applies a median filter to the signal.
- MedFilt - Class in com.hissain.jscipy.signal.filter
-
Implements a median filter for signal smoothing.
- MedFilt() - Constructor for class com.hissain.jscipy.signal.filter.MedFilt
- multiply(double) - Method in class com.hissain.jscipy.signal.JComplex
-
Multiplies this complex number by a scalar factor.
P
- print() - Method in class com.hissain.jscipy.signal.math.RK4Solver.Solution
-
Prints the solution (time and y values) to the console.
- Pxx - Variable in class com.hissain.jscipy.signal.WelchResult
-
Power Spectral Density or power spectrum of x.
R
- real - Variable in class com.hissain.jscipy.signal.JComplex
-
The real part of the complex number.
- resample(double[], int) - Static method in class com.hissain.jscipy.signal.Signal
-
Resamples x to num samples using Fourier method along the given axis.
- rfft(double[]) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the forward FFT of a real-valued signal and returns the positive frequency components.
- rfft(double[]) - Static method in class com.hissain.jscipy.signal.Signal
-
Computes the forward FFT of a real-valued signal and returns the positive frequency components (RFFT).
- RK4Solver - Class in com.hissain.jscipy.signal.math
-
Runge-Kutta 4th Order Method for solving ODEs Usage similar to Python's scipy.integrate.odeint
- RK4Solver() - Constructor for class com.hissain.jscipy.signal.math.RK4Solver
- RK4Solver.DifferentialEquation - Interface in com.hissain.jscipy.signal.math
-
Functional interface for defining the differential equation dy/dt = f(t, y)
- RK4Solver.Solution - Class in com.hissain.jscipy.signal.math
-
Result class to hold the solution
S
- SAME - Enum constant in enum class com.hissain.jscipy.signal.ConvolutionMode
-
The output is the same size as the first input.
- savgol_filter(double[], int, int) - Method in class com.hissain.jscipy.signal.filter.SavitzkyGolayFilter
-
Applies a Savitzky-Golay filter to an array (smoothing, derivative=0).
- savgol_filter(double[], int, int, int, double) - Method in class com.hissain.jscipy.signal.filter.SavitzkyGolayFilter
-
Applies a Savitzky-Golay filter to an array.
- SavitzkyGolayFilter - Class in com.hissain.jscipy.signal.filter
-
Implements Savitzky-Golay filter for data smoothing and differentiation.
- SavitzkyGolayFilter() - Constructor for class com.hissain.jscipy.signal.filter.SavitzkyGolayFilter
- Signal - Class in com.hissain.jscipy.signal
-
A facade class providing static utility methods for signal processing, similar to
scipy.signal. - Signal() - Constructor for class com.hissain.jscipy.signal.Signal
- Solution(double[], double[]) - Constructor for class com.hissain.jscipy.signal.math.RK4Solver.Solution
-
Constructs a new Solution object.
- solve(RK4Solver.DifferentialEquation, double, double[]) - Method in class com.hissain.jscipy.signal.math.RK4Solver
-
Solve ODE using RK4 method with specified time points
- solve(RK4Solver.DifferentialEquation, double, double, double, double) - Method in class com.hissain.jscipy.signal.math.RK4Solver
-
Solve ODE using RK4 method
- stft(double[]) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the Short-Time Fourier Transform (STFT) with default parameters.
- stft(double[], Integer, Integer, Integer, double[], String, Boolean) - Method in class com.hissain.jscipy.signal.fft.FFT
-
Computes the Short-Time Fourier Transform (STFT) of a signal.
T
- t - Variable in class com.hissain.jscipy.signal.math.RK4Solver.Solution
-
Array of time points
V
- VALID - Enum constant in enum class com.hissain.jscipy.signal.ConvolutionMode
-
The output consists only of those elements that do not rely on the zero-padding.
- valueOf(String) - Static method in enum class com.hissain.jscipy.signal.ConvolutionMode
-
Returns the enum constant of this class with the specified name.
- valueOf(String) - Static method in enum class com.hissain.jscipy.signal.DetrendType
-
Returns the enum constant of this class with the specified name.
- values() - Static method in enum class com.hissain.jscipy.signal.ConvolutionMode
-
Returns an array containing the constants of this enum class, in the order they are declared.
- values() - Static method in enum class com.hissain.jscipy.signal.DetrendType
-
Returns an array containing the constants of this enum class, in the order they are declared.
W
- welch(double[], double, double[], int, int) - Method in class com.hissain.jscipy.signal.fft.Welch
-
Compute Power Spectral Density using Welch's method with custom parameters.
- welch(double[], double, int) - Method in class com.hissain.jscipy.signal.fft.Welch
-
Compute Power Spectral Density using Welch's method.
- Welch - Class in com.hissain.jscipy.signal.fft
-
Implementation of Welch's method for spectral density estimation.
- Welch() - Constructor for class com.hissain.jscipy.signal.fft.Welch
- WelchResult - Class in com.hissain.jscipy.signal
-
Holds the result of Welch's method for spectral density estimation.
- WelchResult(double[], double[]) - Constructor for class com.hissain.jscipy.signal.WelchResult
-
Constructs a WelchResult.
- Windows - Class in com.hissain.jscipy.signal
-
Utility class for window functions.
- Windows() - Constructor for class com.hissain.jscipy.signal.Windows
Y
- y - Variable in class com.hissain.jscipy.signal.math.RK4Solver.Solution
-
Array of solution values corresponding to time points
Z
- ZERO - Static variable in class com.hissain.jscipy.signal.JComplex
-
A constant representing the complex number 0 + 0i.
All Classes and Interfaces|All Packages