Title: | Vegetation Imaging Spectroscopy Analyzer |
---|---|
Description: | Provides easy-to-use tools for data analysis and visualization for hyperspectral remote sensing (also known as imaging spectroscopy), with a particular focus on vegetation hyperspectral data analysis. It consists of a set of functions, ranging from the organization of hyperspectral data in the proper data structure for spectral feature selection, calculation of vegetation index, multivariate analysis, as well as to the visualization of spectra and results of analysis in the 'ggplot2' style. |
Authors: | Kang Yu [aut, cre] |
Maintainer: | Kang Yu <[email protected]> |
License: | GPL-3 |
Version: | 1.0.0.9000 |
Built: | 2025-03-31 19:23:22 UTC |
Source: | https://github.com/kang-yu/visa |
Constructor as.spectra.dataframe
function creates a SpectraDataframe object, which is equivalent to the use of as.specdf.
as.spectra.dataframe( spectra = matrix(0), wavelength = numeric(0), w.unit = character(0), data = data.frame(0), ... )
as.spectra.dataframe( spectra = matrix(0), wavelength = numeric(0), w.unit = character(0), data = data.frame(0), ... )
spectra |
A matrix |
wavelength |
A numeric vector |
w.unit |
A character string |
data |
A data.frame |
... |
Other options for similar format of variables |
sdf |
Returns a SpectraDataframe. |
sdf <- as.spectra.dataframe(matrix(1:10, 1), 1:10, "nm", data.frame(a = 1, b =2)) str(sdf)
sdf <- as.spectra.dataframe(matrix(1:10, 1), 1:10, "nm", data.frame(a = 1, b =2)) str(sdf)
This function develops an optimization algorithm based on correlation analysis between the spectral matrix spectra
and the
vegetation variable of interest x
. It determines the best spectral band combinations (i, j) of the full spectrum that are most predictive for x
.
cm.nsr(S, x, w = wavelength(S), w.unit = NULL, cm.plot = FALSE)
cm.nsr(S, x, w = wavelength(S), w.unit = NULL, cm.plot = FALSE)
S |
A matrix of spectral data, where each row is a spectrum across all spectral bands. |
x |
A numeric vector (e.g., a vegetation variable). |
w |
A numeric vector of wavelengths; by default it is derived using |
w.unit |
A character string specifying the unit of wavelengths (default is |
cm.plot |
Logical. If |
For every possible pair of distinct bands (i, j), the function calculates
and then computes the squared Pearson correlation () between
x
and the resulting NSR values.
If the two bands are identical or the standard deviation of computed VI
(for a given band combination) is zero, the correlation is set to 0,
thereby avoiding warnings.
cm |
A correlation coefficient matrix with squared Pearson correlation values. |
## Not run: library(visa) data(NSpec.DF) X <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 5)] # resampled to 5 nm steps y <- NSpec.DF$N # nitrogen cm <- cm.nsr(X, y, cm.plot = TRUE) ## End(Not run)
## Not run: library(visa) data(NSpec.DF) X <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 5)] # resampled to 5 nm steps y <- NSpec.DF$N # nitrogen cm <- cm.nsr(X, y, cm.plot = TRUE) ## End(Not run)
This function computes the squared Pearson correlation () between a response vector
x
and a derived variable for every possible combination of three distinct spectral bands. The derived variable
is calculated using the formula:
where ,
, and
represent the reflectance values at bands
,
, and
, respectively.
cm.rbd3( S, x, w = wavelength(S), w.unit = NULL, cm.plot = FALSE, plot.method = "default" )
cm.rbd3( S, x, w = wavelength(S), w.unit = NULL, cm.plot = FALSE, plot.method = "default" )
S |
A spectral data object or matrix. Each column corresponds to a spectral band. |
x |
A numeric vector representing the response variable (e.g., chlorophyll). |
w |
A numeric vector of wavelengths; by default, it is derived using |
w.unit |
Character string specifying the unit of wavelengths (optional). |
cm.plot |
Logical. If |
plot.method |
Character string specifying the plotting method. Currently, the plotting option uses |
The function prints the maximum value and the corresponding band wavelengths. Optionally, it can produce a 3D slice plot
of the correlation array using
plot3D::slice3D
.
For every combination of three distinct bands (,
,
), the function computes
and then calculates the squared Pearson correlation between x
and V
.
The maximum value and its associated band combination are printed.
If cm.plot
is set to TRUE
, the function generates a 3D slice plot of the correlation array using the best band combination,
where the slices correspond to the wavelengths of the bands.
A 3-dimensional array of squared correlation () values with dimensions corresponding to the
combinations of bands
,
, and
.
## Not run: library(visa) data(NSpec.DF) x <- NSpec.DF$N # nitrogen # Below resamples spectra to 20 nm for fast computation S <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 20)] # S is a spectral data object and x is a numeric vector. Rsq3 <- cm.rbd3(S, x, cm.plot = TRUE) ## End(Not run)
## Not run: library(visa) data(NSpec.DF) x <- NSpec.DF$N # nitrogen # Below resamples spectra to 20 nm for fast computation S <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 20)] # S is a spectral data object and x is a numeric vector. Rsq3 <- cm.rbd3(S, x, cm.plot = TRUE) ## End(Not run)
This function develops an optimization algorithm based on correlation analysis between the spectral matrix spectra
and the
vegetation variable of interest x
. It determines the best spectral band combinations of the full spectrum that are most predictive for x
.
cm.sr(S, x, w = wavelength(S), w.unit = NULL, cm.plot = FALSE)
cm.sr(S, x, w = wavelength(S), w.unit = NULL, cm.plot = FALSE)
S |
A matrix of spectral data, where each row is a spectrum across all spectral bands. |
x |
A numeric vector (e.g., a vegetation variable). |
w |
A numeric vector of wavelengths; by default it is derived using |
w.unit |
A character string specifying the unit of wavelengths (default is |
cm.plot |
Logical. If |
This function runs a calculation of
using the spectra data for all the possible pairs/combinations of any two bands (i, j)
within the full spectrum range. Next, correlation analysis is then performed between all possible SR values and another vector variable y
, and it returns
the squared Pearson correlation () which indicates the predictive performance of each SR and its corresponding two-band combination. The
output is the wavelength (nm) indicating the best two bands that produce the highest value of
.
cm |
Returns a correlation coefficients matrix. |
## Not run: library(visa) data(NSpec.DF) # Using the example spectra matrix of the spectra.dataframe X <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 10)] # resampled to 10 nm steps y <- NSpec.DF$N # nitrogen cm <- cm.sr(X, y, cm.plot = FALSE) ## End(Not run)
## Not run: library(visa) data(NSpec.DF) # Using the example spectra matrix of the spectra.dataframe X <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 10)] # resampled to 10 nm steps y <- NSpec.DF$N # nitrogen cm <- cm.sr(X, y, cm.plot = FALSE) ## End(Not run)
This function identifies the best band combination from the cm.nsr or cm.sr
calculated correlation coefficients - a numeric matrix (2D), or the cm.rbd3 returned array (3D)
by locating the maximum value in the input R
and returning the corresponding wavelengths
from w
. For a 2D matrix, it returns a two-element vector (i, j); for a 3D array, a three-element
vector (i, j, k).
find.bestBands(R, w)
find.bestBands(R, w)
R |
A numeric matrix (2D) or array (3D) containing metric values (e.g., correlation values). |
w |
A numeric vector of wavelengths corresponding to the bands. |
The function first verifies that R
has dimensions. It then computes the maximum value in R
,
retrieves the indices corresponding to that value, and extracts the wavelengths from w
based on the
dimensionality of R
. If R
is 2D, the order is assumed to be (i, j); if R
is 3D, the order
is (i, j, k).
A vector of wavelengths corresponding to the best band combination.
# Example for a 2D matrix: R_mat <- matrix(c(0.2, 0.8, 0.5, 0.3), nrow = 2) wavelengths <- c(450, 550) bestBands <- find.bestBands(R_mat, wavelengths) # Example for a 3D array: R_arr <- array(runif(27), dim = c(3, 3, 3)) wavelengths <- c(400, 450, 500) bestBands <- find.bestBands(R_arr, wavelengths)
# Example for a 2D matrix: R_mat <- matrix(c(0.2, 0.8, 0.5, 0.3), nrow = 2) wavelengths <- c(450, 550) bestBands <- find.bestBands(R_mat, wavelengths) # Example for a 3D array: R_arr <- array(runif(27), dim = c(3, 3, 3)) wavelengths <- c(400, 450, 500) bestBands <- find.bestBands(R_arr, wavelengths)
This function plots a linear model fit using ggplot2. It creates a scatter plot with a regression line, and displays the regression equation along with the R² value.
## S3 method for class 'lmfit' ggplot(data, mapping = NULL, ..., environment = parent.frame())
## S3 method for class 'lmfit' ggplot(data, mapping = NULL, ..., environment = parent.frame())
data |
Either a numeric vector (to be used as x) or an object containing the data (e.g., a data frame). |
mapping |
Either a numeric vector (to be used as y when data is numeric) or an aesthetic mapping
created with |
... |
Other arguments passed to ggplot2 components. |
environment |
The environment in which to evaluate the plot. Defaults to |
When provided with two numeric vectors, the function treats them as x and y values, respectively, constructs a data frame, and applies a default mapping. Alternatively, if a data frame is provided, an aesthetic mapping (or default mapping) will be used.
A ggplot object.
## Not run: library(visa) # Using numeric vectors for x and y: ggplot.lmfit(1:10, 2:11) # Using a data frame: df <- data.frame(x = runif(10, 1, 10), y = runif(10, 2, 11) + 0.5) ggplot.lmfit(df, aes(x, y)) ## End(Not run)
## Not run: library(visa) # Using numeric vectors for x and y: ggplot.lmfit(1:10, 2:11) # Using a data frame: df <- data.frame(x = runif(10, 1, 10), y = runif(10, 2, 11) + 0.5) ggplot.lmfit(df, aes(x, y)) ## End(Not run)
**Deprecated:** This function is deprecated and will be removed in a future release.
Please use plt.2dcm
for 2D correlation matrices or the appropriate new functions for 3D plots.
## S3 method for class 'cm' ggplot( data, mapping = NULL, ..., show.stat = TRUE, environment = parent.frame() )
## S3 method for class 'cm' ggplot( data, mapping = NULL, ..., show.stat = TRUE, environment = parent.frame() )
data |
A numeric 2D matrix of correlation coefficients. (For 3D arrays, a warning is issued.) |
mapping |
Optional ggplot2 aesthetic mapping. |
... |
Additional arguments passed to |
show.stat |
Logical. If |
environment |
The environment in which to evaluate the plot. Defaults to |
This function creates a ggplot visualization from a 2D correlation matrix. It attempts to extract numeric wavelengths from the column names of the input matrix.
This function extracts numeric wavelengths from the column names of data
. If these
cannot be determined, sequential indices are used instead.
A ggplot object visualizing the correlation matrix. For 3D arrays, returns NULL
.
## Not run: library(visa) data(NSpec.DF) x <- NSpec.DF$N # nitrogen # resampled to 10 nm steps S <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 10)] cm2d <- cm.sr(S, x, cm.plot = FALSE) p2d <- ggplot.cm(cm2d) print(p2d) ## End(Not run)
## Not run: library(visa) data(NSpec.DF) x <- NSpec.DF$N # nitrogen # resampled to 10 nm steps S <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 10)] cm2d <- cm.sr(S, x, cm.plot = FALSE) p2d <- ggplot.cm(cm2d) print(p2d) ## End(Not run)
ggplot()
initializes a ggplot object. It can be used to
declare the input spectra object for a graphic and to optionally specify the
set of plot aesthetics intended to be common throughout all
subsequent layers unless specifically overridden.
## S3 method for class 'spectra' ggplot( data, mapping = NULL, ..., wl = NULL, w.unit = "nm", environment = parent.frame() )
## S3 method for class 'spectra' ggplot( data, mapping = NULL, ..., wl = NULL, w.unit = "nm", environment = parent.frame() )
data |
Default spectra database to use for plot. If not a spectra database, the
methods used will be those defined in package |
mapping |
Default list of aesthetic mappings to use for plot. If not specified, in the case of spectra objects, a default mapping will be used. |
... |
Other arguments passed on to methods. Not currently used. |
wl |
numeric The wavelength vector. |
w.unit |
character The wavelength unit of the spectra. |
environment |
If an variable defined in the aesthetic mapping is not
found in the data, ggplot will look for it in this environment. It defaults
to using the environment in which |
ggplot()
is typically used to construct a plot
incrementally, using the + operator to add layers to the
existing ggplot object. This is advantageous in that the
code is explicit about which layers are added and the order
in which they are added. For complex graphics with multiple
layers, initialization with ggplot
is recommended.
Current implementation does not merge default mapping with user supplied mapping. If user supplies a mapping, it is used as is. To add to the default mapping, aes() can be used by itself to compose the ggplot.
?ggpmisc::ggplot()
library(visa) library(ggplot2) ggplot.spectra(NSpec.DF)
library(visa) library(ggplot2) ggplot.spectra(NSpec.DF)
This function calculates a 2-band NDVI using the nsr
function.
ndvi2(s, b1, b2)
ndvi2(s, b1, b2)
s |
Spectral data in the format of visa's Spectra object, spectra.dataframe or spectra.matrix. |
b1 |
A integer number which defines the wavelength of the 1st spectral band. |
b2 |
A integer number which defines the wavelength of the 2nd spectral band. |
Calculate a NDVI with two specific bands of choice. The new NDVI follows the the standard formula
. Bands i and j correspond to the b1 and b2 input arguments, respectively. Wavelength indexes are determined based on the first argument 's'.
ndvi |
The returned values are the new NDVI. |
library(visa) s <- NSpec.DF$spectra ndvi2(s, 780, 680)
library(visa) s <- NSpec.DF$spectra ndvi2(s, 780, 680)
A dataset containing the plant Nitrogen content and spectra. The Spectra matrix is stored as a variable (in a column) of a data.frame.
NSpec.DF
NSpec.DF
A data frame with 19 rows and 2 variables:
Plant nitrogen content
A variable of Matrix of plant spectra
...
data.frame and NSpec.Lib
library(visa) data(NSpec.DF) str(NSpec.DF)
library(visa) data(NSpec.DF) str(NSpec.DF)
A S4 data structure containing the plant spectra and nitorgen (N) content. Spectra is organized as a matrix and is stored as a slot, named 'spectra'. The corresponding N content is stored in the slot 'data', which is a data.frame used for storing supporting data and plant/vegetation traits, such as here the plant N content.
NSpec.Lib
NSpec.Lib
A Spectra object with 19 rows and 4 slots (spectra, wavelength, w.unit, data).
A matrix of plant spectral data
A vector of wavelength for the 'spectra' data
A character string of wavelength unit (default "nm")
A data.frame of vegetation traits, here plant nitrogen content
...{currently not used}
library(visa) data(NSpec.Lib) str(NSpec.Lib)
library(visa) data(NSpec.Lib) str(NSpec.Lib)
It is a normalization of SR by doing NSR = (1-SR)/(1+SR), with the same two spectral bands.
nsr(s, b1, b2) lm.nsr(s, b1, b2, y)
nsr(s, b1, b2) lm.nsr(s, b1, b2, y)
s |
Spectral data in the format of visa's Spectra object, spectra.dataframe or spectra.matrix. |
b1 |
A integer number which defines the wavelength of the 1st spectral band. |
b2 |
A integer number which defines the wavelength of the 2nd spectral band. |
y |
A numeric variable to correlate with SR |
As it exactly reads in its name, it is a normalization of the SR and ranges in (0,1).
nsr |
Returns a NSR index. |
p |
Returns a ggplot object. |
s <- NSpec.DF$spectra nsr1 <- nsr(s, 480, 550) s <- NSpec.DF y <- NSpec.DF$N lm.nsr(s,600,500,y)
s <- NSpec.DF$spectra nsr1 <- nsr(s, 480, 550) s <- NSpec.DF y <- NSpec.DF$N lm.nsr(s,600,500,y)
This function creates a ggplot visualization from a 2D correlation matrix,
such as those produced by cm.sr
or cm.nsr
. The function attempts
to extract numeric wavelengths from the column names. If the extraction fails,
sequential indices are used.
plt.2dcm( data, mapping = NULL, ..., show.stat = TRUE, environment = parent.frame() )
plt.2dcm( data, mapping = NULL, ..., show.stat = TRUE, environment = parent.frame() )
data |
A numeric 2D matrix of correlation coefficients. |
mapping |
Optional ggplot2 aesthetic mapping. |
... |
Additional arguments passed to |
show.stat |
Logical. If |
environment |
The environment in which to evaluate the plot. Defaults to |
It replaces the former ggplot.cm()
.
The function extracts numeric wavelengths from the column names of data
.
If these cannot be determined, sequential indices are used instead.
A ggplot object visualizing the correlation matrix.
## Not run: library(visa) data(NSpec.DF) x <- NSpec.DF$N # nitrogen S <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 10)] # resampled to 10 nm steps cm2d <- cm.sr(S, x, cm.plot = FALSE) p2d <- plt.2dcm(cm2d) print(p2d) ## End(Not run)
## Not run: library(visa) data(NSpec.DF) x <- NSpec.DF$N # nitrogen S <- NSpec.DF$spectra[, seq(1, ncol(NSpec.DF$spectra), 10)] # resampled to 10 nm steps cm2d <- cm.sr(S, x, cm.plot = FALSE) p2d <- plt.2dcm(cm2d) print(p2d) ## End(Not run)
This function creates an interactive Plotly 3D slice plot from a 3D correlation array. The function uses the array's dimnames to define the coordinate values. If no dimnames are present, a warning is issued and sequential indices are used. The plot displays three surfaces corresponding to slices along each dimension (i, j, k) at the best band combination (where the correlation value is maximal).
plt.3dcm_best(R3, colorscale = "Spectral")
plt.3dcm_best(R3, colorscale = "Spectral")
R3 |
A 3D numeric array of correlation coefficients. |
colorscale |
A character string specifying the colorscale to use. If |
The function first checks if the input 3D array has proper dimnames. If not, it issues a warning
and assigns sequential indices as dimnames. It then melts the array to find the best band combination based on the
maximum correlation value. Using the dimnames, it finds the numeric indices for the best bands and creates grid matrices
for each slice. A custom colorscale is built when colorscale = "Spectral"
, and the Plotly figure is constructed
with a single color bar.
An interactive Plotly figure showing three surfaces corresponding to constant slices along dimensions i, j, and k.
## Not run: # Assume cm3d is a 3D correlation array with proper dimnames. plt.3dcm_best(cm3d) ## End(Not run)
## Not run: # Assume cm3d is a 3D correlation array with proper dimnames. plt.3dcm_best(cm3d) ## End(Not run)
Functions to access slot data of the Class Spectra.
spectra(object, ...) ## S4 method for signature 'Spectra' spectra(object, ...) ## S4 method for signature 'data.frame' spectra(object, ...) ## S4 method for signature 'matrix' spectra(object, ...)
spectra(object, ...) ## S4 method for signature 'Spectra' spectra(object, ...) ## S4 method for signature 'data.frame' spectra(object, ...) ## S4 method for signature 'matrix' spectra(object, ...)
object |
A Spectra object, spectra.data.frame, or spectra.matrix. |
... |
Other options. |
Construct generic functions for the Spectra object, spectra.data.frame, and spectra.matrix.
# For the S4 class 'Spectra' library(visa) data(NSpec.Lib) spectra_matrix <- spectra(NSpec.Lib) # For the spectra data.frame data(NSpec.DF) spectra_matrix <- spectra(NSpec.DF)
# For the S4 class 'Spectra' library(visa) data(NSpec.Lib) spectra_matrix <- spectra(NSpec.Lib) # For the spectra data.frame data(NSpec.DF) spectra_matrix <- spectra(NSpec.DF)
Constructor as.spectra
creates a Spectra object.
Constructor as.spectra.library
creates a SpectraLibrary object.
as.spectra( spectra = matrix(0), wavelength = numeric(0), w.unit = "nm", data = data.frame(), ... ) as.spectra.library( spectra = matrix(0), wavelength = numeric(0), w.unit = "nm", data = data.frame(), ... )
as.spectra( spectra = matrix(0), wavelength = numeric(0), w.unit = "nm", data = data.frame(), ... ) as.spectra.library( spectra = matrix(0), wavelength = numeric(0), w.unit = "nm", data = data.frame(), ... )
spectra |
A matrix |
wavelength |
A numeric vector |
w.unit |
A character string |
data |
A data.frame |
... |
Other parameters |
spectra
A matrix
wavelength
A numeric vector
w.unit
A character string
data
A data.frame
s <- as.spectra(matrix(1:100, 4), 1:25, "nm", data.frame(x = letters[1:4])) str(s) s <- as.spectra.library(matrix(1:100, 4), 1:25, "nm", data.frame(x = letters[1:4])) str(s)
s <- as.spectra(matrix(1:100, 4), 1:25, "nm", data.frame(x = letters[1:4])) str(s) s <- as.spectra.library(matrix(1:100, 4), 1:25, "nm", data.frame(x = letters[1:4])) str(s)
SpectraDataframe is an extended 'Spectra' class, with associated vegetation data ('data') in a data.frame.
spectra
A matrix
wavelength
A numeric vector
w.unit
A character string
data
A data.frame of vegetation data corresponding to the spectra
SpectraLibrary is an extended 'Spectra' class, with associated vegetation data ('data') in a data.frame.
spectra
A matrix
wavelength
A numeric vector
w.unit
A character string
data
A data.frame of vegetation data corresponding to the spectra
SpectraMatrix is a extended 'Spectra' class.
Constructor as.spectra.matrix
creates a SpectraMatrix object.
as.spectra.matrix( spectra = matrix(0), wavelength = numeric(0), w.unit = character(0) )
as.spectra.matrix( spectra = matrix(0), wavelength = numeric(0), w.unit = character(0) )
spectra |
A matrix |
wavelength |
A numeric vector |
w.unit |
A character string |
sdf |
Returns a SpectraDataframe. |
smatrix <- as.spectra.matrix(matrix(1:10, 1), 1:10, "nm") str(smatrix)
smatrix <- as.spectra.matrix(matrix(1:10, 1), 1:10, "nm") str(smatrix)
Simple Ratio is the ratio of the spectra (mostly reflectance) between two bands in the format of
sr(s, b1, b2) lm.sr(s, b1, b2, y)
sr(s, b1, b2) lm.sr(s, b1, b2, y)
s |
Spectral data in the format of visa's Spectra object, spectra.dataframe or spectra.matrix. |
b1 |
A integer number which defines the wavelength of the 1st spectral band. |
b2 |
A integer number which defines the wavelength of the 2nd spectral band. |
y |
A numeric variable to correlate with SR |
Simple ratio and NDVI looking indices are the two groups of mostly used spectral indices in remote sensing.
sr |
Returns a simple ratio index. |
p |
Returns a ggplot object. |
library(visa) s <- NSpec.DF$spectra sr1 <- sr(s, 480, 550) s <- NSpec.DF y <- NSpec.DF$N lm.sr(s,600,500,y)
library(visa) s <- NSpec.DF$spectra sr1 <- sr(s, 480, 550) s <- NSpec.DF y <- NSpec.DF$N lm.sr(s,600,500,y)
This function extracts the wavelength information from various representations of spectra.
It supports the S4 class Spectra
, as well as data.frame and matrix representations.
wavelength(object, ...) ## S4 method for signature 'Spectra' wavelength(object, ...) ## S4 method for signature 'data.frame' wavelength(object, ...) ## S4 method for signature 'matrix' wavelength(object, ...)
wavelength(object, ...) ## S4 method for signature 'Spectra' wavelength(object, ...) ## S4 method for signature 'data.frame' wavelength(object, ...) ## S4 method for signature 'matrix' wavelength(object, ...)
object |
An object containing spectra data. This can be an S4 object of class |
... |
Additional arguments for future extensions (currently not used). |
For an object of class Spectra
, the method returns the value stored in the wavelength
slot. For a data.frame or matrix, it extracts numeric values from the column names (by removing
non-digit characters) of the spectra data.
A numeric vector representing the wavelength information extracted from the object.
## Not run: library(visa) # For an S4 Spectra object wavelengths <- wavelength(NSpec.Lib) # For spectra stored in a data.frame wavelengths <- wavelength(NSpec.DF) # For spectra stored in a matrix wavelengths <- wavelength(spectra_matrix) ## End(Not run)
## Not run: library(visa) # For an S4 Spectra object wavelengths <- wavelength(NSpec.Lib) # For spectra stored in a data.frame wavelengths <- wavelength(NSpec.DF) # For spectra stored in a matrix wavelengths <- wavelength(spectra_matrix) ## End(Not run)