# HG changeset patch # User galaxyp # Date 1550243610 18000 # Node ID aa81463e21ea02b49bf0614c2fee9fb295c31838 # Parent 3f3812d36027bd9b951e7ef78eb80e6d0a79a890 planemo upload for repository https://github.com/galaxyproteomics/tools-galaxyp/tree/master/tools/MALDIquant commit f127be2141cf22e269c85282d226eb16fe14a9c1 diff -r 3f3812d36027 -r aa81463e21ea maldi_macros.xml --- a/maldi_macros.xml Thu Oct 25 07:23:20 2018 -0400 +++ b/maldi_macros.xml Fri Feb 15 10:13:30 2019 -0500 @@ -18,11 +18,12 @@ - bioconductor-cardinal + r-base + bioconductor-cardinal r-maldiquantforeign r-maldiquant - r-ggplot2 - r-gridextra + r-ggplot2 + r-gridextra diff -r 3f3812d36027 -r aa81463e21ea maldi_quant_preprocessing.xml --- a/maldi_quant_preprocessing.xml Thu Oct 25 07:23:20 2018 -0400 +++ b/maldi_quant_preprocessing.xml Fri Feb 15 10:13:30 2019 -0500 @@ -1,671 +1,703 @@ - - - Preprocessing of mass-spectrometry imaging data - - - maldi_macros.xml - - - - $outfile_imzml && - ls -l "$outfile_imzml.files_path" >> $outfile_imzml - ]]> - - - 20 && number_combined<40){ - legend_size = 9 - }else if (number_combined>40 && number_combined<60){ - legend_size = 8 - }else if (number_combined>60 && number_combined<100){ - legend_size = 7 - }else{ - legend_size = 6 - } - - combine_plot = ggplot(merged_annotation, aes(x=x, y=y, fill=annotation))+ - geom_tile() + - coord_fixed()+ - ggtitle("Spatial orientation of annotated data")+ - theme_bw()+ - theme(plot.title = element_text(hjust = 0.5))+ - theme(text=element_text(family="ArialMT", face="bold", size=12))+ - theme(legend.position="bottom",legend.direction="vertical")+ - theme(legend.key.size = unit(0.2, "line"), legend.text = element_text(size = legend_size))+ - guides(fill=guide_legend(ncol=5,byrow=TRUE)) - - print(combine_plot) - -#end if - -#################### Preprocessing methods ##################################### - -## QC plot on input file -avgSpectra = averageMassSpectra(maldi_data,method="mean") -plot(avgSpectra, main="Average spectrum for input file") - -pixel_number = length(maldi_data) -minmz = round(min(unlist(lapply(maldi_data,mass))), digits=4) -maxmz = round(max(unlist(lapply(maldi_data,mass))), digits=4) -mean_features = round(length(unlist(lapply(maldi_data,mass)))/length(maldi_data), digits=2) -number_features = length(unique(unlist(lapply(maldi_data,mass)))) -medint = round(median(unlist(lapply(maldi_data,intensity))), digits=2) -inputdata = c(minmz, maxmz,number_features,mean_features, medint) -QC_numbers= data.frame(inputdata = c(minmz, maxmz,number_features, mean_features, medint)) -vectorofactions = "inputdata" - - -#for $method in $methods: - - #if str( $method.methods_conditional.method ) == 'Transformation': - - print('transforming') - ##transformation - maldi_data = transformIntensity(maldi_data, method="$method.methods_conditional.transform_method") - ## QC plot and numbers - avgSpectra = averageMassSpectra(maldi_data,method="mean") - plot(avgSpectra, main="Average spectrum after transformation") - pixel_number = length(maldi_data) - minmz = round(min(unlist(lapply(maldi_data,mass))), digits=4) - maxmz = round(max(unlist(lapply(maldi_data,mass))), digits=4) - mean_features = round(length(unlist(lapply(maldi_data,mass)))/length(maldi_data), digits=2) - medint = round(median(unlist(lapply(maldi_data,intensity))), digits=2) - number_features = length(unique(unlist(lapply(maldi_data,mass)))) - transformed = c(minmz, maxmz,number_features,mean_features, medint) - QC_numbers= cbind(QC_numbers, transformed) - vectorofactions = append(vectorofactions, "transformed") - - - #elif str( $method.methods_conditional.method ) == 'Smoothing': - - print('smoothing') - ##smoothing - - #if str($method.methods_conditional.methods_for_smoothing.smooth_method ) == 'SavitzkyGolay': - print('SavitzkyGolay') - - maldi_data = smoothIntensity(maldi_data, - method="SavitzkyGolay", polynomialOrder=$method.methods_conditional.methods_for_smoothing.polynomial, - halfWindowSize=$method.methods_conditional.halfWindowSize) - - #elif str($method.methods_conditional.methods_for_smoothing.smooth_method ) == 'MovingAverage': - print('MovingAverage') - - maldi_data = smoothIntensity(maldi_data, - method="MovingAverage", weighted=$method.methods_conditional.methods_for_smoothing.weighted, - halfWindowSize=$method.methods_conditional.halfWindowSize) - - #end if - - ## QC plot and numbers - avgSpectra = averageMassSpectra(maldi_data,method="mean") - plot(avgSpectra, main="Average spectrum after smoothing", sub="") - pixel_number = length(maldi_data) - minmz = round(min(unlist(lapply(maldi_data,mass))), digits=4) - maxmz = round(max(unlist(lapply(maldi_data,mass))), digits=4) - mean_features = round(length(unlist(lapply(maldi_data,mass)))/length(maldi_data), digits=2) - medint = round(median(unlist(lapply(maldi_data,intensity))), digits=2) - number_features = length(unique(unlist(lapply(maldi_data,mass)))) - smoothed = c(minmz, maxmz,number_features,mean_features, medint) - QC_numbers= cbind(QC_numbers, smoothed) - vectorofactions = append(vectorofactions, "smoothed") - - - #elif str( $method.methods_conditional.method ) == 'Baseline': - - print('baseline removing') - ## Remove baseline - - #if str($method.methods_conditional.methods_for_baseline.baseline_method ) == 'SNIP': - print('SNIP') - random_spectra = sample(1:length(maldi_data), 4, replace=FALSE) - par(mfrow = c(2,2)) - for (random_sample in random_spectra){ - maldi_data_baseline = estimateBaseline(maldi_data[[random_sample]], - method="SNIP", iterations=$method.methods_conditional.methods_for_baseline.iterations) - plot(maldi_data[[random_sample]], sub="", main=paste0("Estimated baseline for spectrum ", random_sample)) - lines(maldi_data_baseline, col="blue", lwd=2)} - - maldi_data = removeBaseline(maldi_data, - method="SNIP", - iterations=$method.methods_conditional.methods_for_baseline.iterations) - - #elif str($method.methods_conditional.methods_for_baseline.baseline_method ) == 'TopHat': - print('TopHat') - - maldi_data = removeBaseline(maldi_data, - method="TopHat", - halfWindowSize=$method.methods_conditional.methods_for_baseline.tophat_halfWindowSize) - - #elif str($method.methods_conditional.methods_for_baseline.baseline_method ) == 'ConvexHull': - print('ConvexHull') - - maldi_data = removeBaseline(maldi_data, - method="ConvecHull") - - #elif str($method.methods_conditional.methods_for_baseline.baseline_method ) == 'median': - print('median') - - maldi_data = removeBaseline(maldi_data, - method="TopHat", - halfWindowSize=$method.methods_conditional.methods_for_baseline.median_halfWindowSize) - - #end if - - ## QC plot and numbers - par(mfrow = c(1,1)) - avgSpectra = averageMassSpectra(maldi_data,method="mean") - plot(avgSpectra, main="Average spectrum after baseline removal") - pixel_number = length(maldi_data) - minmz = round(min(unlist(lapply(maldi_data,mass))), digits=4) - maxmz = round(max(unlist(lapply(maldi_data,mass))), digits=4) - mean_features = round(length(unlist(lapply(maldi_data,mass)))/length(maldi_data), digits=2) - medint = round(median(unlist(lapply(maldi_data,intensity))), digits=2) - number_features = length(unique(unlist(lapply(maldi_data,mass)))) - baseline_removed = c(minmz, maxmz,number_features,mean_features, medint) - QC_numbers= cbind(QC_numbers, baseline_removed) - vectorofactions = append(vectorofactions, "baseline_removed") - - - #elif str( $method.methods_conditional.method ) == 'Calibrate': - - print('calibrate') - ##calibrate - - #if str($method.methods_conditional.cond_calibration_range) == "yes": - ## calibrate only given m/z range - maldi_data = calibrateIntensity(maldi_data, - method="$method.methods_conditional.calibrate_method", - range=c($method.methods_conditional.cond_calibration_range.mass_start, $method.methods_conditional.cond_calibration_range.mass_end)) - #else: - maldi_data = calibrateIntensity(maldi_data, - method="$method.methods_conditional.calibrate_method") - #end if - ## QC plot and numbers - avgSpectra = averageMassSpectra(maldi_data,method="mean") - plot(avgSpectra, main="Average spectrum after normalization") - pixel_number = length(maldi_data) - minmz = round(min(unlist(lapply(maldi_data,mass))), digits=4) - maxmz = round(max(unlist(lapply(maldi_data,mass))), digits=4) - mean_features = round(length(unlist(lapply(maldi_data,mass)))/length(maldi_data), digits=2) - medint = round(median(unlist(lapply(maldi_data,intensity))), digits=2) - number_features = length(unique(unlist(lapply(maldi_data,mass)))) - intensity_calibrated = c(minmz, maxmz,number_features,mean_features, medint) - QC_numbers= cbind(QC_numbers, intensity_calibrated) - vectorofactions = append(vectorofactions, "intensity_calibrated ") - - - #elif str( $method.methods_conditional.method ) == 'Align': - - print('align') - ##align spectra - - #if str($method.methods_conditional.reference_for_alignment.align_ref) == 'no_reference': - maldi_data = alignSpectra(maldi_data, halfWindowSize=$method.methods_conditional.halfWindowSize, - SNR=$method.methods_conditional.snr, tolerance=$method.methods_conditional.tolerance, - allowNoMatches =$method.methods_conditional.allow_nomatch, emptyNoMatches = $method.methods_conditional.empty_nomatch, - warpingMethod="$method.methods_conditional.warping_method") - - #elif str($method.methods_conditional.reference_for_alignment.align_ref) == 'yes_reference': - ## create reference mass_vector from tabular file - mass_vector = read.delim("$method.methods_conditional.reference_for_alignment.reference_file", header = $method.methods_conditional.reference_for_alignment.reference_header, stringsAsFactors = FALSE)[,1] - int_vector = rep(1,length(mass_vector)) - mass_list = createMassPeaks(mass_vector, int_vector) - - maldi_data = alignSpectra(maldi_data, halfWindowSize=$method.methods_conditional.halfWindowSize, - SNR=$method.methods_conditional.snr, - tolerance=$method.methods_conditional.tolerance, - warpingMethod="$method.methods_conditional.warping_method", - reference = mass_list, allowNoMatches =$method.methods_conditional.allow_nomatch, emptyNoMatches = $method.methods_conditional.empty_nomatch) - - #end if - - #if $method.methods_conditional.remove_empty: - print("remove empty spectra") - - #if $infile.ext == 'rdata' - cardinal_coordinates = cardinal_coordinates[-findEmptyMassObjects(maldi_data),] ## remove coordinates of empty spectra for Cardinal RData input - #end if - #if str($tabular_annotation.load_annotation) == 'yes_annotation': - merged_annotation = merged_annotation[-findEmptyMassObjects(maldi_data),] ## remove coordinate annotations for empty spectra - #end if - maldi_data = removeEmptyMassObjects(maldi_data) - #end if - - - ## QC plot - - if (length(maldi_data)>0){ - avgSpectra = averageMassSpectra(maldi_data,method="mean") - plot(avgSpectra, main="Average spectrum after alignment") - }else{"All spectra are empty"} - - pixel_number = length(maldi_data) - minmz = round(min(unlist(lapply(maldi_data,mass))), digits=4) - maxmz = round(max(unlist(lapply(maldi_data,mass))), digits=4) - mean_features = round(length(unlist(lapply(maldi_data,mass)))/length(maldi_data), digits=2) - medint = round(median(unlist(lapply(maldi_data,intensity))), digits=2) - number_features = length(unique(unlist(lapply(maldi_data,mass)))) - spectra_aligned = c(minmz, maxmz,number_features,mean_features, medint) - QC_numbers= cbind(QC_numbers, spectra_aligned) - vectorofactions = append(vectorofactions, "spectra_aligned") - #end if - -#end for - -rownames(QC_numbers) = c("min m/z", "max mz", "# features", "median \n# features", "median\nintensity") -plot(0,type='n',axes=FALSE,ann=FALSE) -grid.table(t(QC_numbers)) - -dev.off() - -## export imzML file -if (length(maldi_data)>0){ - #if $infile.ext == 'rdata' - MALDIquantForeign::exportImzMl(maldi_data, file="out.imzMl", processed=$export_processed, coordinates=cardinal_coordinates) - #else - MALDIquantForeign::exportImzMl(maldi_data, file="out.imzMl", processed=$export_processed) - #end if - -}else{"All spectra are empty, outputfiles will be empty,too."} - - ]]> - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - `_ - - Cardinal "MSImageSet" data saved as .RData -- Only for Cardinal RData files and when remove empty spectra is chosen: Tabular file with coordinates annotations. Separate columns for x and y coordinates and a third column with pixel annotations. Tabular files with any header name or no header at all are supported -- Optional: Tabular file with pixel coordinates to restrict reading of imzML files to coordinates of interest. The file has to contain x values in the first column and y values in the second columns. Further columns are allowed. Tabular files with any header name or no header at all are supported. - - :: - - x_coord y_coord - 1 1 - 2 1 - 3 1 - ... - ... - -- Optional: Tabular file with reference m/z for the spectra align function. At least 2 m/z values of the input list must be present in every spectrum to peform the alignment. First column must contain m/z values, without empty fields or letters. Tabular files with any header name or no header at all are supported. - - :: - - - m/z - 100.0 - 100.01 - 100.02 - ... - ... - - - -**Options** - -- Transformation: Variance stabilization through intensity transformation:'log', 'log2', 'log10' and 'squareroot' (sqrt) are available -- Smoothing: Smoothing of the peaks reduces noise and improves peak detection. Available smoothing methods are 'SavitzkyGolay' and 'Moving Average' - - - For all smoothing methods: The larger the 'Half window size'f, the stronger the smoothing. The resulting window should be smaller than the FWHM (full width at half maximum) of the typical peaks. Moving average needs smaller window size than SavitzkyGolay. - - Moving average: Recommended for broader peaks/high m/z range spectra. Weighted moving average: Points in the center get larger weight factors than points away from the center. - - SavitzkyGolay: Recommended for sharp peaks/low m/z range, preserves the shape of the local maxima. The PolynomialOrder should be smaller than the resulting window. Negative values will be replaced with 0. - -- Baseline reduction: Baseline reduction removes background intensity generated by chemical noise (common in MALDI datasets). - - - Available methods are SNIP, TopHat,ConvexHull and median: - - SNIP is the default baseline reduction method in MALDIquant. - - ConvexHull is not appropriate for MALDI-TOF baseline removal. - - The moving median may generate negative intensities. - - Except for the ConvexHull all methods have a parameter for the 'Half window size' (in SNIP it is called 'iterations'). The smaller the window the more baseline will be removed but also parts of the peaks. Wider windows preserve the peak height better and produce a smoother baseline, but some local background variation will remain. - -- Intensity calibration (normalization): Normalization of intensities to Total Ion Current (TIC), median spectrum, Probabilistic Quotient Normalization (PQN) - - - TIC and median are local calibration methods: each spectrum is normalized on its own (each peak is divided by the TIC or median of the spectrum) - - PQN is a global calibration method: In PQN all spectra are calibrated using the TIC calibration first. Subsequently, a median reference spectrum is created and the intensities in all spectra are standardized using the reference spectrum and a spectrum-specific median is calculated for each spectrum. Finally, each spectrum is rescaled by the median of the ratios of its intensity values and that of the reference spectrum - -- Spectra alignment (warping): alignment for (re)calibration of m/z values, at least two m/z per spectrum are needed for the alignment. This requirement can be skipped by setting "Don't throw an error when less than 2 reference m/z were found in a spectrum" to yes. If the not aligned spectra should be set to zero select yes in "logical, if TRUE the intensity values of MassSpectrum or MassPeaks objects with missing (NA) warping functions are set to zero". In order to remove such empty spectra set "Should empty spectra be removed" to yes. - - -**Output** - -- imzML file (imzML format can be continuous or processed) -- PDF with average mass spectra after each preprocessing step - -.. _MALDIquant: http://strimmerlab.org/software/maldiquant/ - - ]]> - - - + + + Preprocessing of mass-spectrometry imaging data + + + maldi_macros.xml + + + + $outfile_imzml && + ls -l "$outfile_imzml.files_path" >> $outfile_imzml + ]]> + + + 0) + + { + #if $infile.ext == 'rdata' + cardinal_coordinates = cardinal_coordinates[-findEmptyMassObjects(maldi_data),,drop=FALSE] ## remove coordinates of empty spectra for Cardinal RData input + #end if + + maldi_data = removeEmptyMassObjects(maldi_data) + } + #end if + + ## QC plot + + if (length(maldi_data)>0){ + avgSpectra = averageMassSpectra(maldi_data,method="mean") + plot(avgSpectra, main="Average spectrum after alignment") + medint = round(median(unlist(lapply(maldi_data,intensity))), digits=2) + }else{print("All spectra are empty")} + + pixel_number = length(maldi_data) + minmz = round(min(unlist(lapply(maldi_data,mass))), digits=4) + maxmz = round(max(unlist(lapply(maldi_data,mass))), digits=4) + mean_features = round(length(unlist(lapply(maldi_data,mass)))/length(maldi_data), digits=2) + + number_features = length(unique(unlist(lapply(maldi_data,mass)))) + spectra_aligned = c(minmz, maxmz,number_features,mean_features, medint,pixel_number) + QC_numbers= cbind(QC_numbers, spectra_aligned) + vectorofactions = append(vectorofactions, "aligned") + + #elif str( $method.methods_conditional.method ) == 'skip_preprocessing': + ##for now as option to filter large files + + #end if + +#end for + +rownames(QC_numbers) = c("min m/z", "max mz", "# features", "median \n# peaks (int.>0)", "median\nintensity", "pixel\nnumber") +colnames(QC_numbers) = vectorofactions +plot(0,type='n',axes=FALSE,ann=FALSE) +grid.table(t(QC_numbers)) + +dev.off() + +## export imzML file +if (length(maldi_data)>0){ + #if $infile.ext == 'rdata' + MALDIquantForeign::exportImzMl(maldi_data, file="out.imzMl", processed=$export_processed, coordinates=cardinal_coordinates) + #else + MALDIquantForeign::exportImzMl(maldi_data, file="out.imzMl", processed=$export_processed) + #end if + +}else{"All spectra are empty, outputfiles will be empty,too."} + + ]]> + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + `_ + - Cardinal "MSImageSet" data saved as .RData + +- Optional: Tabular file with pixel coordinates to restrict reading of imzML files to coordinates of interest. Tabular files with any header name or no header at all are supported. + + :: + + x_coord y_coord + 1 1 + 2 1 + 3 1 + ... + ... + +- Optional: Tabular file with reference m/z for the spectra align function. At least 2 m/z values of the input list must be present in every spectrum to peform the alignment. First column must contain m/z values, without empty fields or letters. Tabular files with any header name or no header at all are supported. + + :: + + + m/z + 100.0 + 100.01 + 100.02 + ... + ... + + + +**Options** + +- Transformation: Variance stabilization through intensity transformation:'log', 'log2', 'log10' and 'squareroot' (sqrt) are available +- Smoothing: Smoothing of the peaks reduces noise and improves peak detection. Available smoothing methods are 'SavitzkyGolay' and 'Moving Average' + + - For all smoothing methods: The larger the 'Half window size', the stronger the smoothing. The resulting window should be smaller than the FWHM (full width at half maximum) of the typical peaks. Moving average needs smaller window size than SavitzkyGolay. + - Moving average: Recommended for broader peaks/high m/z range spectra. Weighted moving average: Points in the center get larger weight factors than points away from the center. + - SavitzkyGolay: Recommended for sharp peaks/low m/z range, preserves the shape of the local maxima. The PolynomialOrder should be smaller than the resulting window. Negative values will be replaced with 0. + +- Baseline reduction: Baseline reduction removes background intensity generated by chemical noise (common in MALDI datasets). + + - Available methods are SNIP, TopHat,ConvexHull and median: + - SNIP is the default baseline reduction method in MALDIquant. + - ConvexHull is not appropriate for MALDI-TOF baseline removal. + - The moving median may generate negative intensities. + - Except for the ConvexHull all methods have a parameter for the 'Half window size' (in SNIP it is called 'iterations'). The smaller the window the more baseline will be removed but also parts of the peaks. Wider windows preserve the peak height better and produce a smoother baseline, but some local background variation will remain. + +- Intensity calibration (normalization): Normalization of intensities to Total Ion Current (TIC), median spectrum, Probabilistic Quotient Normalization (PQN) + + - TIC and median are local calibration methods: each spectrum is normalized on its own (each peak is divided by the TIC or median of the spectrum) + - PQN is a global calibration method: In PQN all spectra are calibrated using the TIC calibration first. Subsequently, a median reference spectrum is created and the intensities in all spectra are standardized using the reference spectrum and a spectrum-specific median is calculated for each spectrum. Finally, each spectrum is rescaled by the median of the ratios of its intensity values and that of the reference spectrum + +- Spectra alignment (warping): alignment for (re)calibration of m/z values. + + - peak detection is performed, the reference peaks will be matched to those detected peaks + - without external reference m/z: internal reference is obtained by filtering and binning the picked peaks to find landmark peaks and their average m/z + - with external reference m/z: the given m/z are used as a reference, at least 10 reference values are recommended + - non linear warping (parametric time warping plus binning) to match the reference peaks (internal or external) to the present (picked) peaks with the given tolerance. At least two m/z per spectrum are needed for the alignment. To prevent an error when this criterium is not fullfilled, "Don't throw an error when less than 2 reference m/z were found in a spectrum" should be set to yes. If the not aligned spectra should be set to zero select yes in "If TRUE the intensity values of MassSpectrum or MassPeaks objects with missing (NA) warping functions are set to zero". In order to remove such empty spectra set "Should empty spectra be removed" to yes. + + +**Output** + +- imzML file (imzML format can be continuous or processed) +- PDF with average mass spectra after each preprocessing step + +.. _MALDIquant: http://strimmerlab.org/software/maldiquant/ + + ]]> + + + + diff -r 3f3812d36027 -r aa81463e21ea test-data/Preprocessing1_QC.pdf Binary file test-data/Preprocessing1_QC.pdf has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/Preprocessing2_QC.pdf Binary file test-data/Preprocessing2_QC.pdf has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/Preprocessing3_QC.pdf Binary file test-data/Preprocessing3_QC.pdf has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/align_reference_test2.tabular --- a/test-data/align_reference_test2.tabular Thu Oct 25 07:23:20 2018 -0400 +++ /dev/null Thu Jan 01 00:00:00 1970 +0000 @@ -1,2 +0,0 @@ -350 -340 diff -r 3f3812d36027 -r aa81463e21ea test-data/inputpeptides.tabular --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/inputpeptides.tabular Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,3 @@ +152 mass1 +328.9 mass2 +185.2 mass3 diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile1.ibd Binary file test-data/outfile1.ibd has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile1.imzML --- a/test-data/outfile1.imzML Thu Oct 25 07:23:20 2018 -0400 +++ /dev/null Thu Jan 01 00:00:00 1970 +0000 @@ -1,4 +0,0 @@ -imzML file: -total 84 --rw-r--r-- 1 meli meli 67160 Okt 24 10:12 ibd --rw-r--r-- 1 meli meli 15071 Okt 24 10:12 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile1.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/outfile1.imzml Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,243 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile2.ibd Binary file test-data/outfile2.ibd has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile2.imzML --- a/test-data/outfile2.imzML Thu Oct 25 07:23:20 2018 -0400 +++ /dev/null Thu Jan 01 00:00:00 1970 +0000 @@ -1,4 +0,0 @@ -imzML file: -total 276 --rw-r--r-- 1 meli meli 268784 Okt 24 10:12 ibd --rw-r--r-- 1 meli meli 9286 Okt 24 10:12 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile2.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/outfile2.imzml Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,118 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile3.ibd Binary file test-data/outfile3.ibd has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile3.imzML --- a/test-data/outfile3.imzML Thu Oct 25 07:23:20 2018 -0400 +++ /dev/null Thu Jan 01 00:00:00 1970 +0000 @@ -1,4 +0,0 @@ -imzML file: -total 52 --rw-r--r-- 1 meli meli 38384 Okt 24 10:13 ibd --rw-r--r-- 1 meli meli 9551 Okt 24 10:13 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/outfile3.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/outfile3.imzml Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,333 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection1.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/peak_detection1.imzml.txt Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 120 +-rw-r--r-- 1 meli meli 95936 Feb 14 17:46 ibd +-rw-r--r-- 1 meli meli 20580 Feb 14 17:46 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection2.ibd Binary file test-data/peak_detection2.ibd has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection2.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/peak_detection2.imzml Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,319 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection2.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/peak_detection2.imzml.txt Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 24 +-rw-r--r-- 1 meli meli 320 Feb 14 18:44 ibd +-rw-r--r-- 1 meli meli 19244 Feb 14 18:44 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection3.ibd Binary file test-data/peak_detection3.ibd has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection3.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/peak_detection3.imzml Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,324 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection3.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/peak_detection3.imzml.txt Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 28 +-rw-r--r-- 1 meli meli 4768 Feb 14 18:44 ibd +-rw-r--r-- 1 meli meli 19627 Feb 14 18:44 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection4.ibd Binary file test-data/peak_detection4.ibd has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection4.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/peak_detection4.imzml Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,754 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 3f3812d36027 -r aa81463e21ea test-data/peak_detection4.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/peak_detection4.imzml.txt Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 80 +-rw-r--r-- 1 meli meli 29792 Feb 14 18:45 ibd +-rw-r--r-- 1 meli meli 45290 Feb 14 18:45 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/peakdetection1_QC.pdf Binary file test-data/peakdetection1_QC.pdf has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/peakdetection2_QC.pdf Binary file test-data/peakdetection2_QC.pdf has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/peakdetection3_QC.pdf Binary file test-data/peakdetection3_QC.pdf has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/peakdetection4_QC.pdf Binary file test-data/peakdetection4_QC.pdf has changed diff -r 3f3812d36027 -r aa81463e21ea test-data/preprocessing1.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/preprocessing1.imzml.txt Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 84 +-rw-r--r-- 1 meli meli 67160 Feb 14 17:45 ibd +-rw-r--r-- 1 meli meli 15071 Feb 14 17:45 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/preprocessing2.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/preprocessing2.imzml.txt Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 208 +-rw-r--r-- 1 meli meli 201592 Feb 14 17:45 ibd +-rw-r--r-- 1 meli meli 7431 Feb 14 17:45 imzml diff -r 3f3812d36027 -r aa81463e21ea test-data/preprocessing3.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/preprocessing3.imzml.txt Fri Feb 15 10:13:30 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 120 +-rw-r--r-- 1 meli meli 95936 Feb 14 17:46 ibd +-rw-r--r-- 1 meli meli 20580 Feb 14 17:46 imzml