Title: | Automated spectraL Processing System for NMR |
---|---|
Description: | Reads Bruker NMR data directories both zipped and unzipped. It provides automated and efficient signal processing for untargeted NMR metabolomics. It is able to interpolate the samples, detect outliers, exclude regions, normalize, detect peaks, align the spectra, integrate peaks, manage metadata and visualize the spectra. After spectra proccessing, it can apply multivariate analysis on extracted data. Efficient plotting with 1-D data is also available. Basic reading of 1D ACD/Labs exported JDX samples is also available. |
Authors: | Ivan Montoliu Roura [aut], Sergio Oller Moreno [aut, cre] , Francisco Madrid Gambin [aut] , Luis Fernandez [aut] , Laura López Sánchez [ctb], Héctor Gracia Cabrera [aut], Santiago Marco Colás [aut] , Nestlé Institute of Health Sciences [cph], Institute for Bioengineering of Catalonia [cph], Miller Jack [ctb] (<https://orcid.org/0000-0002-6258-1299>, Autophase wrapper, ASICS export) |
Maintainer: | Sergio Oller Moreno <[email protected]> |
License: | MIT + file LICENSE |
Version: | 4.9.0 |
Built: | 2024-11-21 06:09:37 UTC |
Source: | https://github.com/bioc/AlpsNMR |
AlpsNMR allows you to import NMR spectra into R and provides automated and efficient signal processing for untargeted NMR metabolomics.
The following functions can be combined with the pipe. They create or modify the nmr_dataset object.
There are also functions to extract the metadata and submit the samples to irods, see the example below.
The nmr_dataset object is essentially a list, so it is easy to access its components for further analysis.
Maintainer: Sergio Oller Moreno [email protected] (ORCID)
Authors:
Ivan Montoliu Roura [email protected]
Francisco Madrid Gambin [email protected] (ORCID)
Luis Fernandez [email protected] (ORCID)
Héctor Gracia Cabrera [email protected]
Santiago Marco Colás [email protected] (ORCID)
Other contributors:
Laura López Sánchez [contributor]
Nestlé Institute of Health Sciences [copyright holder]
Institute for Bioengineering of Catalonia [copyright holder]
Miller Jack [email protected] (ORCID) (Autophase wrapper, ASICS export) [contributor]
Useful links:
Report bugs at https://github.com/sipss/AlpsNMR/issues
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) my_nmr_dataset <- dataset %>% nmr_interpolate_1D(axis = c(0.4, 10)) %>% nmr_exclude_region(exclude = list(water = c(4.6, 5))) %>% nmr_normalize(method = "pqn") %>% plot()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) my_nmr_dataset <- dataset %>% nmr_interpolate_1D(axis = c(0.4, 10)) %>% nmr_exclude_region(exclude = list(water = c(4.6, 5))) %>% nmr_normalize(method = "pqn") %>% plot()
Extract parts of an nmr_dataset
## S3 method for class 'nmr_dataset' x[i]
## S3 method for class 'nmr_dataset' x[i]
x |
an nmr_dataset object |
i |
indices of the samples to keep |
an nmr_dataset with the extracted samples
Other subsetting functions:
[.nmr_dataset_1D()
,
[.nmr_dataset_peak_table()
,
filter.nmr_dataset_family()
,
nmr_pca_outliers_filter()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset2 <- dataset[1:3] # get the first 3 samples
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset2 <- dataset[1:3] # get the first 3 samples
Extract parts of an nmr_dataset_1D
## S3 method for class 'nmr_dataset_1D' x[i]
## S3 method for class 'nmr_dataset_1D' x[i]
x |
an nmr_dataset_1D object |
i |
indices of the samples to keep |
an nmr_dataset_1D with the extracted samples
Other subsetting functions:
[.nmr_dataset()
,
[.nmr_dataset_peak_table()
,
filter.nmr_dataset_family()
,
nmr_pca_outliers_filter()
Other nmr_dataset_1D functions:
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) dataset_1D[0]
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) dataset_1D[0]
Extract parts of an nmr_dataset_peak_table
## S3 method for class 'nmr_dataset_peak_table' x[i]
## S3 method for class 'nmr_dataset_peak_table' x[i]
x |
an nmr_dataset_peak_table object |
i |
indices of the samples to keep |
an nmr_dataset_peak_table with the extracted samples
Other subsetting functions:
[.nmr_dataset()
,
[.nmr_dataset_1D()
,
filter.nmr_dataset_family()
,
nmr_pca_outliers_filter()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) new[0]
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) new[0]
Bootstrap and permutation over PLS-VIP on AlpsNMR can be performed on both nmr_dataset_1D full spectra as well as nmr_dataset_peak_table peak tables.
bp_kfold_VIP_analysis(dataset, y_column, k = 4, ncomp = 3, nbootstrap = 300)
bp_kfold_VIP_analysis(dataset, y_column, k = 4, ncomp = 3, nbootstrap = 300)
dataset |
An nmr_dataset_family object |
y_column |
A string with the name of the y column (present in the metadata of the dataset) |
k |
Number of folds, recomended between 4 to 10 |
ncomp |
number of components for the bootstrap models |
nbootstrap |
number of bootstrap dataset |
Use of the bootstrap and permutation methods for a more robust variable importance in the projection metric for partial least squares regression, in a k-fold cross validation
A list with the following elements:
important_vips
: A list with the important vips selected
relevant_vips
: List of vips with some relevance
wilcoxon_vips
: List of vips that pass a wilcoxon test
vip_means
: Means of the vips scores
vip_score_plot
: plot of the vips scores
kfold_resuls
: results of the k bp_VIP_analysis
kfold_index
: list of index of partitions of the folds
# Data analysis for a table of integrated peaks set.seed(42) ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 10 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = sample(rep(c("A", "B"), times = num_samples / 2), num_samples) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) rownames(peak_matrix) <- paste0("Sample", 1:num_samples) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analyzed y_column = "Condition", # Label k = 2, ncomp = 1, nbootstrap = 5 ) message("Selected VIPs are: ", bp_results$important_vips)
# Data analysis for a table of integrated peaks set.seed(42) ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 10 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = sample(rep(c("A", "B"), times = num_samples / 2), num_samples) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) rownames(peak_matrix) <- paste0("Sample", 1:num_samples) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analyzed y_column = "Condition", # Label k = 2, ncomp = 1, nbootstrap = 5 ) message("Selected VIPs are: ", bp_results$important_vips)
Bootstrap and permutation over PLS-VIP on AlpsNMR can be performed on both nmr_dataset_1D full spectra as well as nmr_dataset_peak_table peak tables.
bp_VIP_analysis(dataset, train_index, y_column, ncomp, nbootstrap = 300)
bp_VIP_analysis(dataset, train_index, y_column, ncomp, nbootstrap = 300)
dataset |
An nmr_dataset_family object |
train_index |
set of index used to generate the bootstrap datasets |
y_column |
A string with the name of the y column (present in the metadata of the dataset) |
ncomp |
number of components used in the plsda models |
nbootstrap |
number of bootstrap dataset |
Use of the bootstrap and permutation methods for a more robust variable importance in the projection metric for partial least squares regression
A list with the following elements:
important_vips
: A list with the important vips selected
relevant_vips
: List of vips with some relevance
pls_vip
: Pls-VIPs of every bootstrap
pls_vip_perm
: Pls-VIPs of every bootstrap with permuted variables
pls_vip_means
: Pls-VIPs normaliced differences means
pls_vip_score_diff
: Differences of pls_vip
and pls_vip_perm
pls_models
: pls models of the diferent bootstraps
pls_perm_models
: pls permuted models of the diferent bootstraps
classif_rate
: classification rate of the bootstrap models
general_model
: pls model trained with all train data
general_CR
: classification rate of the general_model
vips_model
: pls model trained with vips selection over all train data
vips_CR
: classification rate of the vips_model
error
: error spected in a t distribution
lower_bound
: lower bound of the confidence interval
upper_bound
: upper bound of the confidence interval
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) ## Area under ROC for each outer cross-validation iteration: model$outer_cv_results_digested$auroc ## The number of components for the bootstrap models is selected ncomps <- model$outer_cv_results$`1`$model$ncomp train_index <- model$train_test_partitions$outer$`1`$outer_train # Bootstrap and permutation for VIP selection bp_VIPS <- bp_VIP_analysis(peak_table, # Data to be analyzed train_index, y_column = "Condition", ncomp = ncomps, nbootstrap = 10 )
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) ## Area under ROC for each outer cross-validation iteration: model$outer_cv_results_digested$auroc ## The number of components for the bootstrap models is selected ncomps <- model$outer_cv_results$`1`$model$ncomp train_index <- model$train_test_partitions$outer$`1`$outer_train # Bootstrap and permutation for VIP selection bp_VIPS <- bp_VIP_analysis(peak_table, # Data to be analyzed train_index, y_column = "Condition", ncomp = ncomps, nbootstrap = 10 )
Downloads the MTBLS242 dataset from Gralka et al., 2015. DOI: doi:10.3945/ajcn.115.110536.
download_MTBLS242( dest_dir = "MTBLS242", force = FALSE, keep_only_CPMG_1r = TRUE, keep_only_preop_and_3months = TRUE, keep_only_complete_time_points = TRUE )
download_MTBLS242( dest_dir = "MTBLS242", force = FALSE, keep_only_CPMG_1r = TRUE, keep_only_preop_and_3months = TRUE, keep_only_complete_time_points = TRUE )
dest_dir |
Directory where the dataset should be saved |
force |
Logical. If |
keep_only_CPMG_1r |
If |
keep_only_preop_and_3months |
If |
keep_only_complete_time_points |
If |
Besides the destination directory, this function includes three logical parameters to limit the amount of downloaded/saved data. To run the tutorial workflow:
only the "preop" and "three months" timepoints are used,
only subjects measured in both preop and three months time points are used
only the CPMG samples are used.
If you want to run the tutorial, you can set those filters to TRUE
. Then, roughly
800MB will be downloaded, and 77MB of disk space will be used, since for each
downloaded sample we remove all the data but the CPMG.
If you set those filters to FALSE
, roughly 1.8GB of data will be
downloaded (since we have more timepoints to download) and 1.8GB
of disk space will be used.
Note that we have experienced some sporadic timeouts from Metabolights, when downloading the dataset. If you get those timeouts simply re-run the download function and it will restart from where it stopped.
Note as well, that we observed several files to have incorrect data:
Obs4_0346s.zip is not present in the FTP server
Obs0_0110s.zip and Obs1_0256s.zip incorrectly contain sample Obs1_0010s
This function removes all three samples from the samples annotations and doesn't download their data.
Invisibly, the annotations. See the example for how to download the annotations and create a dataset from the downloaded files.
## Not run: download_MTBLS242("./MTBLS242") annot <- readr::read_tsv(annotations_destfile) dataset <- nmr_read_samples(annot$filename) dataset <- nmr_meta_add(dataset, annot) dataset ## End(Not run)
## Not run: download_MTBLS242("./MTBLS242") annot <- readr::read_tsv(annotations_destfile) dataset <- nmr_read_samples(annot$filename) dataset <- nmr_meta_add(dataset, annot) dataset ## End(Not run)
The function lists samples from the chosen folder required to import and
create a nmr_dataset_1D object. The function is based on the fs::dir_ls()
function.
file_lister(dataset_path_nmr, glob)
file_lister(dataset_path_nmr, glob)
dataset_path_nmr |
A character vector of the path where samples are. |
glob |
A wildcard or globbing pattern common for the samples to be read,
for example ending with *0 (spectra acquired by a NOESY sequence often end
by 0: 10, 20, 30...) or *s (for example, samples from the tutorial in this
package) passed on to |
lists of samples from the chosen folder
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") lists_of_samples <- file_lister(dir_to_demo_dataset, "*0")
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") lists_of_samples <- file_lister(dir_to_demo_dataset, "*0")
The rDolphin family functions are introduced to perform automatic targeted
metabolite profiling. Therefore, ensure that you interpolated from -0.1 ppm
in order to consider the TSP/DSS signal at 0.0 ppm. The function generates a
list with the files required by to_rDolphin function. Then, it is required
to save them with the save_files_to_rDolphin
. to_rDolphin function will
read the generated "parameters.csv" file.
function.
files_to_rDolphin(nmr_dataset, biological_origin)
files_to_rDolphin(nmr_dataset, biological_origin)
nmr_dataset |
An nmr_dataset object |
biological_origin |
String specify the type of sample (blood, urine, cell) |
a list containing:
meta_rDolphin
: metadata in rDolphin format,
NMR_spectra
: spectra matrix
ROI
: ROI template
Parameters
: parameters file
Other import/export functions:
Pipelines
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
## Not run: # Set the directory in which rDolphin files will be saved output_dir_10_rDolphin <- file.path(your_path, "10-rDolphin") fs::dir_create(output_dir_10_rDolphin) # Generate the files (for plasma/serum) files_rDolphin <- files_to_rDolphin(nmr_dataset_0_10_ppm, blood) # Save the files save_files_to_rDolphin(files_rDolphin, output_dir_10_rDolphin) # Build the rDolphin object. Do not forget to set the directory setwd(output_dir_10_rDolphin) rDolphin_object <- to_rDolphin("Parameters.csv") # Visualize your spectra rDolphin_plot(rDolphin_object) # Run the main profiling function (it takes a while) targeted_profiling <- Automatic_targeted_profiling(rDolphin_object) # Save results save_profiling_output(targeted_profiling, output_dir_10_rDolphin) save_profiling_plots( output_dir_10_rDolphin, targeted_profiling$final_output, targeted_profiling$reproducibility_data ) # Additionally, you can run some stats intensities <- targeted_profiling$final_output$intensity group <- as.factor(rDolphin_object$Metadata$type) model_PLS <- rdCV_PLS_RF(X = intensities, Y = group) ## End(Not run)
## Not run: # Set the directory in which rDolphin files will be saved output_dir_10_rDolphin <- file.path(your_path, "10-rDolphin") fs::dir_create(output_dir_10_rDolphin) # Generate the files (for plasma/serum) files_rDolphin <- files_to_rDolphin(nmr_dataset_0_10_ppm, blood) # Save the files save_files_to_rDolphin(files_rDolphin, output_dir_10_rDolphin) # Build the rDolphin object. Do not forget to set the directory setwd(output_dir_10_rDolphin) rDolphin_object <- to_rDolphin("Parameters.csv") # Visualize your spectra rDolphin_plot(rDolphin_object) # Run the main profiling function (it takes a while) targeted_profiling <- Automatic_targeted_profiling(rDolphin_object) # Save results save_profiling_output(targeted_profiling, output_dir_10_rDolphin) save_profiling_plots( output_dir_10_rDolphin, targeted_profiling$final_output, targeted_profiling$reproducibility_data ) # Additionally, you can run some stats intensities <- targeted_profiling$final_output$intensity group <- as.factor(rDolphin_object$Metadata$type) model_PLS <- rdCV_PLS_RF(X = intensities, Y = group) ## End(Not run)
Keep samples based on metadata column criteria
## S3 method for class 'nmr_dataset_family' filter(.data, ...)
## S3 method for class 'nmr_dataset_family' filter(.data, ...)
.data |
An nmr_dataset_family object |
... |
conditions, as in dplyr |
The same object, with the matching rows
Other subsetting functions:
[.nmr_dataset()
,
[.nmr_dataset_1D()
,
[.nmr_dataset_peak_table()
,
nmr_pca_outliers_filter()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) ## example 1 sample_10 <- filter(dataset_1D, NMRExperiment == "10") ## example 2 # test_samples <- dataset_1D %>% filter(nmr_peak_table$metadata$external$Group == "placebo")
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) ## example 1 sample_10 <- filter(dataset_1D, NMRExperiment == "10") ## example 2 # test_samples <- dataset_1D %>% filter(nmr_peak_table$metadata$external$Group == "placebo")
Format for nmr_dataset
## S3 method for class 'nmr_dataset' format(x, ...)
## S3 method for class 'nmr_dataset' format(x, ...)
x |
an nmr_dataset object |
... |
for future use |
Format for nmr_dataset
Other class helper functions:
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) format(dataset)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) format(dataset)
format for nmr_dataset_1D
## S3 method for class 'nmr_dataset_1D' format(x, ...)
## S3 method for class 'nmr_dataset_1D' format(x, ...)
x |
an nmr_dataset_1D object |
... |
for future use |
format for nmr_dataset_1D
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) format(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) format(dataset_1D)
Format for nmr_dataset_peak_table
## S3 method for class 'nmr_dataset_peak_table' format(x, ...)
## S3 method for class 'nmr_dataset_peak_table' format(x, ...)
x |
an nmr_dataset_peak_table object |
... |
for future use |
Format for nmr_dataset_peak_table
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) format(new)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) format(new)
integrate peak positions
Get integrals with metadata from integrate peak positions
get_integration_with_metadata(integration_object)
get_integration_with_metadata(integration_object)
integration_object |
A nmr_dataset object |
Get integrals with metadata from integrate peak positions
integration dataframe
Other peak integration functions:
Pipelines
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
peak_table <- matrix(1:6, nrow = 2, ncol = 3) rownames(peak_table) <- c("10", "20") colnames(peak_table) <- c("ppm_1.2", "ppm1.4", "ppm1.6") dataset <- new_nmr_dataset_peak_table( peak_table = peak_table, metadata = list(external = data.frame(NMRExperiment = c("10", "20"), Condition = c("A", "B"))) ) get_integration_with_metadata(dataset)
peak_table <- matrix(1:6, nrow = 2, ncol = 3) rownames(peak_table) <- c("10", "20") colnames(peak_table) <- c("ppm_1.2", "ppm1.4", "ppm1.6") dataset <- new_nmr_dataset_peak_table( peak_table = peak_table, metadata = list(external = data.frame(NMRExperiment = c("10", "20"), Condition = c("A", "B"))) ) get_integration_with_metadata(dataset)
The Human Metabolome DataBase multiplet table
# Get all the 1-Methylhistidine peaks: data("hmdb") hmdb[hmdb$Metabolite == "1-Methylhistidine", ]
# Get all the 1-Methylhistidine peaks: data("hmdb") hmdb[hmdb$Metabolite == "1-Methylhistidine", ]
The Human Metabolome DataBase multiplet table: blood metabolites normally found in NMR-based metabolomics
data("HMDB_blood") HMDB_blood[HMDB_blood$Metabolite == "1-Methylhistidine", ]
data("HMDB_blood") HMDB_blood[HMDB_blood$Metabolite == "1-Methylhistidine", ]
The Human Metabolome DataBase multiplet table: cell metabolites normally found in NMR-based metabolomics
data("HMDB_cell") HMDB_cell[HMDB_cell$Metabolite == "Acetone", ]
data("HMDB_cell") HMDB_cell[HMDB_cell$Metabolite == "Acetone", ]
The Human Metabolome DataBase multiplet table: urine metabolites normally found in NMR-based metabolomics
data("HMDB_urine") HMDB_urine[HMDB_urine$Metabolite == "1-Methyladenosine", ]
data("HMDB_urine") HMDB_urine[HMDB_urine$Metabolite == "1-Methyladenosine", ]
Object is of nmr_dataset class
is.nmr_dataset(x)
is.nmr_dataset(x)
x |
An object |
TRUE
if the object is an nmr_dataset, FALSE
otherwise
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) is(dataset)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) is(dataset)
Object is of nmr_dataset_1D class
is.nmr_dataset_1D(x)
is.nmr_dataset_1D(x)
x |
an nmr_dataset_1D object |
TRUE
if the object is an nmr_dataset_1D, FALSE
otherwise
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) result <- is(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) result <- is(dataset_1D)
Object is of nmr_dataset_peak_table class
is.nmr_dataset_peak_table(x)
is.nmr_dataset_peak_table(x)
x |
an nmr_dataset_peak_table object |
TRUE
if the object is an nmr_dataset_peak_table
, FALSE
otherwise
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) is(new)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) is(new)
nmr_dataset_load
nmr_dataset_save
nmr_dataset_load(file_name) nmr_dataset_save(nmr_dataset, file_name, ...)
nmr_dataset_load(file_name) nmr_dataset_save(nmr_dataset, file_name, ...)
file_name |
The file name to load or save to |
nmr_dataset |
An object from the nmr_dataset_family |
... |
Additional arguments passed to saveRDS. |
Functions to load and save nmr_dataset objects
load nmr dataset
save nmr dataset
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
# dataset <- nmr_dataset_load("test") nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # nmr_dataset_save(dataset, "test")
# dataset <- nmr_dataset_load("test") nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # nmr_dataset_save(dataset, "test")
Plot stability among models of the external cross validation
models_stability_plot_bootstrap(bp_results)
models_stability_plot_bootstrap(bp_results)
bp_results |
bp_kfold_VIP_analysis results |
A plot of models stability
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation # bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analized # y_column = "Condition", # Label # k = 3, # nbootstrap = 10) # message("Selected VIPs are: ", bp_results$importarn_vips) # models_stability_plot_bootstrap(bp_results)
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation # bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analized # y_column = "Condition", # Label # k = 3, # nbootstrap = 10) # message("Selected VIPs are: ", bp_results$importarn_vips) # models_stability_plot_bootstrap(bp_results)
Plot stability among models of the external cross validation
models_stability_plot_plsda(model)
models_stability_plot_plsda(model)
model |
A nmr_data_analysis_model |
A plot of models stability
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) # models_stability_plot_plsda(model)
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) # models_stability_plot_plsda(model)
Create an nmr_dataset object
new_nmr_dataset(metadata, data_fields, axis)
new_nmr_dataset(metadata, data_fields, axis)
metadata |
A named list of data frames |
data_fields |
A named list. Check the examples |
axis |
A list. Check the examples |
Create an nmr_dataset object
Create an nmr_dataset object
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
# metadata_1D <- list(external = data.frame(NMRExperiment = c("10", "20"))) # Sample 10 and Sample 20 can have different lengths (due to different setups) data_fields_1D <- list(data_1r = list(runif(16), runif(32))) # Each sample has its own axis list, with one element (because this example is 1D) axis_1D <- list(list(1:16), list(1:32)) my_1D_data <- new_nmr_dataset(metadata_1D, data_fields_1D, axis_1D) # Example for 2D samples metadata_2D <- list(external = data.frame(NMRExperiment = c("11", "21"))) data_fields_2D <- list(data_2rr = list(matrix(runif(16 * 3), nrow = 16, ncol = 3), runif(32 * 3), nrow = 32, ncol = 3 )) # Each sample has its own axis list, with one element (because this example is 1D) axis_2D <- list(list(1:16, 1:3), list(1:32, 1:3)) my_2D_data <- new_nmr_dataset(metadata_2D, data_fields_2D, axis_2D)
# metadata_1D <- list(external = data.frame(NMRExperiment = c("10", "20"))) # Sample 10 and Sample 20 can have different lengths (due to different setups) data_fields_1D <- list(data_1r = list(runif(16), runif(32))) # Each sample has its own axis list, with one element (because this example is 1D) axis_1D <- list(list(1:16), list(1:32)) my_1D_data <- new_nmr_dataset(metadata_1D, data_fields_1D, axis_1D) # Example for 2D samples metadata_2D <- list(external = data.frame(NMRExperiment = c("11", "21"))) data_fields_2D <- list(data_2rr = list(matrix(runif(16 * 3), nrow = 16, ncol = 3), runif(32 * 3), nrow = 32, ncol = 3 )) # Each sample has its own axis list, with one element (because this example is 1D) axis_2D <- list(list(1:16, 1:3), list(1:32, 1:3)) my_2D_data <- new_nmr_dataset(metadata_2D, data_fields_2D, axis_2D)
Creates a new 1D nmr_dataset object from scratch
new_nmr_dataset_1D(ppm_axis, data_1r, metadata)
new_nmr_dataset_1D(ppm_axis, data_1r, metadata)
ppm_axis |
A numeric vector with the ppm values for the columns of data_1r |
data_1r |
A numeric matrix with one NMR spectrum on each row |
metadata |
A list of data frames with at least the |
Creates a new 1D nmr_dataset object from scratch
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
# Create a random spectra matrix nsamp <- 12 npoints <- 20 dummy_ppm_axis <- seq(from = 0.2, to = 10, length.out = npoints) dummy_spectra_matrix <- matrix(runif(nsamp * npoints), nrow = nsamp, ncol = npoints) metadata <- list(external = data.frame( NMRExperiment = paste0("Sample", 1:12), DummyClass = c("a", "b") )) dummy_nmr_dataset_1D <- new_nmr_dataset_1D( ppm_axis = dummy_ppm_axis, data_1r = dummy_spectra_matrix, metadata = metadata )
# Create a random spectra matrix nsamp <- 12 npoints <- 20 dummy_ppm_axis <- seq(from = 0.2, to = 10, length.out = npoints) dummy_spectra_matrix <- matrix(runif(nsamp * npoints), nrow = nsamp, ncol = npoints) metadata <- list(external = data.frame( NMRExperiment = paste0("Sample", 1:12), DummyClass = c("a", "b") )) dummy_nmr_dataset_1D <- new_nmr_dataset_1D( ppm_axis = dummy_ppm_axis, data_1r = dummy_spectra_matrix, metadata = metadata )
Creates a new nmr_dataset_peak_table object from scratch
new_nmr_dataset_peak_table(peak_table, metadata)
new_nmr_dataset_peak_table(peak_table, metadata)
peak_table |
A numeric matrix with one NMR spectrum on each row |
metadata |
A list of data frames with at least the |
Creates a new nmr_dataset_peak_table object from scratch
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata)
This function is based on speaq::dohCluster.
nmr_align( nmr_dataset, peak_data, NMRExp_ref = NULL, maxShift_ppm = 0.0015, acceptLostPeak = FALSE )
nmr_align( nmr_dataset, peak_data, NMRExp_ref = NULL, maxShift_ppm = 0.0015, acceptLostPeak = FALSE )
nmr_dataset |
|
peak_data |
The detected peak data given by nmr_detect_peaks. |
NMRExp_ref |
NMRExperiment of the reference to use for alignment |
maxShift_ppm |
The maximum shift allowed, in ppm |
acceptLostPeak |
This is an option for users, TRUE is the default value. If the users believe that all the peaks in the peak list are true positive, change it to FALSE. |
An nmr_dataset_1D, with the spectra aligned
Other alignment functions:
Pipelines
,
nmr_align_find_ref()
Other peak alignment functions:
nmr_align_find_ref()
Find alignment reference
nmr_align_find_ref(nmr_dataset, peak_data)
nmr_align_find_ref(nmr_dataset, peak_data)
nmr_dataset |
|
peak_data |
The detected peak data given by nmr_detect_peaks. |
The NMRExperiment of the reference sample
Other alignment functions:
Pipelines
,
nmr_align()
Other peak alignment functions:
nmr_align()
Use phasing algorithms to rephase data in the spectral domain.
This function may improve autophasing processing from instrument vendors. It
wraps the NMRphasing::NMRphasing()
function, to automatically rephase spectra,
allowing you to choose from a number of algorithms
of which NLS
, MPC_DANM
and SPC_DANM
are the most recent.
Rephasing should happen before any spectra interpolation.
Please use the all_components = TRUE
when calling nmr_read_samples()
in order
to load the complex spectra and fix NMR phasing correctly.
nmr_autophase( dataset, method = c("NLS", "MPC_DANM", "MPC_EMP", "SPC_DANM", "SPC_EMP", "SPC_AAM", "SPC_DSM"), withBC = FALSE, ... )
nmr_autophase( dataset, method = c("NLS", "MPC_DANM", "MPC_EMP", "SPC_DANM", "SPC_EMP", "SPC_AAM", "SPC_DSM"), withBC = FALSE, ... )
dataset |
An nmr_dataset object |
method |
The autophasing method. See |
withBC |
|
... |
Other parameters passed on to |
A (hopefully better phased) nmr_dataset object, with updated real and imaginary parts.
if (requireNamespace("NMRphasing", quietly=TRUE)) { # Helpers to create a dataset: lorentzian <- function(x, x0, gamma, A) { A * (1 / (pi * gamma)) * ((gamma^2) / ((x - x0)^2 + gamma^2)) } x <- seq(from=1, to=2, length.out = 300) y <- lorentzian(x, 1.3, 0.01, 1) + lorentzian(x, 1.6, 0.01, 1) dataset <- new_nmr_dataset( metadata = list(external = data.frame(NMRExperiment = "10")), data_fields = list(data_1r = list(y)), axis = list(list(x)) ) # Autophase, interpolate and plot: dataset <- nmr_autophase(dataset, method = "NLS") dataset <- nmr_interpolate_1D(dataset, axis = c(min = 1, max = 2, by = 0.01)) plot(dataset) }
if (requireNamespace("NMRphasing", quietly=TRUE)) { # Helpers to create a dataset: lorentzian <- function(x, x0, gamma, A) { A * (1 / (pi * gamma)) * ((gamma^2) / ((x - x0)^2 + gamma^2)) } x <- seq(from=1, to=2, length.out = 300) y <- lorentzian(x, 1.3, 0.01, 1) + lorentzian(x, 1.6, 0.01, 1) dataset <- new_nmr_dataset( metadata = list(external = data.frame(NMRExperiment = "10")), data_fields = list(data_1r = list(y)), axis = list(list(x)) ) # Autophase, interpolate and plot: dataset <- nmr_autophase(dataset, method = "NLS") dataset <- nmr_interpolate_1D(dataset, axis = c(min = 1, max = 2, by = 0.01)) plot(dataset) }
Estimate the baseline on an nmr_dataset_1D object, using baseline::baseline.als.
nmr_baseline_estimation(nmr_dataset, lambda = 9, p = 0.05, maxit = 20)
nmr_baseline_estimation(nmr_dataset, lambda = 9, p = 0.05, maxit = 20)
nmr_dataset |
An nmr_dataset_1D. |
lambda |
2nd derivative constraint |
p |
Weighting of positive residuals |
maxit |
Maximum number of iterations |
The same nmr_dataset_1D object with the data_1r_baseline
element.
Other baseline removal functions:
nmr_baseline_removal()
dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) dataset_1D <- nmr_baseline_estimation(dataset_1D, lambda = 9, p = 0.01)
dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) dataset_1D <- nmr_baseline_estimation(dataset_1D, lambda = 9, p = 0.01)
Removes the baseline on an nmr_dataset_1D object, using baseline::baseline.als.
nmr_baseline_removal(nmr_dataset, lambda = 6, p = 0.05, maxit = 20)
nmr_baseline_removal(nmr_dataset, lambda = 6, p = 0.05, maxit = 20)
nmr_dataset |
An nmr_dataset_1D. |
lambda |
2nd derivative constraint |
p |
Weighting of positive residuals |
maxit |
Maximum number of iterations |
The same nmr_dataset_1D object after baseline removal.
Other baseline removal functions:
nmr_baseline_estimation()
dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) dataset_no_base_line <- nmr_baseline_removal(dataset_1D, lambda = 6, p = 0.01)
dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) dataset_no_base_line <- nmr_baseline_removal(dataset_1D, lambda = 6, p = 0.01)
Estimates the threshold value for peak detection on an nmr_dataset_1D object by examining a range without peaks, by default the 9.5 - 10 ppm range.
nmr_baseline_threshold( nmr_dataset, range_without_peaks = c(9.5, 10), method = c("mean3sd", "median3mad") )
nmr_baseline_threshold( nmr_dataset, range_without_peaks = c(9.5, 10), method = c("mean3sd", "median3mad") )
nmr_dataset |
An nmr_dataset_1D. |
range_without_peaks |
A vector with two doubles describing a range without peaks suitable for baseline detection |
method |
Either "mean3sd" or the more robust "median3mad". See the details. |
Two methods can be used:
"mean3sd": The mean3sd method computes the mean and the standard deviation of each spectrum
in the 9.5 - 10 ppm range. The mean spectrum and the mean standard deviation are both vectors
of length equal to the number of points in the given range. The mean of the mean spectrum
the noise. The threshold is defined as center + 3 dispersion
, and it is one single threshold
for the whole dataset. This is the default for backwards compatibility.
"median3mad": First we take the data matrix. If we have estimated a baseline already,
subtract it. In the defined region without peaks, estimate the median of each sample and
its median absolute deviation. Return a vector of length equal to the number of samples
with the median+3mad
for each sample. This is a new more robust method.
Numerical. A threshold value in intensity below that no peak is detected.
Other peak detection functions:
Pipelines
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
ppm_axis <- seq(from = 0, to = 10, length.out = 1000) data_1r <- matrix(runif(1000, 0, 10), nrow = 1) + 100 dataset_1D <- new_nmr_dataset_1D( ppm_axis = ppm_axis, data_1r = data_1r, metadata = list(external=data.frame(NMRExperiment = "10")) ) bl_threshold <- nmr_baseline_threshold(dataset_1D, range_without_peaks = c(9.5,10))
ppm_axis <- seq(from = 0, to = 10, length.out = 1000) data_1r <- matrix(runif(1000, 0, 10), nrow = 1) + 100 dataset_1D <- new_nmr_dataset_1D( ppm_axis = ppm_axis, data_1r = data_1r, metadata = list(external=data.frame(NMRExperiment = "10")) ) bl_threshold <- nmr_baseline_threshold(dataset_1D, range_without_peaks = c(9.5,10))
If you have a lot of samples you can make the plot window bigger (or
use " ```{r fig.height=10, fig.width=10}
" in notebooks), or choose some NMRExperiments.
nmr_baseline_threshold_plot( nmr_dataset, thresholds, NMRExperiment = "all", chemshift_range = c(9.5, 10), ... )
nmr_baseline_threshold_plot( nmr_dataset, thresholds, NMRExperiment = "all", chemshift_range = c(9.5, 10), ... )
nmr_dataset |
An nmr_dataset_1D object |
thresholds |
A named vector. The values are baseline thresholds. The names are NMRExperiments. |
NMRExperiment |
The NMRExperiments to plot (Use |
chemshift_range |
The range to plot, as a first check use the |
... |
arguments passed to ggplot2::aes (or to ggplot2::aes_string, being deprecated). |
A plot.
ppm_axis <- seq(from = 0, to = 10, length.out = 1000) data_1r <- matrix(runif(1000, 0, 10), nrow = 1) + 100 dataset_1D <- new_nmr_dataset_1D( ppm_axis = ppm_axis, data_1r = data_1r, metadata = list(external=data.frame(NMRExperiment = "10")) ) bl_threshold <- nmr_baseline_threshold(dataset_1D, range_without_peaks = c(9.5,10)) baselineThresh <- nmr_baseline_threshold(dataset_1D) nmr_baseline_threshold_plot(dataset_1D, bl_threshold)
ppm_axis <- seq(from = 0, to = 10, length.out = 1000) data_1r <- matrix(runif(1000, 0, 10), nrow = 1) + 100 dataset_1D <- new_nmr_dataset_1D( ppm_axis = ppm_axis, data_1r = data_1r, metadata = list(external=data.frame(NMRExperiment = "10")) ) bl_threshold <- nmr_baseline_threshold(dataset_1D, range_without_peaks = c(9.5,10)) baselineThresh <- nmr_baseline_threshold(dataset_1D) nmr_baseline_threshold_plot(dataset_1D, bl_threshold)
Batman helpers
nmr_batman_write_options( bopts, batman_dir = "BatmanInput", filename = "batmanOptions.txt" ) nmr_batman_export_dataset( nmr_dataset, batman_dir = "BatmanInput", filename = "NMRdata.txt" ) nmr_batman_multi_data_user_hmdb( batman_dir = "BatmanInput", filename = "multi_data_user.csv" ) nmr_batman_multi_data_user( multiplet_table, batman_dir = "BatmanInput", filename = "multi_data_user.csv" ) nmr_batman_metabolites_list( metabolite_names, batman_dir = "BatmanInput", filename = "metabolitesList.csv" )
nmr_batman_write_options( bopts, batman_dir = "BatmanInput", filename = "batmanOptions.txt" ) nmr_batman_export_dataset( nmr_dataset, batman_dir = "BatmanInput", filename = "NMRdata.txt" ) nmr_batman_multi_data_user_hmdb( batman_dir = "BatmanInput", filename = "multi_data_user.csv" ) nmr_batman_multi_data_user( multiplet_table, batman_dir = "BatmanInput", filename = "multi_data_user.csv" ) nmr_batman_metabolites_list( metabolite_names, batman_dir = "BatmanInput", filename = "metabolitesList.csv" )
bopts |
Batman options |
batman_dir |
Batman input directorye |
filename |
Filename to use, inside |
nmr_dataset |
An nmr_dataset_1D object |
multiplet_table |
A data frame, like the hmdb dataset |
metabolite_names |
A character vector of the metabolite names to consider |
These are helper functions to make Batman tests easier
Other batman functions:
nmr_batman_options()
bopts <- nmr_batman_options() # nmr_batman_write_options(bopts) dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) # nmr_batman_export_dataset(dataset_1D) message("Use of multi_data_user_hmdb") # multi_data_user_hmdb <- nmr_batman_multi_data_user_hmdb() hmdb <- NULL # utils::data("hmdb", package = "AlpsNMR", envir = environment()) # hmdb <- nmr_batman_multi_data_user(hmbd) metabolite_names <- c("alanine", "glucose") # metabolite_names <- nmr_batman_metabolites_list(metabolite_names)
bopts <- nmr_batman_options() # nmr_batman_write_options(bopts) dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) # nmr_batman_export_dataset(dataset_1D) message("Use of multi_data_user_hmdb") # multi_data_user_hmdb <- nmr_batman_multi_data_user_hmdb() hmdb <- NULL # utils::data("hmdb", package = "AlpsNMR", envir = environment()) # hmdb <- nmr_batman_multi_data_user(hmbd) metabolite_names <- c("alanine", "glucose") # metabolite_names <- nmr_batman_metabolites_list(metabolite_names)
Batman Options helper
nmr_batman_options( ppmRange = matrix(c(3, 3.1, 3.6, 3.7, 3.9, 4, 4, 4.1, 6.95, 7.05, 7.6, 7.7, 7.8, 7.9), ncol = 2, byrow = TRUE), specNo = "1", paraProc = 4L, negThresh = -0.5, scaleFac = 1e+06, downSamp = 1, hiresFlag = 1, randSeed = 100025L, nItBurnin = 200L, nItPostBurnin = 5000L, multFile = 2L, thinning = 50L, cfeFlag = 0, nItRerun = 5000L, startTemp = 1000, specFreq = 600, a = 1e-05, b = 1e-09, muMean = 1.1, muVar = 0.2, muVar_prop = 0.002, nuMVar = 0.0025, nuMVarProp = 0.1, tauMean = -0.05, tauPrec = 2, rdelta = 0.02, csFlag = 0 )
nmr_batman_options( ppmRange = matrix(c(3, 3.1, 3.6, 3.7, 3.9, 4, 4, 4.1, 6.95, 7.05, 7.6, 7.7, 7.8, 7.9), ncol = 2, byrow = TRUE), specNo = "1", paraProc = 4L, negThresh = -0.5, scaleFac = 1e+06, downSamp = 1, hiresFlag = 1, randSeed = 100025L, nItBurnin = 200L, nItPostBurnin = 5000L, multFile = 2L, thinning = 50L, cfeFlag = 0, nItRerun = 5000L, startTemp = 1000, specFreq = 600, a = 1e-05, b = 1e-09, muMean = 1.1, muVar = 0.2, muVar_prop = 0.002, nuMVar = 0.0025, nuMVarProp = 0.1, tauMean = -0.05, tauPrec = 2, rdelta = 0.02, csFlag = 0 )
ppmRange |
Range of ppm to process |
specNo |
Index of spectra to process |
paraProc |
Number of cores to use |
negThresh |
Truncation threshold for negative intensities |
scaleFac |
Divide each spectrum by this number |
downSamp |
Decimate each spectrum by this factor |
hiresFlag |
Keep High Resolution deconvolved spectra |
randSeed |
A random seed |
nItBurnin |
Number of burn-in iterations |
nItPostBurnin |
Number of iterations after burn-in |
multFile |
Multiplet file (integer) |
thinning |
Save MCMC state every thinning iterations |
cfeFlag |
Same concentration for all spectra (fixed effect) |
nItRerun |
Number of iterations for a batman rerun |
startTemp |
Start temperature |
specFreq |
NMR Spectrometer frequency |
a |
Shape parameter for the gamma distribution (used for lambda, the precision) |
b |
Rate distribution parameter for the gamma distribution (used for lambda, the precision) |
muMean |
Peak width mean in ln(Hz) |
muVar |
Peak width variance in ln(Hz) |
muVar_prop |
Peak width proposed variance in ln(Hz) |
nuMVar |
Peak width metabolite variance in ln(Hz) |
nuMVarProp |
Peak width metabolite proposed variance in ln(Hz) |
tauMean |
mean of the prior on tau |
tauPrec |
inverse of variance of prior on tau |
rdelta |
Truncation of the prior on peak shift (ppm) |
csFlag |
Specify chemical shift for each multiplet in each spectrum? (chemShiftperSpectra.csv file) |
A batman_options object with the Batman Options
Other batman functions:
nmr_batman
bopts <- nmr_batman_options()
bopts <- nmr_batman_options()
Build a peak table from the clustered peak list
nmr_build_peak_table(peak_data, dataset = NULL)
nmr_build_peak_table(peak_data, dataset = NULL)
peak_data |
A peak list, with the cluster column |
dataset |
A nmr_dataset_1D object, to get the metadata |
An nmr_dataset_peak_table, containing the peak table and the annotations
peak_data <- data.frame( NMRExperiment = c("10", "10", "20", "20"), peak_id = paste0("Peak", 1:4), ppm = c(1, 2, 1.1, 2.1), area = c(10, 20, 12, 22) ) clustering_result <- nmr_peak_clustering(peak_data, num_clusters = 2) peak_data <- clustering_result$peak_data peak_table <- nmr_build_peak_table(peak_data) stopifnot(ncol(peak_table) == 2)
peak_data <- data.frame( NMRExperiment = c("10", "10", "20", "20"), peak_id = paste0("Peak", 1:4), ppm = c(1, 2, 1.1, 2.1), area = c(10, 20, 12, 22) ) clustering_result <- nmr_peak_clustering(peak_data, num_clusters = 2) peak_data <- clustering_result$peak_data peak_table <- nmr_build_peak_table(peak_data) stopifnot(ncol(peak_table) == 2)
Set/Return the full spectra matrix
nmr_data(nmr_dataset, ...) ## S3 method for class 'nmr_dataset_1D' nmr_data(nmr_dataset, what = "data_1r", ...) nmr_data(nmr_dataset, ...) <- value ## S3 replacement method for class 'nmr_dataset_1D' nmr_data(nmr_dataset, what = "data_1r", ...) <- value
nmr_data(nmr_dataset, ...) ## S3 method for class 'nmr_dataset_1D' nmr_data(nmr_dataset, what = "data_1r", ...) nmr_data(nmr_dataset, ...) <- value ## S3 replacement method for class 'nmr_dataset_1D' nmr_data(nmr_dataset, what = "data_1r", ...) <- value
nmr_dataset |
An object from the nmr_dataset_family to get the raw data from |
... |
Passed on to methods for compatibility |
what |
What data do we want to get (default: |
value |
A matrix |
a matrix
The given nmr_dataset
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
dataset_rds <- system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR") dataset_1D <- nmr_dataset_load(dataset_rds) dataset_data <- nmr_data(dataset_1D) dataset_rds <- system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR") dataset_1D <- nmr_dataset_load(dataset_rds) dataset_1D_data <- nmr_data(dataset_1D)
dataset_rds <- system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR") dataset_1D <- nmr_dataset_load(dataset_rds) dataset_data <- nmr_data(dataset_1D) dataset_rds <- system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR") dataset_1D <- nmr_dataset_load(dataset_rds) dataset_1D_data <- nmr_data(dataset_1D)
Export 1D NMR data to SummarizedExperiment
nmr_data_1r_to_SummarizedExperiment(nmr_dataset)
nmr_data_1r_to_SummarizedExperiment(nmr_dataset)
nmr_dataset |
An nmr_dataset_1D object |
SummarizedExperiment An SummarizedExperiment object (unmodified)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) se <- nmr_data_1r_to_SummarizedExperiment(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) se <- nmr_data_1r_to_SummarizedExperiment(dataset_1D)
Data analysis on AlpsNMR can be performed on both nmr_dataset_1D full spectra as well as nmr_dataset_peak_table peak tables.
nmr_data_analysis( dataset, y_column, identity_column, external_val, internal_val, data_analysis_method, .enable_parallel = TRUE )
nmr_data_analysis( dataset, y_column, identity_column, external_val, internal_val, data_analysis_method, .enable_parallel = TRUE )
dataset |
An nmr_dataset_family object |
y_column |
A string with the name of the y column (present in the metadata of the dataset) |
identity_column |
|
external_val , internal_val
|
A list with two elements: |
data_analysis_method |
An nmr_data_analysis_method object |
.enable_parallel |
Set to |
The workflow consists of a double cross validation strategy using random
subsampling for splitting into train and test sets. The classification model
and the metric to choose the best model can be customized (see
new_nmr_data_analysis_method()
), but for now only a PLSDA classification
model with a best area under ROC curve metric is implemented (see
the examples here and plsda_auroc_vip_method)
A list with the following elements:
train_test_partitions
: A list with the indices used in train and test on each of the cross-validation iterations
inner_cv_results
: The output returned by train_evaluate_model
on each inner cross-validation
inner_cv_results_digested
: The output returned by choose_best_inner
.
outer_cv_results
: The output returned by train_evaluate_model
on each outer cross-validation
outer_cv_results_digested
: The output returned by train_evaluate_model_digest_outer
.
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) ## Area under ROC for each outer cross-validation iteration: model$outer_cv_results_digested$auroc ## Rank Product of the Variable Importance in the Projection ## (Lower means more important) sort(model$outer_cv_results_digested$vip_rankproducts)
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) ## Area under ROC for each outer cross-validation iteration: model$outer_cv_results_digested$auroc ## Rank Product of the Variable Importance in the Projection ## (Lower means more important) sort(model$outer_cv_results_digested$vip_rankproducts)
Create method for NMR data analysis
new_nmr_data_analysis_method( train_evaluate_model, train_evaluate_model_params_inner, choose_best_inner, train_evaluate_model_params_outer, train_evaluate_model_digest_outer )
new_nmr_data_analysis_method( train_evaluate_model, train_evaluate_model_params_inner, choose_best_inner, train_evaluate_model_params_outer, train_evaluate_model_digest_outer )
train_evaluate_model |
A function. The function(x_train, y_train, identity_train, x_test, y_test, identity_test, ...) The The The |
train_evaluate_model_params_inner , train_evaluate_model_params_outer
|
A list with additional
arguments to pass to |
choose_best_inner |
A function with a single argument: function(inner_cv_results) The argument is a list of
|
train_evaluate_model_digest_outer |
A function with a single argument: function(outer_cv_results) The argument is a list of |
An object encapsulating the method dependent functions that can be used with nmr_data_analysis
An nmr_dataset
represents a set of NMR samples.
It is defined as an S3 class, and it can be treated as a regular list.
It currently has the following elements:
metadata
: A list of data frames. Each data frame contains metadata of
a given area (acquisition parameters, preprocessing parameters, general sample information...)
axis
: A list with length equal to the dimensionality of the data.
For 1D spectra it is a list with a numeric vector
data_*
: Data arrays with the actual spectra. The first index represents
the sample, the rest of the indices match the length of each axis
.
Typically data_1r
is a matrix with one sample on each row and the chemical
shifts in the columns.
num_samples
: The number of samples in the dataset
Functions to save and load these objects
Other AlpsNMR dataset objects:
nmr_dataset_family
metadata_1D <- list(external = data.frame(NMRExperiment = c("10", "20"))) # Sample 10 and Sample 20 can have different lengths (due to different setups) data_fields_1D <- list(data_1r = list(runif(16), runif(32))) # Each sample has its own axis list, with one element (because this example is 1D) axis_1D <- list(list(1:16), list(1:32)) my_1D_data <- new_nmr_dataset(metadata_1D, data_fields_1D, axis_1D)
metadata_1D <- list(external = data.frame(NMRExperiment = c("10", "20"))) # Sample 10 and Sample 20 can have different lengths (due to different setups) data_fields_1D <- list(data_1r = list(runif(16), runif(32))) # Each sample has its own axis list, with one element (because this example is 1D) axis_1D <- list(list(1:16), list(1:32)) my_1D_data <- new_nmr_dataset(metadata_1D, data_fields_1D, axis_1D)
An nmr_dataset_1D
represents a set of 1D interpolated NMR samples.
It is defined as an S3 class, and it can be treated as a regular list.
It currently has the following elements:
metadata
: A list of data frames. Each data frame contains metadata of
a given area (acquisition parameters, preprocessing parameters, general sample information...)
axis
: A numeric vector with the chemical shift axis in ppm.
data_1r
: A matrix with one sample on each row and the chemical
shifts in the columns.
# Create a random spectra matrix nsamp <- 12 npoints <- 20 dummy_ppm_axis <- seq(from = 0.2, to = 10, length.out = npoints) dummy_spectra_matrix <- matrix(runif(nsamp * npoints), nrow = nsamp, ncol = npoints) metadata <- list(external = data.frame( NMRExperiment = paste0("Sample", 1:12), DummyClass = c("a", "b") )) dummy_nmr_dataset_1D <- new_nmr_dataset_1D( ppm_axis = dummy_ppm_axis, data_1r = dummy_spectra_matrix, metadata = metadata )
# Create a random spectra matrix nsamp <- 12 npoints <- 20 dummy_ppm_axis <- seq(from = 0.2, to = 10, length.out = npoints) dummy_spectra_matrix <- matrix(runif(nsamp * npoints), nrow = nsamp, ncol = npoints) metadata <- list(external = data.frame( NMRExperiment = paste0("Sample", 1:12), DummyClass = c("a", "b") )) dummy_nmr_dataset_1D <- new_nmr_dataset_1D( ppm_axis = dummy_ppm_axis, data_1r = dummy_spectra_matrix, metadata = metadata )
The AlpsNMR package defines and uses several objects to manage NMR Data.
These objects share some structure and functions, so it makes sense to have an abstract class to ensure that the shared structures are compatible
Functions to save and load these objects
Other AlpsNMR dataset objects:
nmr_dataset
An nmr_dataset_peak_table
represents a peak table with metadata.
It is defined as an S3 class, and it can be treated as a regular list.
## S3 method for class 'nmr_dataset_peak_table' as.data.frame(x, ...)
## S3 method for class 'nmr_dataset_peak_table' as.data.frame(x, ...)
x |
An nmr_dataset_peak_table object, |
... |
ignored |
metadata
: A list of data frames. Each data frame contains metadata. Usually
the list only has one data frame named "external".
peak_table
: A matrix with one sample on each row and the peaks in the
columns
A data frame with the sample metadata and the peak table
as.data.frame(nmr_dataset_peak_table)
: Convert to a data frame
Export nmr_dataset_peak_table to SummarizedExperiment
nmr_dataset_peak_table_to_SummarizedExperiment(nmr_peak_table)
nmr_dataset_peak_table_to_SummarizedExperiment(nmr_peak_table)
nmr_peak_table |
An nmr_dataset_peak_table object |
SummarizedExperiment object (unmodified)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) nmr_peak_table <- new_nmr_dataset_peak_table(peak_table, metadata) se <- nmr_dataset_peak_table_to_SummarizedExperiment(nmr_peak_table)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) nmr_peak_table <- new_nmr_dataset_peak_table(peak_table, metadata) se <- nmr_dataset_peak_table_to_SummarizedExperiment(nmr_peak_table)
The function detects peaks on an nmr_dataset_1D object, using
speaq::detectSpecPeaks. detectSpecPeaks
divides the whole spectra into
smaller segments and uses MassSpecWavelet::peakDetectionCWT for peak
detection.
nmr_detect_peaks( nmr_dataset, nDivRange_ppm = 0.1, scales = seq(1, 16, 2), baselineThresh = NULL, SNR.Th = 3, range_without_peaks = c(9.5, 10), fit_lorentzians = FALSE, verbose = FALSE )
nmr_detect_peaks( nmr_dataset, nDivRange_ppm = 0.1, scales = seq(1, 16, 2), baselineThresh = NULL, SNR.Th = 3, range_without_peaks = c(9.5, 10), fit_lorentzians = FALSE, verbose = FALSE )
nmr_dataset |
An nmr_dataset_1D. |
nDivRange_ppm |
Segment size, in ppms, to divide the spectra and search for peaks. |
scales |
The parameter of peakDetectionCWT function of MassSpecWavelet package, look it up in the original function. |
baselineThresh |
All peaks with intensities below the thresholds are excluded. Either:
|
SNR.Th |
The parameter of peakDetectionCWT function of MassSpecWavelet package, look it up in the original function. If you set -1, the function will itself re-compute this value. |
range_without_peaks |
A numeric vector of length two with a region without peaks, only used when |
fit_lorentzians |
If |
verbose |
Logical ( |
Optionally afterwards, the peak apex and the peak inflection points are used to efficiently adjust a lorentzian to each peak, and compute the peak area and width, as well as the error of the fit. These peak features can be used afterwards to reject false detections.
A data frame with the NMRExperiment, the sample index, the position in ppm and index and the peak intensity
nmr_align for peak alignment with the detected peak table
Peak_detection
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Plot peak detection results
nmr_detect_peaks_plot( nmr_dataset, peak_data, NMRExperiment = NULL, peak_id = NULL, accepted_only = NULL, ... )
nmr_detect_peaks_plot( nmr_dataset, peak_data, NMRExperiment = NULL, peak_id = NULL, accepted_only = NULL, ... )
nmr_dataset |
An nmr_dataset_1D. |
peak_data |
The peak table returned by nmr_detect_peaks |
NMRExperiment |
a single NMR experiment to plot |
peak_id |
A character vector. If given, plot only that peak id. |
accepted_only |
If |
... |
Arguments passed to plot.nmr_dataset_1D ( |
Plot peak detection results
Peak_detection nmr_detect_peaks
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
This plot allows to explore the performance of the peak detection across all the samples, by summarizing how many peaks are detected on each sample at each chemical shift range.
nmr_detect_peaks_plot_overview( peak_data, ppm_breaks = pretty(range(peak_data$ppm), n = 20), accepted_only = TRUE )
nmr_detect_peaks_plot_overview( peak_data, ppm_breaks = pretty(range(peak_data$ppm), n = 20), accepted_only = TRUE )
peak_data |
The output of |
ppm_breaks |
A numeric vector with the breaks that will be used to count the number of the detected peaks. |
accepted_only |
If |
You can use this plot to find differences in the number of detected peaks across your dataset, and then use
nmr_detect_peaks_plot()
to have a finer look at specific samples and chemical shifts, and assess graphically that the
peak detection results that you have are correct.
A scatter plot, with samples on one axis and chemical shift bins in the other axis. The size of each dot represents the number of peaks found on a sample within a chemical shift range.
Peak_detection
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Plot multiple peaks from a peak list
nmr_detect_peaks_plot_peaks( nmr_dataset, peak_data, peak_ids, caption = paste("{peak_id}", "(NMRExp.\u00A0{NMRExperiment},", "\u03B3(ppb)\u00a0=\u00a0{gamma_ppb},", "\narea\u00a0=\u00a0{area},", "nrmse\u00a0=\u00a0{norm_rmse})") )
nmr_detect_peaks_plot_peaks( nmr_dataset, peak_data, peak_ids, caption = paste("{peak_id}", "(NMRExp.\u00A0{NMRExperiment},", "\u03B3(ppb)\u00a0=\u00a0{gamma_ppb},", "\narea\u00a0=\u00a0{area},", "nrmse\u00a0=\u00a0{norm_rmse})") )
nmr_dataset |
The |
peak_data |
A data frame, the peak list |
peak_ids |
The peak ids to plot |
caption |
The caption for each subplot |
A plot object
Diagnose SNR threshold in peak detection
nmr_detect_peaks_tune_snr( ds, NMRExperiment = NULL, SNR_thresholds = seq(from = 2, to = 6, by = 0.1), ... )
nmr_detect_peaks_tune_snr( ds, NMRExperiment = NULL, SNR_thresholds = seq(from = 2, to = 6, by = 0.1), ... )
ds |
An nmr_dataset_1D dataset |
NMRExperiment |
A string with the single NMRExperiment used explore the SNR thresholds. If not given, use the first one. |
SNR_thresholds |
A numeric vector with the SNR thresholds to explore |
... |
Arguments passed on to
|
A list with the following elements:
peaks_detected
: A data frame with the columns from the nmr_detect_peaks output and an additional column
SNR_threshold
with the threshold used on each row.
num_peaks_per_region
: A summary of the peaks_detected
table, with the number of peaks detected on
each chemical shift region
plot_num_peaks_per_region
: A visual representation of num_peaks_per_region
plot_spectrum_and_detections
: A visual representation of the spectrum and the peaks detected with each
SNR threshold. Use plotly::ggplotly or plot_interactive on this to zoom and explore the results.
nmr_detect_peaks
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Excludes a given region (for instance to remove the water peak)
nmr_exclude_region(samples, exclude = list(water = c(4.7, 5))) ## S3 method for class 'nmr_dataset_1D' nmr_exclude_region(samples, exclude = list(water = c(4.7, 5)))
nmr_exclude_region(samples, exclude = list(water = c(4.7, 5))) ## S3 method for class 'nmr_dataset_1D' nmr_exclude_region(samples, exclude = list(water = c(4.7, 5)))
samples |
An object |
exclude |
A list with regions to be removed Typically:
|
The same object, with the regions excluded
Other basic functions:
nmr_normalize()
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) exclude_regions <- list(water = c(5.1, 4.5)) nmr_dataset <- nmr_exclude_region(nmr_dataset, exclude = exclude_regions) nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) exclude_regions <- list(water = c(5.1, 4.5)) nmr_dataset <- nmr_exclude_region(nmr_dataset, exclude = exclude_regions)
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) exclude_regions <- list(water = c(5.1, 4.5)) nmr_dataset <- nmr_exclude_region(nmr_dataset, exclude = exclude_regions) nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) exclude_regions <- list(water = c(5.1, 4.5)) nmr_dataset <- nmr_exclude_region(nmr_dataset, exclude = exclude_regions)
Export 1D NMR data to a CSV file
nmr_export_data_1r(nmr_dataset, filename)
nmr_export_data_1r(nmr_dataset, filename)
nmr_dataset |
An nmr_dataset_1D object |
filename |
The csv filename |
The nmr_dataset object (unmodified)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # nmr_export_data_1r(dataset_1D, "exported_nmr_dataset")
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # nmr_export_data_1r(dataset_1D, "exported_nmr_dataset")
Compute peak to peak distances
nmr_get_peak_distances(peak_data, same_sample_dist_factor = 3)
nmr_get_peak_distances(peak_data, same_sample_dist_factor = 3)
peak_data |
A peak list |
same_sample_dist_factor |
The distance between two peaks from the same sample are set to this factor multiplied by the maximum of all the peak distances |
A dist object with the peak2peak distances
peak_data <- data.frame( NMRExperiment = c("10", "10", "20", "20"), peak_id = paste0("Peak", 1:4), ppm = c(1, 2, 1.1, 3) ) peak2peak_dist <- nmr_get_peak_distances(peak_data) stopifnot(abs(as.numeric(peak2peak_dist) - c(6, 0.1, 2, 0.9, 1, 6)) < 1E-8)
peak_data <- data.frame( NMRExperiment = c("10", "10", "20", "20"), peak_id = paste0("Peak", 1:4), ppm = c(1, 2, 1.1, 3) ) peak2peak_dist <- nmr_get_peak_distances(peak_data) stopifnot(abs(as.numeric(peak2peak_dist) - c(6, 0.1, 2, 0.9, 1, 6)) < 1E-8)
Identify given regions and return a data frame with plausible assignations in human plasma/serum samples.
nmr_identify_regions_blood( ppm_to_assign, num_proposed_compounds = 3, verbose = FALSE )
nmr_identify_regions_blood( ppm_to_assign, num_proposed_compounds = 3, verbose = FALSE )
ppm_to_assign |
A vector with the ppm regions to assign |
num_proposed_compounds |
set the number of proposed metabolites sorted by the number times reported in the HMDB: |
verbose |
Logical value. Set it to TRUE to print additional information |
a data frame with plausible assignations.
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Other peak integration functions:
Pipelines
,
get_integration_with_metadata()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
# We identify regions from from the corresponding ppm storaged in a vector. ppm_to_assign <- c( 4.060960203, 3.048970634, 2.405935596, 3.24146865, 0.990616851, 1.002075066, 0.955325548 ) identification <- nmr_identify_regions_blood(ppm_to_assign)
# We identify regions from from the corresponding ppm storaged in a vector. ppm_to_assign <- c( 4.060960203, 3.048970634, 2.405935596, 3.24146865, 0.990616851, 1.002075066, 0.955325548 ) identification <- nmr_identify_regions_blood(ppm_to_assign)
Identify given regions and return a data frame with plausible assignations in cell samples.
nmr_identify_regions_cell( ppm_to_assign, num_proposed_compounds = 3, verbose = FALSE )
nmr_identify_regions_cell( ppm_to_assign, num_proposed_compounds = 3, verbose = FALSE )
ppm_to_assign |
A vector with the ppm regions to assign |
num_proposed_compounds |
set the number of proposed metabolites in |
verbose |
Logical value. Set it to TRUE to print additional information |
a data frame with plausible assignations.
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Other peak integration functions:
Pipelines
,
get_integration_with_metadata()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_urine()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
# We identify regions from from the corresponding ppm storaged in a vector. ppm_to_assign <- c( 4.060960203, 3.048970634, 2.405935596, 3.24146865, 0.990616851, 1.002075066, 0.955325548 ) identification <- nmr_identify_regions_cell(ppm_to_assign, num_proposed_compounds = 3)
# We identify regions from from the corresponding ppm storaged in a vector. ppm_to_assign <- c( 4.060960203, 3.048970634, 2.405935596, 3.24146865, 0.990616851, 1.002075066, 0.955325548 ) identification <- nmr_identify_regions_cell(ppm_to_assign, num_proposed_compounds = 3)
Identify given regions and return a data frame with plausible assignations in human urine samples. The data frame contains the column "Bouatra_2013" showing if the proposed metabolite was reported in this publication as regular urinary metabolite.
nmr_identify_regions_urine( ppm_to_assign, num_proposed_compounds = 5, verbose = FALSE )
nmr_identify_regions_urine( ppm_to_assign, num_proposed_compounds = 5, verbose = FALSE )
ppm_to_assign |
A vector with the ppm regions to assign |
num_proposed_compounds |
set the number of proposed metabolites sorted by the number times reported in the HMDB: |
verbose |
Logical value. Set it to TRUE to print additional information |
a data frame with plausible assignations.
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_integrate_regions()
Other peak integration functions:
Pipelines
,
get_integration_with_metadata()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
# We identify regions from from the corresponding ppm storaged in a vector. ppm_to_assign <- c( 4.060960203, 3.048970634, 2.405935596, 3.24146865, 0.990616851, 1.002075066, 0.955325548 ) identification <- nmr_identify_regions_urine(ppm_to_assign, num_proposed_compounds = 5)
# We identify regions from from the corresponding ppm storaged in a vector. ppm_to_assign <- c( 4.060960203, 3.048970634, 2.405935596, 3.24146865, 0.990616851, 1.002075066, 0.955325548 ) identification <- nmr_identify_regions_urine(ppm_to_assign, num_proposed_compounds = 5)
The function allows the integration of a given ppm vector with a specific width.
nmr_integrate_peak_positions( samples, peak_pos_ppm, peak_width_ppm = 0.006, ... )
nmr_integrate_peak_positions( samples, peak_pos_ppm, peak_width_ppm = 0.006, ... )
samples |
A nmr_dataset object |
peak_pos_ppm |
The peak positions, in ppm |
peak_width_ppm |
The peak widths (or a single peak width for all peaks) |
... |
Arguments passed on to
|
Integrate peak positions
Other peak integration functions:
Pipelines
,
get_integration_with_metadata()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
Integrate given regions and return a data frame with them
nmr_integrate_regions(samples, regions, ...) ## S3 method for class 'nmr_dataset_1D' nmr_integrate_regions( samples, regions, fix_baseline = FALSE, excluded_regions_as_zero = FALSE, set_negative_areas_to_zero = FALSE, ... )
nmr_integrate_regions(samples, regions, ...) ## S3 method for class 'nmr_dataset_1D' nmr_integrate_regions( samples, regions, fix_baseline = FALSE, excluded_regions_as_zero = FALSE, set_negative_areas_to_zero = FALSE, ... )
samples |
A nmr_dataset object |
regions |
A named list. Each element of the list is a region, given as a named numeric vector of length two with the range to integrate. The name of the region will be the name of the column |
... |
Keep for compatibility |
fix_baseline |
A logical. If |
excluded_regions_as_zero |
A logical. It determines the behaviour of the
integration when integrating regions that have been excluded. If If |
set_negative_areas_to_zero |
A logical. Ignored if |
An nmr_dataset_peak_table object
Other peak detection functions:
Pipelines
,
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
Other peak integration functions:
Pipelines
,
get_integration_with_metadata()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_peak_positions()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
# Creating a dataset dataset <- new_nmr_dataset_1D( ppm_axis = 1:10, data_1r = matrix(sample(0:99, replace = TRUE), nrow = 10), metadata = list(external = data.frame(NMRExperiment = c( "10", "20", "30", "40", "50", "60", "70", "80", "90", "100" ))) ) # Integrating selected regions peak_table_integration <- nmr_integrate_regions( samples = dataset, regions = list(ppm = c(2, 5)) ) # Creating a dataset dataset <- new_nmr_dataset_1D( ppm_axis = 1:10, data_1r = matrix(sample(0:99, replace = TRUE), nrow = 10), metadata = list(external = data.frame(NMRExperiment = c( "10", "20", "30", "40", "50", "60", "70", "80", "90", "100" ))) ) # Integrating selected regions peak_table_integration <- nmr_integrate_regions( samples = dataset, regions = list(ppm = c(2, 5)), fix_baseline = FALSE )
# Creating a dataset dataset <- new_nmr_dataset_1D( ppm_axis = 1:10, data_1r = matrix(sample(0:99, replace = TRUE), nrow = 10), metadata = list(external = data.frame(NMRExperiment = c( "10", "20", "30", "40", "50", "60", "70", "80", "90", "100" ))) ) # Integrating selected regions peak_table_integration <- nmr_integrate_regions( samples = dataset, regions = list(ppm = c(2, 5)) ) # Creating a dataset dataset <- new_nmr_dataset_1D( ppm_axis = 1:10, data_1r = matrix(sample(0:99, replace = TRUE), nrow = 10), metadata = list(external = data.frame(NMRExperiment = c( "10", "20", "30", "40", "50", "60", "70", "80", "90", "100" ))) ) # Integrating selected regions peak_table_integration <- nmr_integrate_regions( samples = dataset, regions = list(ppm = c(2, 5)), fix_baseline = FALSE )
Interpolate a set of 1D NMR Spectra
nmr_interpolate_1D(samples, axis = c(min = 0.2, max = 10, by = 8e-04)) ## S3 method for class 'nmr_dataset' nmr_interpolate_1D(samples, axis = c(min = 0.2, max = 10, by = 8e-04))
nmr_interpolate_1D(samples, axis = c(min = 0.2, max = 10, by = 8e-04)) ## S3 method for class 'nmr_dataset' nmr_interpolate_1D(samples, axis = c(min = 0.2, max = 10, by = 8e-04))
samples |
An NMR dataset |
axis |
The ppm axis range and optionally the ppm step. Set it to |
Interpolate a set of 1D NMR Spectra
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4))
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4))
This is useful to add metadata to datasets that can be later used for plotting spectra or further analysis (PCA...).
nmr_meta_add(nmr_data, metadata, by = "NMRExperiment") nmr_meta_add_tidy_excel(nmr_data, excel_file)
nmr_meta_add(nmr_data, metadata, by = "NMRExperiment") nmr_meta_add_tidy_excel(nmr_data, excel_file)
nmr_data |
an nmr_dataset_family object |
metadata |
A data frame with metadata to add |
by |
A column name of both the |
excel_file |
Path to a tidy Excel file name. The Excel can consist of multiple sheets, that are added sequentially. The first column of the first sheet MUST be named as one of the metadata already present in the dataset, typically will be "NMRExperiment". The rest of the columns of the first sheet can be named at will. Similary, the first column of the second sheet must be named as one of the metadata already present in the dataset, typically "NMRExperiment" or any of the columns of the first sheet. The rest of the columns of the second sheet can be named at will. See the package vignette for an example. |
The nmr_dataset_family object with the added metadata
Other metadata functions:
Pipelines
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_meta_groups()
Other nmr_dataset functions:
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
Other nmr_dataset_peak_table functions:
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
# Load a demo dataset with four samples: dataset <- system.file("dataset-demo", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dataset) # At first we just have the NMRExperiment column nmr_meta_get(nmr_dataset, groups = "external") # Get a table with NMRExperiment -> SubjectID dummy_metadata <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") NMRExp_SubjID <- readxl::read_excel(dummy_metadata, sheet = 1) NMRExp_SubjID # We can link the SubjectID column of the first excel into the dataset nmr_dataset <- nmr_meta_add(nmr_dataset, NMRExp_SubjID, by = "NMRExperiment") nmr_meta_get(nmr_dataset, groups = "external") # The second excel can use the SubjectID: SubjID_Age <- readxl::read_excel(dummy_metadata, sheet = 2) SubjID_Age # Add the metadata by its SubjectID: nmr_dataset <- nmr_meta_add(nmr_dataset, SubjID_Age, by = "SubjectID") # The final loaded metadata: nmr_meta_get(nmr_dataset, groups = "external") # Read a tidy excel file: dataset <- system.file("dataset-demo", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dataset) # At first we just have the NMRExperiment column nmr_meta_get(nmr_dataset, groups = "external") # Get a table with NMRExperiment -> SubjectID dummy_metadata <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") nmr_dataset <- nmr_meta_add_tidy_excel(nmr_dataset, dummy_metadata) # Updated Metadata: nmr_meta_get(nmr_dataset, groups = "external")
# Load a demo dataset with four samples: dataset <- system.file("dataset-demo", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dataset) # At first we just have the NMRExperiment column nmr_meta_get(nmr_dataset, groups = "external") # Get a table with NMRExperiment -> SubjectID dummy_metadata <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") NMRExp_SubjID <- readxl::read_excel(dummy_metadata, sheet = 1) NMRExp_SubjID # We can link the SubjectID column of the first excel into the dataset nmr_dataset <- nmr_meta_add(nmr_dataset, NMRExp_SubjID, by = "NMRExperiment") nmr_meta_get(nmr_dataset, groups = "external") # The second excel can use the SubjectID: SubjID_Age <- readxl::read_excel(dummy_metadata, sheet = 2) SubjID_Age # Add the metadata by its SubjectID: nmr_dataset <- nmr_meta_add(nmr_dataset, SubjID_Age, by = "SubjectID") # The final loaded metadata: nmr_meta_get(nmr_dataset, groups = "external") # Read a tidy excel file: dataset <- system.file("dataset-demo", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dataset) # At first we just have the NMRExperiment column nmr_meta_get(nmr_dataset, groups = "external") # Get a table with NMRExperiment -> SubjectID dummy_metadata <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") nmr_dataset <- nmr_meta_add_tidy_excel(nmr_dataset, dummy_metadata) # Updated Metadata: nmr_meta_get(nmr_dataset, groups = "external")
Export Metadata to an Excel file
nmr_meta_export( nmr_dataset, xlsx_file, groups = c("info", "orig", "title", "external") )
nmr_meta_export( nmr_dataset, xlsx_file, groups = c("info", "orig", "title", "external") )
nmr_dataset |
An nmr_dataset_family object |
xlsx_file |
"The .xlsx excel file" |
groups |
A character vector. Use |
The Excel file name
Other metadata functions:
Pipelines
,
nmr_meta_add()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_meta_groups()
Other nmr_dataset functions:
nmr_meta_add()
,
nmr_meta_get()
,
nmr_meta_get_column()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
Other nmr_dataset_peak_table functions:
nmr_meta_add()
,
nmr_meta_get()
,
nmr_meta_get_column()
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # nmr_meta_export(dataset, "metadata.xlsx")
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # nmr_meta_export(dataset, "metadata.xlsx")
Get metadata
nmr_meta_get(samples, columns = NULL, groups = NULL)
nmr_meta_get(samples, columns = NULL, groups = NULL)
samples |
a nmr_dataset_family object |
columns |
Columns to get. By default gets all the columns. |
groups |
Groups to get. Groups are predefined of columns. Typically
Both |
a data frame with the injection metadata
Other metadata functions:
Pipelines
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get_column()
,
nmr_meta_groups()
Other nmr_dataset functions:
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get_column()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
Other nmr_dataset_peak_table functions:
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get_column()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) metadata <- nmr_meta_get(dataset)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) metadata <- nmr_meta_get(dataset)
Get a single metadata column
nmr_meta_get_column(samples, column = "NMRExperiment")
nmr_meta_get_column(samples, column = "NMRExperiment")
samples |
a nmr_dataset_family object |
column |
A column to get |
A vector with the column
Other metadata functions:
Pipelines
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_groups()
Other nmr_dataset functions:
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_ppm_resolution()
,
print.nmr_dataset_1D()
Other nmr_dataset_peak_table functions:
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) metadata_column <- nmr_meta_get_column(dataset)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) metadata_column <- nmr_meta_get_column(dataset)
Get the names of metadata groups
nmr_meta_groups(samples)
nmr_meta_groups(samples)
samples |
a nmr_dataset_family object |
A character vector with group names
Other metadata functions:
Pipelines
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) metadata_column <- nmr_meta_get_column(dataset)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) metadata_column <- nmr_meta_get_column(dataset)
The nmr_normalize
function is used to normalize all the samples according
to a given criteria.
nmr_normalize( samples, method = c("area", "max", "value", "region", "pqn", "none"), ... ) nmr_normalize_extra_info(samples)
nmr_normalize( samples, method = c("area", "max", "value", "region", "pqn", "none"), ... ) nmr_normalize_extra_info(samples)
samples |
A nmr_dataset_1D object |
method |
The criteria to be used for normalization - area: Normalize to the total area - max: Normalize to the maximum intensity - value: Normalize each sample to a user defined value - region: Integrate a region and normalize each sample to that region - pqn: Use Probabalistic Quotient Normalization for normalization - none: Do not normalize at all |
... |
Method dependent arguments:
- |
The aim is to correct from changes between samples, so no matter the criteria used to normalize, once we get the factors (e.g. the areas), we divide them by the median normalization factor to avoid introducing global scaling factors.
The nmr_normalize_extra_info
function is used to extract additional information
after the normalization. Typically, we want to know what was the actual normalization
factor applied to each sample. The extra information includes a plot, representing
the dispersion of the normalization factor for each sample.
The nmr_dataset_1D object, with the samples normalized.
Further information for diagnostic of the normalization process is also saved
and can be extracted by calling nmr_normalize_extra_info()
afterwards.
Other basic functions:
nmr_exclude_region()
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_dataset <- nmr_normalize(nmr_dataset, method = "area") norm_dataset <- nmr_normalize(nmr_dataset) norm_dataset$plot nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_dataset <- nmr_normalize(nmr_dataset, method = "area") norm_extra_info <- nmr_normalize_extra_info(nmr_dataset) norm_extra_info$plot
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_dataset <- nmr_normalize(nmr_dataset, method = "area") norm_dataset <- nmr_normalize(nmr_dataset) norm_dataset$plot nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_dataset <- nmr_normalize(nmr_dataset, method = "area") norm_extra_info <- nmr_normalize_extra_info(nmr_dataset) norm_extra_info$plot
This function builds a PCA model with all the NMR spectra. Regions with zero values (excluded regions) or near-zero variance regions are automatically excluded from the analysis.
nmr_pca_build_model( nmr_dataset, ncomp = NULL, center = TRUE, scale = FALSE, ... ) ## S3 method for class 'nmr_dataset_1D' nmr_pca_build_model( nmr_dataset, ncomp = NULL, center = TRUE, scale = FALSE, ... )
nmr_pca_build_model( nmr_dataset, ncomp = NULL, center = TRUE, scale = FALSE, ... ) ## S3 method for class 'nmr_dataset_1D' nmr_pca_build_model( nmr_dataset, ncomp = NULL, center = TRUE, scale = FALSE, ... )
nmr_dataset |
a nmr_dataset_1D object |
ncomp |
Integer, if data is complete |
center |
(Default=TRUE) Logical, whether the variables should be shifted
to be zero centered. Only set to FALSE if data have already been centered.
Alternatively, a vector of length equal the number of columns of |
scale |
(Default=FALSE) Logical indicating whether the variables should be
scaled to have unit variance before the analysis takes place. The default is
|
... |
Additional arguments passed on to mixOmics::pca |
A PCA model as given by mixOmics::pca with two additional attributes:
nmr_data_axis
containing the full ppm axis
nmr_included
with the data points included in the model
These attributes are used internally by AlpsNMR to create loading plots
Other PCA related functions:
nmr_pca_outliers()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_plot()
,
nmr_pca_outliers_robust()
,
nmr_pca_plots
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D)
Compute PCA residuals and score distance for each sample
nmr_pca_outliers( nmr_dataset, pca_model, ncomp = NULL, quantile_critical = 0.975 )
nmr_pca_outliers( nmr_dataset, pca_model, ncomp = NULL, quantile_critical = 0.975 )
nmr_dataset |
An nmr_dataset_1D object |
pca_model |
A pca model returned by nmr_pca_build_model |
ncomp |
Number of components to use. Use |
quantile_critical |
critical quantile |
A list with:
outlier_info: A data frame with the NMRExperiment, the Q residuals and T scores
ncomp: Number of components used to compute Q and T
Tscore_critical, QResidual_critical: Critical values, given a quantile, for both Q and T.
Other PCA related functions:
nmr_pca_build_model()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_plot()
,
nmr_pca_outliers_robust()
,
nmr_pca_plots
Other outlier detection functions:
Pipelines
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_plot()
,
nmr_pca_outliers_robust()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D) outliers_info <- nmr_pca_outliers(dataset_1D, model)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D) outliers_info <- nmr_pca_outliers(dataset_1D, model)
Exclude outliers
nmr_pca_outliers_filter(nmr_dataset, pca_outliers)
nmr_pca_outliers_filter(nmr_dataset, pca_outliers)
nmr_dataset |
An nmr_dataset_1D object |
pca_outliers |
The output from |
An nmr_dataset_1D without the detected outliers
Other PCA related functions:
nmr_pca_build_model()
,
nmr_pca_outliers()
,
nmr_pca_outliers_plot()
,
nmr_pca_outliers_robust()
,
nmr_pca_plots
Other outlier detection functions:
Pipelines
,
nmr_pca_outliers()
,
nmr_pca_outliers_plot()
,
nmr_pca_outliers_robust()
Other subsetting functions:
[.nmr_dataset()
,
[.nmr_dataset_1D()
,
[.nmr_dataset_peak_table()
,
filter.nmr_dataset_family()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D) outliers_info <- nmr_pca_outliers(dataset_1D, model) dataset_whitout_outliers <- nmr_pca_outliers_filter(dataset_1D, outliers_info)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) model <- nmr_pca_build_model(dataset_1D) outliers_info <- nmr_pca_outliers(dataset_1D, model) dataset_whitout_outliers <- nmr_pca_outliers_filter(dataset_1D, outliers_info)
Plot for outlier detection diagnostic
nmr_pca_outliers_plot(nmr_dataset, pca_outliers, ...)
nmr_pca_outliers_plot(nmr_dataset, pca_outliers, ...)
nmr_dataset |
An nmr_dataset_1D object |
pca_outliers |
The output from |
... |
Additional parameters passed on to |
A plot for the outlier detection
Other PCA related functions:
nmr_pca_build_model()
,
nmr_pca_outliers()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_robust()
,
nmr_pca_plots
Other outlier detection functions:
Pipelines
,
nmr_pca_outliers()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_robust()
# dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # model <- nmr_pca_build_model(dataset_1D) # outliers_info <- nmr_pca_outliers(dataset_1D, model) # nmr_pca_outliers_plot(dataset_1D, outliers_info)
# dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # model <- nmr_pca_build_model(dataset_1D) # outliers_info <- nmr_pca_outliers(dataset_1D, model) # nmr_pca_outliers_plot(dataset_1D, outliers_info)
Outlier detection through robust PCA
nmr_pca_outliers_robust(nmr_dataset, ncomp = 5)
nmr_pca_outliers_robust(nmr_dataset, ncomp = 5)
nmr_dataset |
An nmr_dataset_1D object |
ncomp |
Number of rPCA components to use We have observed that the statistical test used as a threshold for outlier detection usually flags as outliers too many samples, due possibly to a lack of gaussianity As a workaround, a heuristic method has been implemented: We know that in the
Q residuals vs T scores plot from To determine the critical value, both for Q and T, we find the biggest gap between samples in the plot and use as critical value the center of the gap. This approach seems to work well when there are outliers, but it fails when there isn't any outlier. For that case, the gap would be placed anywhere and that is not desirable as many samples would be incorrectly flagged. The second assumption that we use is that no more than 10\ the samples may pass our critical value. If more than 10\ pass the critical value, then we assume that our heuristics are not reasonable and we don't set any critical limit. |
A list similar to nmr_pca_outliers
Other PCA related functions:
nmr_pca_build_model()
,
nmr_pca_outliers()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_plot()
,
nmr_pca_plots
Other outlier detection functions:
Pipelines
,
nmr_pca_outliers()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_plot()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) outliers_info <- nmr_pca_outliers_robust(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) outliers_info <- nmr_pca_outliers_robust(dataset_1D)
Plotting functions for PCA
nmr_pca_plot_variance(pca_model) nmr_pca_scoreplot(nmr_dataset, pca_model, comp = seq_len(2), ...) nmr_pca_loadingplot(pca_model, comp)
nmr_pca_plot_variance(pca_model) nmr_pca_scoreplot(nmr_dataset, pca_model, comp = seq_len(2), ...) nmr_pca_loadingplot(pca_model, comp)
pca_model |
A PCA model trained with nmr_pca_build_model |
nmr_dataset |
an nmr_dataset_1D object |
comp |
Components to represent |
... |
Additional aesthetics passed on to ggplot2::aes (use bare unquoted names) |
Plot of PCA
Other PCA related functions:
nmr_pca_build_model()
,
nmr_pca_outliers()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_plot()
,
nmr_pca_outliers_robust()
dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) model <- nmr_pca_build_model(dataset_1D) nmr_pca_plot_variance(model) nmr_pca_scoreplot(dataset_1D, model) nmr_pca_loadingplot(model, 1)
dataset_1D <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) model <- nmr_pca_build_model(dataset_1D) nmr_pca_plot_variance(model) nmr_pca_scoreplot(dataset_1D, model) nmr_pca_loadingplot(model, 1)
Peak clustering
nmr_peak_clustering( peak_data, peak2peak_dist = NULL, num_clusters = NULL, max_dist_thresh_ppb = NULL, verbose = FALSE )
nmr_peak_clustering( peak_data, peak2peak_dist = NULL, num_clusters = NULL, max_dist_thresh_ppb = NULL, verbose = FALSE )
peak_data |
The peak list |
peak2peak_dist |
The distances obtained with nmr_get_peak_distances.
If NULL it is computed from |
num_clusters |
If you want to fix the number of clusters. Leave |
max_dist_thresh_ppb |
To estimate the number of clusters, we enforce a limit on how far two peaks of the same cluster may be. By default this threshold will be computed as 3 times the median peak width (gamma), as given in the peak list. |
verbose |
A logical vector to print additional information |
A list including:
The peak_data
with an additional "cluster" column
cluster: the hierarchical cluster
num_clusters: an estimation of the number of clusters
num_cluster_estimation: A list with tables and plots to justify the number of cluster estimation
peak_data <- data.frame( NMRExperiment = c("10", "10", "20", "20"), peak_id = paste0("Peak", 1:4), ppm = c(1, 2, 1.1, 2.2), gamma_ppb = 100 ) clustering_result <- nmr_peak_clustering(peak_data) peak_data <- clustering_result$peak_data stopifnot("cluster" %in% colnames(peak_data))
peak_data <- data.frame( NMRExperiment = c("10", "10", "20", "20"), peak_id = paste0("Peak", 1:4), ppm = c(1, 2, 1.1, 2.2), gamma_ppb = 100 ) clustering_result <- nmr_peak_clustering(peak_data) peak_data <- clustering_result$peak_data stopifnot("cluster" %in% colnames(peak_data))
Plot clustering results
nmr_peak_clustering_plot( dataset, peak_list_clustered, NMRExperiments, chemshift_range, baselineThresh = NULL )
nmr_peak_clustering_plot( dataset, peak_list_clustered, NMRExperiments, chemshift_range, baselineThresh = NULL )
dataset |
The nmr_dataset_1D object |
peak_list_clustered |
A peak list table with a clustered column |
NMRExperiments |
Two and only two experiments to compare in the plot |
chemshift_range |
A region, make it so it does not cover a huge range (maybe 1ppm or less) |
baselineThresh |
If given (as returned from the |
A plot of the two experiments in the given chemshift range, with lines connecting peaks identified as the same and dots showing peaks without pairs
The function gets the ppm resolution of the dataset using the median of the difference of data points.
nmr_ppm_resolution(nmr_dataset) ## S3 method for class 'nmr_dataset' nmr_ppm_resolution(nmr_dataset) ## S3 method for class 'nmr_dataset_1D' nmr_ppm_resolution(nmr_dataset)
nmr_ppm_resolution(nmr_dataset) ## S3 method for class 'nmr_dataset' nmr_ppm_resolution(nmr_dataset) ## S3 method for class 'nmr_dataset_1D' nmr_ppm_resolution(nmr_dataset)
nmr_dataset |
An object containing NMR samples |
Numeric (the ppm resolution, measured in ppms)
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
print.nmr_dataset_1D()
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset) message("the ppm resolution of this dataset is ", nmr_ppm_resolution(nmr_dataset), " ppm") nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset) message("the ppm resolution of this dataset is ", nmr_ppm_resolution(nmr_dataset), " ppm") nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset) message("the ppm resolution of this dataset is ", nmr_ppm_resolution(nmr_dataset), " ppm")
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset) message("the ppm resolution of this dataset is ", nmr_ppm_resolution(nmr_dataset), " ppm") nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset) message("the ppm resolution of this dataset is ", nmr_ppm_resolution(nmr_dataset), " ppm") nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset) message("the ppm resolution of this dataset is ", nmr_ppm_resolution(nmr_dataset), " ppm")
Reads an FID file. This is a very simple function.
nmr_read_bruker_fid(sample_name, endian = "little")
nmr_read_bruker_fid(sample_name, endian = "little")
sample_name |
A single sample name |
endian |
Endianness of the fid file ("little" by default, use "big" if acqus$BYTORDA == 1) |
A numeric vector with the free induction decay values
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
fid <- nmr_read_bruker_fid("sample.fid")
fid <- nmr_read_bruker_fid("sample.fid")
These functions load samples from files and return a nmr_dataset.
nmr_read_samples_dir( samples_dir, format = "bruker", pulse_sequence = NULL, metadata_only = FALSE, ... ) nmr_read_samples( sample_names, format = "bruker", pulse_sequence = NULL, metadata_only = FALSE, ... )
nmr_read_samples_dir( samples_dir, format = "bruker", pulse_sequence = NULL, metadata_only = FALSE, ... ) nmr_read_samples( sample_names, format = "bruker", pulse_sequence = NULL, metadata_only = FALSE, ... )
samples_dir |
A directory or directories that contain multiple samples |
format |
Either "bruker" or "jdx" |
pulse_sequence |
If it is set to a pulse sequence ("NOESY", "JRES", "CPMG"...) it will only load the samples that match that pulse sequence. |
metadata_only |
A logical, to load only metadata (default: |
... |
Arguments passed on to
|
sample_names |
A character vector with file or directory names. |
a nmr_dataset object
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") zip_files <- fs::dir_ls(dir_to_demo_dataset, glob = "*.zip") dataset <- nmr_read_samples(sample_names = zip_files)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") zip_files <- fs::dir_ls(dir_to_demo_dataset, glob = "*.zip") dataset <- nmr_read_samples(sample_names = zip_files)
Create one zip file for each brucker sample path
nmr_zip_bruker_samples(path, workdir, overwrite = FALSE, ...)
nmr_zip_bruker_samples(path, workdir, overwrite = FALSE, ...)
path |
Character vector with sample directories |
workdir |
Directory to store zip files |
overwrite |
Should existing zip files be overwritten? |
... |
Passed to utils::zip |
A character vector of the same length as path, with the zip file names
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
save_zip_files_to <- tempfile(pattern = "zip_file_storage_") where_your_samples_are <- tempfile(pattern = "where_your_samples_are") # prepare sample: zip::unzip( system.file("dataset-demo", "10.zip", package = "AlpsNMR"), exdir = where_your_samples_are ) outpaths <- nmr_zip_bruker_samples( list.files(where_your_samples_are, full.names = TRUE), workdir = save_zip_files_to )
save_zip_files_to <- tempfile(pattern = "zip_file_storage_") where_your_samples_are <- tempfile(pattern = "where_your_samples_are") # prepare sample: zip::unzip( system.file("dataset-demo", "10.zip", package = "AlpsNMR"), exdir = where_your_samples_are ) outpaths <- nmr_zip_bruker_samples( list.files(where_your_samples_are, full.names = TRUE), workdir = save_zip_files_to )
Parameters for blood (plasma/serum) samples profiling
The template Parameters_blood
contains the chosen normalization approach (by default, PQN), the Spectometer Frequency (by default, 600.04MHz),
alignment (by default, TSP 0.00 ppm), bucket resolution (by default, 0.00023)
github.com/danielcanueto/rDolphin
data("Parameters_blood") Parameters_blood
data("Parameters_blood") Parameters_blood
The template Parameters_cell
contains the chosen normalization approach (by default, PQN), the Spectometer Frequency (by default, 600.04MHz),
alignment (by default, TSP 0.00 ppm), bucket resolution (by default, 0.00023)
github.com/danielcanueto/rDolphin
data("Parameters_cell") Parameters_cell
data("Parameters_cell") Parameters_cell
The template Parameters_urine
contains the chosen normalization approach (by default, PQN), the Spectometer Frequency (by default, 600.04MHz),
alignment (by default, TSP 0.00 ppm), bucket resolution (by default, 0.00023)
github.com/danielcanueto/rDolphin
data("Parameters_urine") Parameters_urine
data("Parameters_urine") Parameters_urine
Peak detection for NMR
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # Low resolution: dataset_1D <- nmr_interpolate_1D(nmr_dataset, axis = c(min = -0.5, max = 10, by = 0.001)) dataset_1D <- nmr_exclude_region(dataset_1D, exclude = list(water = c(4.7, 5))) # 1. Optimize peak detection parameters: range_without_peaks <- c(9.5, 10) # Choose a region without peaks: plot(dataset_1D, chemshift_range = range_without_peaks) baselineThresh <- nmr_baseline_threshold(dataset_1D, range_without_peaks = range_without_peaks) # Plot to check the baseline estimations nmr_baseline_threshold_plot( dataset_1D, baselineThresh, NMRExperiment = "all", chemshift_range = range_without_peaks ) # 1.Peak detection in the dataset. peak_data <- nmr_detect_peaks( dataset_1D, nDivRange_ppm = 0.1, # Size of detection segments scales = seq(1, 16, 2), baselineThresh = NULL, # Minimum peak intensity SNR.Th = 4, # Signal to noise ratio range_without_peaks = range_without_peaks, # To estimate ) sample_10 <- filter(dataset_1D, NMRExperiment == "10") # nmr_detect_peaks_plot(sample_10, peak_data, "NMRExp_ref") peaks_detected <- nmr_detect_peaks_tune_snr( sample_10, SNR_thresholds = seq(from = 2, to = 3, by = 0.5), nDivRange_ppm = 0.03, scales = seq(1, 16, 2), baselineThresh = 0 ) # 2.Find the reference spectrum to align with. NMRExp_ref <- nmr_align_find_ref(dataset_1D, peak_data) # 3.Spectra alignment using the ref spectrum and a maximum alignment shift nmr_dataset <- nmr_align(dataset_1D, # the dataset peak_data, # detected peaks NMRExp_ref = NMRExp_ref, # ref spectrum maxShift_ppm = 0.0015, # max alignment shift acceptLostPeak = FALSE ) # lost peaks # 4.PEAK INTEGRATION (please, consider previous normalization step). # First we take the peak table from the reference spectrum peak_data_ref <- filter(peak_data, NMRExperiment == NMRExp_ref) # Then we integrate spectra considering the peaks from the ref spectrum nmr_peak_table <- nmr_integrate_peak_positions( samples = nmr_dataset, peak_pos_ppm = peak_data_ref$ppm, peak_width_ppm = NULL ) validate_nmr_dataset_peak_table(nmr_peak_table) # If you wanted the final peak table before machine learning you can run nmr_peak_table_completed <- get_integration_with_metadata(nmr_peak_table)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # Low resolution: dataset_1D <- nmr_interpolate_1D(nmr_dataset, axis = c(min = -0.5, max = 10, by = 0.001)) dataset_1D <- nmr_exclude_region(dataset_1D, exclude = list(water = c(4.7, 5))) # 1. Optimize peak detection parameters: range_without_peaks <- c(9.5, 10) # Choose a region without peaks: plot(dataset_1D, chemshift_range = range_without_peaks) baselineThresh <- nmr_baseline_threshold(dataset_1D, range_without_peaks = range_without_peaks) # Plot to check the baseline estimations nmr_baseline_threshold_plot( dataset_1D, baselineThresh, NMRExperiment = "all", chemshift_range = range_without_peaks ) # 1.Peak detection in the dataset. peak_data <- nmr_detect_peaks( dataset_1D, nDivRange_ppm = 0.1, # Size of detection segments scales = seq(1, 16, 2), baselineThresh = NULL, # Minimum peak intensity SNR.Th = 4, # Signal to noise ratio range_without_peaks = range_without_peaks, # To estimate ) sample_10 <- filter(dataset_1D, NMRExperiment == "10") # nmr_detect_peaks_plot(sample_10, peak_data, "NMRExp_ref") peaks_detected <- nmr_detect_peaks_tune_snr( sample_10, SNR_thresholds = seq(from = 2, to = 3, by = 0.5), nDivRange_ppm = 0.03, scales = seq(1, 16, 2), baselineThresh = 0 ) # 2.Find the reference spectrum to align with. NMRExp_ref <- nmr_align_find_ref(dataset_1D, peak_data) # 3.Spectra alignment using the ref spectrum and a maximum alignment shift nmr_dataset <- nmr_align(dataset_1D, # the dataset peak_data, # detected peaks NMRExp_ref = NMRExp_ref, # ref spectrum maxShift_ppm = 0.0015, # max alignment shift acceptLostPeak = FALSE ) # lost peaks # 4.PEAK INTEGRATION (please, consider previous normalization step). # First we take the peak table from the reference spectrum peak_data_ref <- filter(peak_data, NMRExperiment == NMRExp_ref) # Then we integrate spectra considering the peaks from the ref spectrum nmr_peak_table <- nmr_integrate_peak_positions( samples = nmr_dataset, peak_pos_ppm = peak_data_ref$ppm, peak_width_ppm = NULL ) validate_nmr_dataset_peak_table(nmr_peak_table) # If you wanted the final peak table before machine learning you can run nmr_peak_table_completed <- get_integration_with_metadata(nmr_peak_table)
accepted
column based on some criteriaPeak list: Create an accepted
column based on some criteria
peaklist_accept_peaks( peak_data, nmr_dataset, nrmse_max = Inf, area_min = 0, area_max = Inf, ppm_min = -Inf, ppm_max = Inf, keep_rejected = TRUE, verbose = FALSE )
peaklist_accept_peaks( peak_data, nmr_dataset, nrmse_max = Inf, area_min = 0, area_max = Inf, ppm_min = -Inf, ppm_max = Inf, keep_rejected = TRUE, verbose = FALSE )
peak_data |
The peak list (a data frame) |
nmr_dataset |
The nmr_dataset where the peak_data was computed from |
nrmse_max |
The normalized root mean squared error of the lorentzian peak fitting must be less than or equal to this value |
area_min |
Peak areas must be larger or equal to this value |
area_max |
Peak areas must be smaller or equal to this value |
ppm_min |
The peak apex must be above this value |
ppm_max |
The peak apex must be below this value |
keep_rejected |
If |
verbose |
Print informational message |
The peak_data
, with a new accepted
column (or maybe some filtered rows)
# Fake data: nmr_dataset <- new_nmr_dataset_1D( 1:10, matrix(c(1:5, 4:2, 3, 0), nrow = 1), list(external = data.frame(NMRExperiment = "10")) ) peak_data <- data.frame( peak_id = c("Peak1", "Peak2"), NMRExperiment = c("10", "10"), ppm = c(5, 9), pos = c(5, 9), intensity = c(5, 3), ppm_infl_min = c(3, 8), ppm_infl_max = c(7, 10), gamma_ppb = c(1, 1), area = c(25, 3), norm_rmse = c(0.01, 0.8) ) # Create the accepted column: peak_data <- peaklist_accept_peaks(peak_data, nmr_dataset, area_min = 10, keep_rejected = FALSE) stopifnot(identical(peak_data$peak_id, "Peak1"))
# Fake data: nmr_dataset <- new_nmr_dataset_1D( 1:10, matrix(c(1:5, 4:2, 3, 0), nrow = 1), list(external = data.frame(NMRExperiment = "10")) ) peak_data <- data.frame( peak_id = c("Peak1", "Peak2"), NMRExperiment = c("10", "10"), ppm = c(5, 9), pos = c(5, 9), intensity = c(5, 3), ppm_infl_min = c(3, 8), ppm_infl_max = c(7, 10), gamma_ppb = c(1, 1), area = c(25, 3), norm_rmse = c(0.01, 0.8) ) # Create the accepted column: peak_data <- peaklist_accept_peaks(peak_data, nmr_dataset, area_min = 10, keep_rejected = FALSE) stopifnot(identical(peak_data$peak_id, "Peak1"))
The different methods are available for benchmarking while developing, we should pick one.
peaklist_fit_lorentzians( peak_data, nmr_dataset, amplitude_method = c("intensity", "2nd_derivative", "intensity_without_baseline"), refine_peak_model = c("none", "peak", "2nd_derivative") )
peaklist_fit_lorentzians( peak_data, nmr_dataset, amplitude_method = c("intensity", "2nd_derivative", "intensity_without_baseline"), refine_peak_model = c("none", "peak", "2nd_derivative") )
peak_data |
The peak data |
nmr_dataset |
The nmr_dataset object with the data. This function for now assumes nmr_dataset is NOT be baseline corrected |
amplitude_method |
The method to estimate the amplitude. It may be:
|
refine_peak_model |
Whether a non linear least squares fitting should be used to refine the estimated parameters. It can be:
|
gamma is estimated using the inflection points of the signal and fitting them to the lorentzian inflection points
$A$ is estimated using the amplitude_method
below
The peak position ($x_0$) is given in peak_data
Those estimations may be refined with non-linear least squares using refine_peak_model
. If the nls does not converge,
the initial estimations are kept. Convergence -and other nls errors- are saved for further reference and diagnostic.
Use attr(peak_data_fitted, "errors")
to retreive the error messages, where peak_data_fitted
is assumed to be the
output of this function. The refining improves gamma, $A$ and $x_0$.
The baseline estimation (when calculated, see the arguments) is set to Asymmetric Least Squares with lambda = 6, p=0.05, maxit=20 and it is probably not optimal... yet.
The given data frame peak_data
, with added columns:
inflection points,
gamma
area
a norm_rmse fitting error
As well as some attributes
"errors": A data frame with any error in the peak fitting
"fit_baseline": Whether the method used has any consideration for the baseline of the signal (maybe not very useful attribute)
"method_description": A textual description of what we did, to include it in plots
Make permutations with data and default settings from an nmr_data_analysis_method
permutation_test_model( dataset, y_column, identity_column, external_val, internal_val, data_analysis_method, nPerm = 50 )
permutation_test_model( dataset, y_column, identity_column, external_val, internal_val, data_analysis_method, nPerm = 50 )
dataset |
An nmr_dataset_family object |
y_column |
A string with the name of the y column (present in the metadata of the dataset) |
identity_column |
|
external_val , internal_val
|
A list with two elements: |
data_analysis_method |
An nmr_data_analysis_method object |
nPerm |
number of permutations |
A permutation matrix with permuted values
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) p <- permutation_test_model(peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology, nPerm = 10 )
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) p <- permutation_test_model(peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology, nPerm = 10 )
Plot permutation test using actual model and permutated models
permutation_test_plot( nmr_data_analysis_model, permMatrix, xlab = "AUCs", xlim, ylim = NULL, breaks = "Sturges", main = "Permutation test" )
permutation_test_plot( nmr_data_analysis_model, permMatrix, xlab = "AUCs", xlim, ylim = NULL, breaks = "Sturges", main = "Permutation test" )
nmr_data_analysis_model |
A nmr_data_analysis_model |
permMatrix |
A permutation fitness outcome from permutation_test_model |
xlab |
optional xlabel |
xlim |
optional x-range |
ylim |
otional y-range |
breaks |
optional custom histogram breaks (defaults to 'sturges') |
main |
optional plot title (or TRUE for autoname) |
A plot with the comparison between the actual model versus the permuted models
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) p <- permutation_test_model(peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology, nPerm = 10 ) permutation_test_plot(model, p)
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) methodology <- plsda_auroc_vip_method(ncomp = 3) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology ) p <- permutation_test_model(peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 3, test_size = 0.25), internal_val = list(iterations = 3, test_size = 0.25), data_analysis_method = methodology, nPerm = 10 ) permutation_test_plot(model, p)
Uses nmr_pca_outliers_robust to perform the detection of outliers
Normalize the full spectra to the internal calibrant region, then exclude that region and finally perform PQN normalization.
pipe_load_samples(samples_dir, glob = "*0", output_dir = NULL) pipe_add_metadata(nmr_dataset_rds, excel_file, output_dir) pipe_interpolate_1D(nmr_dataset_rds, axis, output_dir) pipe_exclude_regions(nmr_dataset_rds, exclude, output_dir) pipe_outlier_detection(nmr_dataset_rds, output_dir) pipe_filter_samples(nmr_dataset_rds, conditions, output_dir) pipe_peakdet_align( nmr_dataset_rds, nDivRange_ppm = 0.1, scales = seq(1, 16, 2), baselineThresh = 0.01, SNR.Th = -1, maxShift_ppm = 0.0015, acceptLostPeak = FALSE, output_dir = NULL ) pipe_peak_integration( nmr_dataset_rds, peak_det_align_dir, peak_width_ppm, output_dir ) pipe_normalization( nmr_dataset_rds, internal_calibrant = NULL, output_dir = NULL )
pipe_load_samples(samples_dir, glob = "*0", output_dir = NULL) pipe_add_metadata(nmr_dataset_rds, excel_file, output_dir) pipe_interpolate_1D(nmr_dataset_rds, axis, output_dir) pipe_exclude_regions(nmr_dataset_rds, exclude, output_dir) pipe_outlier_detection(nmr_dataset_rds, output_dir) pipe_filter_samples(nmr_dataset_rds, conditions, output_dir) pipe_peakdet_align( nmr_dataset_rds, nDivRange_ppm = 0.1, scales = seq(1, 16, 2), baselineThresh = 0.01, SNR.Th = -1, maxShift_ppm = 0.0015, acceptLostPeak = FALSE, output_dir = NULL ) pipe_peak_integration( nmr_dataset_rds, peak_det_align_dir, peak_width_ppm, output_dir ) pipe_normalization( nmr_dataset_rds, internal_calibrant = NULL, output_dir = NULL )
samples_dir |
The directory where the samples are |
glob |
A wildcard aka globbing pattern (e.g. |
output_dir |
The output directory for this pipe element |
nmr_dataset_rds |
The nmr_dataset.rds file name coming from previous nodes |
excel_file |
An excel file name. See details for the requirements The excel file can have one or more sheets. The excel sheets need to be as simple as possible: One header column on the first row and values below. Each of the sheets contain metadata that has to be integrated. The merge (technically a left join) is done using the first column of each sheet as key. In practical terms this means that the first sheet of the excel file MUST start with an "NMRExperiment" column, and as many additional columns to add (e.g. FluidXBarcode, SampleCollectionDate, TimePoint and SubjectID). The second sheet can have as the first column any of the already added columns, for instance the "SubjectID", and any additional columns (e.g. Gender, Age). The first column on each sheet, named the key column, MUST have unique values. For instance, a sheet starting with "SubjectID" MUST specify each subject ID only once (without repetitions). |
axis |
The ppm axis range and optionally the ppm step. Set it to |
exclude |
A list with regions to be removed Typically:
|
conditions |
A character vector with conditions to filter metadata.
The
Only samples fullfilling all the given conditions are kept in further analysis. |
nDivRange_ppm |
Segment size, in ppms, to divide the spectra and search for peaks. |
scales |
The parameter of peakDetectionCWT function of MassSpecWavelet package, look it up in the original function. |
baselineThresh |
All peaks with intensities below the thresholds are excluded. Either:
|
SNR.Th |
The parameter of peakDetectionCWT function of MassSpecWavelet package, look it up in the original function. If you set -1, the function will itself re-compute this value. |
maxShift_ppm |
The maximum shift allowed, in ppm |
acceptLostPeak |
This is an option for users, TRUE is the default value. If the users believe that all the peaks in the peak list are true positive, change it to FALSE. |
peak_det_align_dir |
Output directory from pipe_peakdet_align |
peak_width_ppm |
A peak width in ppm |
internal_calibrant |
A ppm range where the internal calibrant is, or |
If there is no internal calibrant, only the PQN normalization is done.
This function saves the result to the output directory
This function saves the result to the output directory
This function saves the result to the output directory
This function saves the result to the output directory
This function saves the result to the output directory
Pipeline: Filter samples according to metadata conditions
Pipeline: Peak detection and Alignment
Pipeline: Peak integration
Pipe: Full spectra normalization
Other import/export functions:
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
,
to_ChemoSpec()
Other metadata functions:
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_meta_groups()
Other outlier detection functions:
nmr_pca_outliers()
,
nmr_pca_outliers_filter()
,
nmr_pca_outliers_plot()
,
nmr_pca_outliers_robust()
Other peak detection functions:
nmr_baseline_threshold()
,
nmr_detect_peaks()
,
nmr_detect_peaks_plot()
,
nmr_detect_peaks_plot_overview()
,
nmr_detect_peaks_tune_snr()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_regions()
Other alignment functions:
nmr_align()
,
nmr_align_find_ref()
Other peak integration functions:
get_integration_with_metadata()
,
nmr_identify_regions_blood()
,
nmr_identify_regions_cell()
,
nmr_identify_regions_urine()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
## Example of pipeline usage ## There are differet ways of load the dataset dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # excel_file <- system.file("dataset-demo", # "dummy_metadata.xlsx", # package = "AlpsNMR") # output_dir <- tempdir() ## Load samples with pipes # pipe_load_samples(dir_to_demo_dataset, # glob = "*.zip", # output_dir = "../pipe_output") ## Another way to load it # nmr_dataset <- nmr_read_samples_dir(dir_to_demo_dataset) ## Saving the dataset in a .rds file # nmr_dataset_rds <- tempfile(fileext = ".rds") # nmr_dataset_save(nmr_dataset, nmr_dataset_rds) ## Interpolation # pipe_interpolate_1D(nmr_dataset_rds, # axis = c(min = -0.5, max = 10, by = 2.3E-4), # output_dir) ## Get the new path, based in output_dir # nmr_dataset_rds <- paste(output_dir, "\", "nmr_dataset.rds", sep = "", collapse = NULL) ## Adding metadata to samples # pipe_add_metadata(nmr_dataset_rds = nmr_dataset_rds, output_dir = output_dir, # excel_file = excel_file) ## Filtering samples # conditions <- 'SubjectID == "Ana"' # pipe_filter_samples(nmr_dataset_rds, conditions, output_dir) ## Outlier detection # pipe_outlier_detection(nmr_dataset_rds, output_dir) ## Exclude regions # exclude_regions <- list(water = c(5.1, 4.5)) # pipe_exclude_regions(nmr_dataset_rds, exclude_regions, output_dir) ## peak aling # pipe_peakdet_align(nmr_dataset_rds, output_dir = output_dir) ## peak integration # pipe_peak_integration(nmr_dataset_rds, # peak_det_align_dir = output_dir, # peak_width_ppm = 0.006, output_dir) ## Normalization # pipe_normalization(nmr_dataset_rds, output_dir = output_dir)
## Example of pipeline usage ## There are differet ways of load the dataset dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # excel_file <- system.file("dataset-demo", # "dummy_metadata.xlsx", # package = "AlpsNMR") # output_dir <- tempdir() ## Load samples with pipes # pipe_load_samples(dir_to_demo_dataset, # glob = "*.zip", # output_dir = "../pipe_output") ## Another way to load it # nmr_dataset <- nmr_read_samples_dir(dir_to_demo_dataset) ## Saving the dataset in a .rds file # nmr_dataset_rds <- tempfile(fileext = ".rds") # nmr_dataset_save(nmr_dataset, nmr_dataset_rds) ## Interpolation # pipe_interpolate_1D(nmr_dataset_rds, # axis = c(min = -0.5, max = 10, by = 2.3E-4), # output_dir) ## Get the new path, based in output_dir # nmr_dataset_rds <- paste(output_dir, "\", "nmr_dataset.rds", sep = "", collapse = NULL) ## Adding metadata to samples # pipe_add_metadata(nmr_dataset_rds = nmr_dataset_rds, output_dir = output_dir, # excel_file = excel_file) ## Filtering samples # conditions <- 'SubjectID == "Ana"' # pipe_filter_samples(nmr_dataset_rds, conditions, output_dir) ## Outlier detection # pipe_outlier_detection(nmr_dataset_rds, output_dir) ## Exclude regions # exclude_regions <- list(water = c(5.1, 4.5)) # pipe_exclude_regions(nmr_dataset_rds, exclude_regions, output_dir) ## peak aling # pipe_peakdet_align(nmr_dataset_rds, output_dir = output_dir) ## peak integration # pipe_peak_integration(nmr_dataset_rds, # peak_det_align_dir = output_dir, # peak_width_ppm = 0.006, output_dir) ## Normalization # pipe_normalization(nmr_dataset_rds, output_dir = output_dir)
Bootstrap plot predictions
plot_bootstrap_multimodel(bp_results, dataset, y_column, plot = TRUE)
plot_bootstrap_multimodel(bp_results, dataset, y_column, plot = TRUE)
bp_results |
bp_kfold_VIP_analysis results |
dataset |
An nmr_dataset_family object |
y_column |
A string with the name of the y column (present in the metadata of the dataset) |
plot |
A boolean that indicate if results are plotted or not |
A plot of the results or a ggplot object
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation # bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analized # y_column = "Condition", # Label # k = 3, # nbootstrap = 10) # message("Selected VIPs are: ", bp_results$importarn_vips) # plot_bootstrap_multimodel(bp_results, peak_table, "Condition")
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation # bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analized # y_column = "Condition", # Label # k = 3, # nbootstrap = 10) # message("Selected VIPs are: ", bp_results$importarn_vips) # plot_bootstrap_multimodel(bp_results, peak_table, "Condition")
Plots in WebGL
plot_interactive(plt, html_filename, overwrite = NULL)
plot_interactive(plt, html_filename, overwrite = NULL)
plt |
A plot created with plotly or ggplot2 |
html_filename |
The file name where the plot will be saved |
overwrite |
Overwrite the lib/ directory (use |
The html_filename
Other plotting functions:
plot.nmr_dataset_1D()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # plot <- plot(dataset_1D) # html_plot_interactive <- plot_interactive(plot, "html_plot_interactive.html")
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # plot <- plot(dataset_1D) # html_plot_interactive <- plot_interactive(plot, "html_plot_interactive.html")
Multi PLDSA model plot predictions
plot_plsda_multimodel(model, plot = TRUE)
plot_plsda_multimodel(model, plot = TRUE)
model |
A nmr_data_analysis_model |
plot |
A boolean that indicate if results are plotted or not |
A plot of the results or a ggplot object
#' # Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 1) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 2, test_size = 0.25), internal_val = list(iterations = 2, test_size = 0.25), data_analysis_method = methodology ) # plot_plsda_multimodel(model)
#' # Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 1) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 2, test_size = 0.25), internal_val = list(iterations = 2, test_size = 0.25), data_analysis_method = methodology ) # plot_plsda_multimodel(model)
Plot PLSDA predictions
plot_plsda_samples(model, newdata = NULL, plot = TRUE)
plot_plsda_samples(model, newdata = NULL, plot = TRUE)
model |
A plsda model |
newdata |
newdata to predict, if not included model$X_test will be used |
plot |
A boolean that indicate if results are plotted or not |
A plot of the samples or a ggplot object
#' # Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 1) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 1, test_size = 0.25), data_analysis_method = methodology ) # plot_plsda_samples(model$outer_cv_results[[1]]$model)
#' # Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 1) model <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 1, test_size = 0.25), data_analysis_method = methodology ) # plot_plsda_samples(model$outer_cv_results[[1]]$model)
Plot vip scores of bootstrap
plot_vip_scores(vip_means, error, nbootstrap, plot = TRUE)
plot_vip_scores(vip_means, error, nbootstrap, plot = TRUE)
vip_means |
vips means values of bootstraps |
error |
error tolerated, calculated in the bootstrap |
nbootstrap |
number of bootstraps realiced |
plot |
A boolean that indicate if results are plotted or not |
A plot of the results or a ggplot object
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation # bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analized # y_column = "Condition", # Label # k = 3, # ncomp = 1, # nbootstrap = 10) # message("Selected VIPs are: ", bp_results$importarn_vips) # plot_vip_scores(bp_results$kfold_results[[1]]$vip_means, # bp_results$kfold_results[[1]]$error[1], # nbootstrap = 10)
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 64 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use bootstrap and permutation method for VIPs selection ## in a a k-fold cross validation # bp_results <- bp_kfold_VIP_analysis(peak_table, # Data to be analized # y_column = "Condition", # Label # k = 3, # ncomp = 1, # nbootstrap = 10) # message("Selected VIPs are: ", bp_results$importarn_vips) # plot_vip_scores(bp_results$kfold_results[[1]]$vip_means, # bp_results$kfold_results[[1]]$error[1], # nbootstrap = 10)
Uses WebGL for performance
plot_webgl(nmr_dataset, html_filename, overwrite = NULL, ...)
plot_webgl(nmr_dataset, html_filename, overwrite = NULL, ...)
nmr_dataset |
|
html_filename |
The output HTML filename to be created |
overwrite |
Overwrite the lib/ directory (use |
... |
Arguments passed on to
|
the html filename created
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # html_plot <- plot_webgl(dataset_1D, "html_plot.html")
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # html_plot <- plot_webgl(dataset_1D, "html_plot.html")
Plot an nmr_dataset_1D
## S3 method for class 'nmr_dataset_1D' plot( x, NMRExperiment = NULL, chemshift_range = NULL, interactive = FALSE, quantile_plot = NULL, quantile_colors = NULL, ... )
## S3 method for class 'nmr_dataset_1D' plot( x, NMRExperiment = NULL, chemshift_range = NULL, interactive = FALSE, quantile_plot = NULL, quantile_colors = NULL, ... )
x |
a nmr_dataset_1D object |
NMRExperiment |
A character vector with the NMRExperiments to include. Use "all" to include all experiments. |
chemshift_range |
range of the chemical shifts to be included. Can be of length 3
to include the resolution in the third element (e.g. |
interactive |
if |
quantile_plot |
If |
quantile_colors |
A vector with the colors for each of the quantiles |
... |
arguments passed to ggplot2::aes (or to ggplot2::aes_string, being deprecated). |
The plot
Other plotting functions:
plot_interactive()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # plot(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") # dataset <- nmr_read_samples_dir(dir_to_demo_dataset) # dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) # plot(dataset_1D)
Compare PLSDA auroc VIP results
plsda_auroc_vip_compare(...)
plsda_auroc_vip_compare(...)
... |
Results of nmr_data_analysis to be combined. Give each result a name. |
A plot of the AUC for each method
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 1) model1 <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 1, test_size = 0.25), data_analysis_method = methodology ) methodology2 <- plsda_auroc_vip_method(ncomp = 2) model2 <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 1, test_size = 0.25), data_analysis_method = methodology2 ) plsda_auroc_vip_compare(model1 = model1, model2 = model2)
# Data analysis for a table of integrated peaks ## Generate an artificial nmr_dataset_peak_table: ### Generate artificial metadata: num_samples <- 32 # use an even number in this example num_peaks <- 20 metadata <- data.frame( NMRExperiment = as.character(1:num_samples), Condition = rep(c("A", "B"), times = num_samples / 2) ) ### The matrix with peaks peak_means <- runif(n = num_peaks, min = 300, max = 600) peak_sd <- runif(n = num_peaks, min = 30, max = 60) peak_matrix <- mapply(function(mu, sd) rnorm(num_samples, mu, sd), mu = peak_means, sd = peak_sd ) colnames(peak_matrix) <- paste0("Peak", 1:num_peaks) ## Artificial differences depending on the condition: peak_matrix[metadata$Condition == "A", "Peak2"] <- peak_matrix[metadata$Condition == "A", "Peak2"] + 70 peak_matrix[metadata$Condition == "A", "Peak6"] <- peak_matrix[metadata$Condition == "A", "Peak6"] - 60 ### The nmr_dataset_peak_table peak_table <- new_nmr_dataset_peak_table( peak_table = peak_matrix, metadata = list(external = metadata) ) ## We will use a double cross validation, splitting the samples with random ## subsampling both in the external and internal validation. ## The classification model will be a PLSDA, exploring at maximum 3 latent ## variables. ## The best model will be selected based on the area under the ROC curve methodology <- plsda_auroc_vip_method(ncomp = 1) model1 <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 1, test_size = 0.25), data_analysis_method = methodology ) methodology2 <- plsda_auroc_vip_method(ncomp = 2) model2 <- nmr_data_analysis( peak_table, y_column = "Condition", identity_column = NULL, external_val = list(iterations = 1, test_size = 0.25), internal_val = list(iterations = 1, test_size = 0.25), data_analysis_method = methodology2 ) plsda_auroc_vip_compare(model1 = model1, model2 = model2)
Method for nmr_data_analysis (PLSDA model with AUROC and VIP outputs)
plsda_auroc_vip_method(ncomp, auc_increment_threshold = 0.05)
plsda_auroc_vip_method(ncomp, auc_increment_threshold = 0.05)
ncomp |
Max. number of latent variables to explore in the PLSDA analysis |
auc_increment_threshold |
Choose the number of latent variables when the AUC does not increment more than this threshold. |
Returns an object to be used with nmr_data_analysis to perform a (optionally multilevel) PLS-DA model, using the area under the ROC curve as figure of merit to determine the optimum number of latent variables.
method <- plsda_auroc_vip_method(3)
method <- plsda_auroc_vip_method(3)
A wrapper to unlist the output from the function
nmr_ppm_resolution(nmr_dataset)
when no interpolation has been applied.
ppm_resolution(nmr_dataset)
ppm_resolution(nmr_dataset)
nmr_dataset |
An object containing NMR samples |
A number (the ppm resolution, measured in ppms)
Numeric (the ppm resolution, measured in ppms)
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset)
nmr_dataset <- nmr_dataset_load(system.file("extdata", "nmr_dataset.rds", package = "AlpsNMR")) nmr_ppm_resolution(nmr_dataset)
Print for nmr_dataset
## S3 method for class 'nmr_dataset' print(x, ...)
## S3 method for class 'nmr_dataset' print(x, ...)
x |
an nmr_dataset object |
... |
for future use |
Print for nmr_dataset
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) print(dataset)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) print(dataset)
print for nmr_dataset_1D
## S3 method for class 'nmr_dataset_1D' print(x, ...)
## S3 method for class 'nmr_dataset_1D' print(x, ...)
x |
an nmr_dataset_1D object |
... |
for future use |
print for nmr_dataset_1D
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
Other nmr_dataset_1D functions:
[.nmr_dataset_1D()
,
format.nmr_dataset_1D()
,
get_integration_with_metadata()
,
is.nmr_dataset_1D()
,
nmr_integrate_peak_positions()
,
nmr_integrate_regions()
,
nmr_meta_add()
,
nmr_meta_export()
,
nmr_meta_get()
,
nmr_meta_get_column()
,
nmr_ppm_resolution()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) print(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) print(dataset_1D)
print for nmr_dataset_peak_table
## S3 method for class 'nmr_dataset_peak_table' print(x, ...)
## S3 method for class 'nmr_dataset_peak_table' print(x, ...)
x |
an nmr_dataset_peak_table object |
... |
for future use |
print for nmr_dataset_peak_table
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) new
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) new <- new_nmr_dataset_peak_table(peak_table, metadata) new
Random subsampling
random_subsampling( sample_idx, iterations = 10L, test_size = 0.25, keep_together = NULL, balance_in_train = NULL )
random_subsampling( sample_idx, iterations = 10L, test_size = 0.25, keep_together = NULL, balance_in_train = NULL )
sample_idx |
Typically a numeric vector with sample index to be separated. A character vector with sample IDs could also be used |
iterations |
An integer, the number of iterations in the random subsampling |
test_size |
A number between 0 and 1. The samples to be included in the test set on each interation. |
keep_together |
Either |
balance_in_train |
Either |
A list of length equal to iterations
. Each element of the list is
a list with two entries (training
and test
) containing the sample_idx
values that will belong to each subset.
random_subsampling(1:100, iterations = 4, test_size = 0.25) subject_id <- c("Alice", "Bob", "Charlie", "Eve") random_subsampling(1:4, iterations = 2, test_size = 0.25, keep_together = subject_id)
random_subsampling(1:100, iterations = 4, test_size = 0.25) subject_id <- c("Alice", "Bob", "Charlie", "Eve") random_subsampling(1:4, iterations = 2, test_size = 0.25, keep_together = subject_id)
The template ROI_blood contains the targeted list of metabolites to be quantified (blood samples)
github.com/danielcanueto/rDolphin
data("ROI_blood") ROI_blood[ROI_blood$Metabolite == "Valine", ]
data("ROI_blood") ROI_blood[ROI_blood$Metabolite == "Valine", ]
The template ROI_cell contains the targeted list of metabolites to be quantified (cell samples)
github.com/danielcanueto/rDolphin
data("ROI_cell") ROI_cell[ROI_cell$Metabolite == "Valine", ]
data("ROI_cell") ROI_cell[ROI_cell$Metabolite == "Valine", ]
The template ROI_urine contains the targeted list of metabolites to be quantified (urine samples)
github.com/danielcanueto/rDolphin
data("ROI_urine") ROI_urine[ROI_urine$Metabolite == "Valine", ]
data("ROI_urine") ROI_urine[ROI_urine$Metabolite == "Valine", ]
The function saves the CSV files required by to_rDolphin and Automatic_targeted_profiling functions for metabolite profiling.
save_files_to_rDolphin(files_rDolphin, output_directory)
save_files_to_rDolphin(files_rDolphin, output_directory)
files_rDolphin |
a list containing 4 elements from
|
output_directory |
a directory in which the CSV files are saved |
CSV files containing:
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_profiling_output()
,
to_ChemoSpec()
## Not run: dataset <- system.file("dataset-demo", package = "AlpsNMR") excel_file <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dataset) files_rDolphin <- files_to_rDolphin_blood(nmr_dataset) save_files_to_rDolphin(files_rDolphin, output_directory = ".") ## End(Not run)
## Not run: dataset <- system.file("dataset-demo", package = "AlpsNMR") excel_file <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") nmr_dataset <- nmr_read_samples_dir(dataset) files_rDolphin <- files_to_rDolphin_blood(nmr_dataset) save_files_to_rDolphin(files_rDolphin, output_directory = ".") ## End(Not run)
The function saves the output from Automatic_targeted_profiling function in CSV format.
save_profiling_output(targeted_profiling, output_directory)
save_profiling_output(targeted_profiling, output_directory)
targeted_profiling |
A list from Automatic_targeted_profiling function |
output_directory |
a directory in which the CSV files are saved |
rDolphin output from Automatic_targeted_profiling function:
metabolites_intensity
metabolites_quantification
ROI_profiles_used
chemical_shift
fitting_error
half_bandwidth
signal_area_ratio
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
to_ChemoSpec()
## Not run: rDolphin_object <- to_rDolphin(parameters) targeted_profiling <- Automatic_targeted_profiling(rDolphin) save_profiling_output(targeted_profiling, output_directory) ## End(Not run)
## Not run: rDolphin_object <- to_rDolphin(parameters) targeted_profiling <- Automatic_targeted_profiling(rDolphin) save_profiling_output(targeted_profiling, output_directory) ## End(Not run)
Import SummarizedExperiment as 1D NMR data
SummarizedExperiment_to_nmr_data_1r(se)
SummarizedExperiment_to_nmr_data_1r(se)
se |
An SummarizedExperiment object |
nmr_dataset An nmr_dataset_1D object (unmodified)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) se <- nmr_data_1r_to_SummarizedExperiment(dataset_1D) dataset_1D <- SummarizedExperiment_to_nmr_data_1r(se)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) se <- nmr_data_1r_to_SummarizedExperiment(dataset_1D) dataset_1D <- SummarizedExperiment_to_nmr_data_1r(se)
Import SummarizedExperiment as mr_dataset_peak_table
SummarizedExperiment_to_nmr_dataset_peak_table(se)
SummarizedExperiment_to_nmr_dataset_peak_table(se)
se |
An SummarizedExperiment object |
nmr_dataset_peak_table An nmr_dataset_peak_table object (unmodified)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) nmr_peak_table <- new_nmr_dataset_peak_table(peak_table, metadata) se <- nmr_dataset_peak_table_to_SummarizedExperiment(nmr_peak_table) nmr_peak_table <- SummarizedExperiment_to_nmr_dataset_peak_table(se)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) meta <- file.path(dir_to_demo_dataset, "dummy_metadata.xlsx") metadata <- readxl::read_excel(meta, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, metadata = metadata, by = "NMRExperiment") metadata <- list(external = dataset_1D[["metadata"]][["external"]]) peak_table <- nmr_data(dataset_1D) nmr_peak_table <- new_nmr_dataset_peak_table(peak_table, metadata) se <- nmr_dataset_peak_table_to_SummarizedExperiment(nmr_peak_table) nmr_peak_table <- SummarizedExperiment_to_nmr_dataset_peak_table(se)
This dataframe is useful for plotting with ggplot, although it may be very long and therefore use a lot of RAM.
## S3 method for class 'nmr_dataset_1D' tidy( x, NMRExperiment = NULL, chemshift_range = NULL, columns = character(0L), matrix_name = "data_1r", axis_name = "axis", ... )
## S3 method for class 'nmr_dataset_1D' tidy( x, NMRExperiment = NULL, chemshift_range = NULL, columns = character(0L), matrix_name = "data_1r", axis_name = "axis", ... )
x |
an |
NMRExperiment |
A character vector with the NMRExperiments to include. |
chemshift_range |
range of the chemical shifts to be included. Can be of length 3
to include the resolution in the third element (e.g. |
columns |
A character vector with the metadata columns to get, use |
matrix_name |
A string with the matrix name, typically "data_1r" |
axis_name |
A string with the axis name, for now "axis" is the only valid option |
... |
Ignored |
A data frame with NMRExperiment
, chemshift
, intensity
and any additional column requested
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -1.0, max = 1.6, by = 2.3E-4)) dummy_metadata <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") NMRExp_SubjID <- readxl::read_excel(dummy_metadata, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, NMRExp_SubjID) df_for_ggplot <- tidy(dataset_1D, chemshift_range = c(1.2, 1.4), columns = "SubjectID") head(df_for_ggplot)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -1.0, max = 1.6, by = 2.3E-4)) dummy_metadata <- system.file("dataset-demo", "dummy_metadata.xlsx", package = "AlpsNMR") NMRExp_SubjID <- readxl::read_excel(dummy_metadata, sheet = 1) dataset_1D <- nmr_meta_add(dataset_1D, NMRExp_SubjID) df_for_ggplot <- tidy(dataset_1D, chemshift_range = c(1.2, 1.4), columns = "SubjectID") head(df_for_ggplot)
Exports the spectra matrix, sample names and chemical shift axis into an ASICS Spectra object.
to_ASICS(dataset, ...)
to_ASICS(dataset, ...)
dataset |
An nmr_dataset_1D object |
... |
Arguments passed on to
|
An ASICS::Spectra object
if (requireNamespace("ASICS", quietly=TRUE)) { nsamp <- 3 npoints <- 300 metadata <- list(external = data.frame( NMRExperiment = paste0("Sample", seq_len(nsamp)) )) dataset <- new_nmr_dataset_1D( ppm_axis = seq(from = 0.2, to = 10, length.out = npoints), data_1r = matrix(runif(nsamp * npoints), nrow = nsamp, ncol = npoints), metadata = metadata ) forAsics <- to_ASICS(dataset) #ASICS::ASICS(forAsics) }
if (requireNamespace("ASICS", quietly=TRUE)) { nsamp <- 3 npoints <- 300 metadata <- list(external = data.frame( NMRExperiment = paste0("Sample", seq_len(nsamp)) )) dataset <- new_nmr_dataset_1D( ppm_axis = seq(from = 0.2, to = 10, length.out = npoints), data_1r = matrix(runif(nsamp * npoints), nrow = nsamp, ncol = npoints), metadata = metadata ) forAsics <- to_ASICS(dataset) #ASICS::ASICS(forAsics) }
Convert to ChemoSpec Spectra class
to_ChemoSpec(nmr_dataset, desc = "A nmr_dataset", group = NULL)
to_ChemoSpec(nmr_dataset, desc = "A nmr_dataset", group = NULL)
nmr_dataset |
An nmr_dataset_1D object |
desc |
a description for the dataset |
group |
A string with the column name from the metadata that has grouping information |
A Spectra object from the ChemoSpec package
Other import/export functions:
Pipelines
,
files_to_rDolphin()
,
load_and_save_functions
,
nmr_data()
,
nmr_meta_export()
,
nmr_read_bruker_fid()
,
nmr_read_samples()
,
nmr_zip_bruker_samples()
,
save_files_to_rDolphin()
,
save_profiling_output()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) chemo_spectra <- to_ChemoSpec(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) chemo_spectra <- to_ChemoSpec(dataset_1D)
Validate nmr_dataset objects
Validate 1D nmr datasets
validate_nmr_dataset(samples) validate_nmr_dataset_1D(nmr_dataset_1D)
validate_nmr_dataset(samples) validate_nmr_dataset_1D(nmr_dataset_1D)
samples |
An nmr_dataset object |
nmr_dataset_1D |
An nmr_dataset_1D object |
Validate nmr_dataset objects
The nmr_dataset_1D unchanged
This function is useful for its side-effects. Stopping in case of error
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset_family()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) validate_nmr_dataset(dataset) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) dataset_1D_validated <- validate_nmr_dataset_1D(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) validate_nmr_dataset(dataset) dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) dataset_1D_validated <- validate_nmr_dataset_1D(dataset_1D)
Validate nmr_dataset_family objects
validate_nmr_dataset_family(nmr_dataset_family)
validate_nmr_dataset_family(nmr_dataset_family)
nmr_dataset_family |
An nmr_dataset_family object |
The nmr_dataset_family unchanged
This function is useful for its side-effects: Stopping in case of error
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_peak_table()
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) validate_nmr_dataset_family(dataset_1D)
dir_to_demo_dataset <- system.file("dataset-demo", package = "AlpsNMR") dataset <- nmr_read_samples_dir(dir_to_demo_dataset) dataset_1D <- nmr_interpolate_1D(dataset, axis = c(min = -0.5, max = 10, by = 2.3E-4)) validate_nmr_dataset_family(dataset_1D)
Validate nmr_dataset_peak_table objects
validate_nmr_dataset_peak_table(nmr_dataset_peak_table)
validate_nmr_dataset_peak_table(nmr_dataset_peak_table)
nmr_dataset_peak_table |
An nmr_dataset_peak_table object |
The nmr_dataset_peak_table unchanged
Other class helper functions:
format.nmr_dataset()
,
format.nmr_dataset_1D()
,
format.nmr_dataset_peak_table()
,
is.nmr_dataset_1D()
,
is.nmr_dataset_peak_table()
,
new_nmr_dataset()
,
new_nmr_dataset_1D()
,
new_nmr_dataset_peak_table()
,
print.nmr_dataset()
,
print.nmr_dataset_1D()
,
print.nmr_dataset_peak_table()
,
validate_nmr_dataset()
,
validate_nmr_dataset_family()
pt <- new_nmr_dataset_peak_table( peak_table = matrix(c(1, 2), nrow = 1, dimnames = list("10", c("ppm_1.4", "ppm_1.6"))), metadata = list(external = data.frame(NMRExperiment = "10")) ) pt_validated <- validate_nmr_dataset_peak_table(pt)
pt <- new_nmr_dataset_peak_table( peak_table = matrix(c(1, 2), nrow = 1, dimnames = list("10", c("ppm_1.4", "ppm_1.6"))), metadata = list(external = data.frame(NMRExperiment = "10")) ) pt_validated <- validate_nmr_dataset_peak_table(pt)