# HG changeset patch # User galaxyp # Date 1576263263 18000 # Node ID b41107d8fe89e6c40323a1e41cdc98a4eb732daa # Parent 48c07268f341f4ab90f43cec00f1a4aa27aef46b "planemo upload for repository https://github.com/galaxyproteomics/tools-galaxyp/tree/master/tools/cardinal commit 1df4591de435d232862f20669aea529ceb23b12a" diff -r 48c07268f341 -r b41107d8fe89 combine.xml --- a/combine.xml Fri Mar 22 08:18:29 2019 -0400 +++ b/combine.xml Fri Dec 13 13:54:23 2019 -0500 @@ -1,13 +1,17 @@ - + combine several mass spectrometry imaging datasets into one macros.xml - - r-ggplot2 - + + bioconductor-cardinal + r-base + r-ggplot2 + r-maldiquantforeign + r-maldiquant + $outfile_imzml && ls -l "$outfile_imzml.files_path" >> $outfile_imzml @@ -42,13 +44,14 @@ 7){ - input_annotation = input_annotation[,1:7]} - annotation_df = merge(msidata_coordinates, input_annotation, by=c("x", "y"), all.x=TRUE) - annotation_df_8 = cbind(annotation_df, data.frame(matrix(NA,ncol=8-ncol(annotation_df), nrow=ncol(msidata_$i)))) - annotation_df_8_sorted = annotation_df_8[order(annotation_df_8\$pixel_index),]## orders pixel according to msidata - - ## each annotation column is assigned to the pixel in the pData slot of the MSIdata - msidata_$i\$column1 = annotation_df_8_sorted[,4] - msidata_$i\$column2 = annotation_df_8_sorted[,5] - msidata_$i\$column3 = annotation_df_8_sorted[,6] - msidata_$i\$column4 = annotation_df_8_sorted[,7] - msidata_$i\$column5 = annotation_df_8_sorted[,8] - + annotation_df_sorted = annotation_df[order(annotation_df\$pixel_index),]## orders pixel according to msidata + annotation_df_sorted\$pixel_index = NULL ## extract columnnames from (last) annotation tabular (for QC plot names) - annotation_colnames = colnames(input_annotation)[-c(1,2)] + annotation_colnames = colnames(input_annotation) #end if - - ################### preparation xy shifts ########################## +############### 4) shift coordinates with xy shifts ############################ #if str( $combine_conditional.combine_method ) == 'xy_shifts': + ## optional: set all files to 1/1 and then add shift + #if $combine_conditional.xy_origin: + coord(msidata_$i)\$x = as.integer(coord(msidata_$i)\$x - min(coord(msidata_$i)\$x-1)) + coord(msidata_$i)\$y = as.integer(coord(msidata_$i)\$y - min(coord(msidata_$i)\$y-1)) + #end if + ## shift coordinates according to input tabular file and store file names coord(msidata_$i)\$x = as.integer(coord(msidata_$i)\$x + input_list[$i+1,$combine_conditional.column_x]) ## shifts x coordinates according to tabular file coord(msidata_$i)\$y = as.integer(coord(msidata_$i)\$y + input_list[$i+1,$combine_conditional.column_y]) ## shifts y coordinates according to tabular file - pixel_vector = append(pixel_vector, rep(paste($i+1, input_list[$i+1,$combine_conditional.column_names], sep="_"),times=ncol(msidata_$i))) ## stores file name for each pixel - msidata_$i\$combined_sample = rep(paste($i+1, input_list[$i+1,$combine_conditional.column_names], sep="_"),times=ncol(msidata_$i)) - ## store number of file + sample_name = rep(paste(input_list[$i+1,$combine_conditional.column_names]),times=ncol(msidata_$i)) ## stores file name for each pixel + sample_names = append(sample_names, sample_name) + + ## store number of file to use later when removing duplicate coordinates pixelcoords_$i = cbind(coord(msidata_$i)[,1:2], rep($i+1,ncol(msidata_$i))) #silent $pixelcoords.append('pixelcoords_'+str($i)) colnames(pixelcoords_$i)[3] = "file_number" - ################### preparation automatic combination ########################## +##################### 5) shift coordinates automatically ####################### #elif str( $combine_conditional.combine_method ) == 'automatic_combine': - ## use name of Galaxy inputfile as combined sample annotation - names_vector = character() + ## use name of Galaxy inputfile as sample annotation + sample_name = character() #set escaped_element_identifier = re.sub('[^\w\-\s\[/]]', '_', str($infile.element_identifier)) if (ncol(msidata_$i)>0 & nrow(msidata_$i) >0) { - if (is.null(levels(msidata_$i\$combined_sample))) - { - names_vector = append(names_vector, rep(paste($i+1, "$escaped_element_identifier", sep="_"),ncol(msidata_$i))) - msidata_$i\$combined_sample = as.factor(names_vector) - } + sample_name = append(sample_name, rep(paste("$escaped_element_identifier"),ncol(msidata_$i))) } ## Number of input files define grid which is row-wise filled with files coord(msidata_$i)\$x = as.integer(coord(msidata_$i)\$x - (min(coord(msidata_$i)\$x-1)) + x_shifts) coord(msidata_$i)\$y = as.integer(coord(msidata_$i)\$y - (min(coord(msidata_$i)\$y-1)) + y_shifts) - x_shifts = max(coord(msidata_$i)\$x) + 5 + + x_shifts = max(coord(msidata_$i)\$x) + $combine_conditional.shift_value max_y = append(max_y, max(coord(msidata_$i)\$y)) all_files = $num_infiles new_row = ($i+1)/ceiling(sqrt(all_files)) new_row%%1==0 if (new_row%%1==0) {x_shifts = 0 ### when row is filled: x values start again at zero - y_shifts = max(max_y) + 5 ### when row is filled: y value increases to start a new row + y_shifts = max(max_y) + $combine_conditional.shift_value ### when row is filled: y value increases to start a new row max_y = numeric()} #end if +############################# 6) combination of files ########################## + + ## combine shifted coordinates with sample name and annotations from input file + + #if str($annotation_cond.annotation_tabular) == 'annotation' + cardinal_coordinates_$i = data.frame(as.matrix(Cardinal::coord(msidata_$i)[,1:2]), sample_name, annotation_df_sorted[,-c(1,2)]) + #else + cardinal_coordinates_$i = data.frame(as.matrix(Cardinal::coord(msidata_$i)[,1:2]), sample_name) + #end if + ## store files to combine them later and for each file check if it is valid + #silent $msidata.append('msidata_'+str($i)) + valid_dataset = append(valid_dataset, ncol(msidata_$i)>0 & nrow(msidata_$i)>0) + + +######################### 6a) combination different mz axis #################### + + ## combination for files with different mz axis via MALDIquant during for loop + + #if $processed_true: + print("mz axis differ") - #silent $msidata.append('msidata_'+str($i)) - valid_dataset = append(valid_dataset, ncol(msidata_$i)>0 & nrow(msidata_$i)>0) ## file with no intensities is considered valid + cardinal_mzs_$i = Cardinal::mz(msidata_$i) + + for(number_spectra in 1:ncol(msidata_${i})){ + + if (centroided(msidata_$i) == FALSE){ + ## create mass spectrum object + maldi_data_${i} = list() + for(number_spectra in 1:ncol(msidata_$i)){ + maldi_data_${i}[[number_spectra]] = MALDIquant::createMassSpectrum(mass = cardinal_mzs_$i, intensity = Cardinal::iData(msidata_$i)[,number_spectra])} + }else{ + maldi_data_${i} = list() + for (spectra in 1:ncol(msidata_$i)) + { + single_peaks_${i} = createMassPeaks(cardinal_mzs_$i, Cardinal::spectra(msidata_$i)[,spectra], snr=as.numeric(rep("NA", nrow(msidata_$i)))) + maldi_data_${i}[[spectra]] = single_peaks_${i} + } + } + } + + msidata_combined = append(msidata_combined, maldi_data_$i) + + #end if + + coordinates_combined = rbind(coordinates_combined, cardinal_coordinates_$i) #end for -###################### automatic combination ################################### -################################################################################ +######################### 6a) combination same mz axis ################### #if str( $combine_conditional.combine_method ) == 'automatic_combine': - print("automatic_combine") - - ## combine only valid datasets + print("automatic combine") - valid_data = list(#echo ','.join($msidata)#)[valid_dataset] - msidata_combined = do.call(combine, valid_data) - print("Valid datasets in order of input bottom to top:") - print(valid_dataset) + #if not $processed_true: + ## combine only valid datasets - ## create dataframe with x,y,sample_name and show all pixels in PDF as QC - position_df = cbind(coord(msidata_combined)[,1:2], msidata_combined\$combined_sample) - colnames(position_df)[3] = "sample_name" - - msidata = msidata_combined + valid_data = list(#echo ','.join($msidata)#)[valid_dataset] + msidata = do.call(combine, valid_data) + print("Valid datasets in order of input bottom to top:") + print(valid_dataset) + writeImzML(msidata, "out") - ## save msidata as imzML file - #if str($imzml_output) == "imzml_format": - writeImzML(msidata, "out") - #elif str($imzml_output) == "rdata_format": - ## save as (.RData) - iData(msidata) = iData(msidata)[] - save(msidata, file="$outfile_rdata") + #else + + ## save msidata as imzML file MALDIquant + MALDIquantForeign::exportImzMl(msidata_combined, file="out.imzML", processed=TRUE, coordinates=as.matrix(coordinates_combined[,1:2])) + #end if - -################################## xy shifts ################################### +########################### xy shift combination ############################### ################################################################################ #elif str( $combine_conditional.combine_method ) == 'xy_shifts': print("xy_shifts") - ## in case user made mistake with xy shifts: find duplicated coordinates - all_coordinates = do.call(rbind, list(#echo ','.join($pixelcoords)#)) - duplicated_coordinates= duplicated(all_coordinates[,1:2])| duplicated(all_coordinates[,1:2], fromLast=TRUE) -print(paste0("Number of removed duplicated coordinates after combination: ", sum(duplicated_coordinates)/2)) - unique_coordinates = all_coordinates[!duplicated_coordinates,] + #if not $processed_true: + + duplicated_coordinates= duplicated(coordinates_combined[,1:2])| duplicated(coordinates_combined[,1:2], fromLast=TRUE) + print(paste0("Number of removed duplicated coordinates after combination: ", sum(duplicated_coordinates))) + coordinates_combined = coordinates_combined[!duplicated_coordinates,] - ## remove duplicated coordinates - datasetlist = list() - count = 1 - for (usable_dataset in list(#echo ','.join($msidata)#)){ - pixelsofinterest = pixels(usable_dataset)[names(pixels(usable_dataset)) %in% rownames(unique_coordinates)] - filtered_dataset = usable_dataset[,pixelsofinterest] - if (ncol(filtered_dataset) > 0 ){ - datasetlist[[count]] = filtered_dataset} - count = count +1} + ## remove duplicated coordinates + datasetlist = list() + count = 1 + for (usable_dataset in list(#echo ','.join($msidata)#)){ + pixelsofinterest = pixels(usable_dataset)[names(pixels(usable_dataset)) %in% rownames(coordinates_combined)] + filtered_dataset = usable_dataset[,pixelsofinterest] + if (ncol(filtered_dataset) > 0 ){ + datasetlist[[count]] = filtered_dataset} + count = count +1} + + msidata = do.call(combine, datasetlist) + writeImzML(msidata, "out") - msidata_combined = do.call(combine, datasetlist) + #else - msidata = msidata_combined + ## in case user made mistake with xy shifts: find duplicated coordinates + duplicated_coordinates= duplicated(coordinates_combined[,1:2])| duplicated(coordinates_combined[,1:2], fromLast=TRUE) + print(paste0("Number of removed duplicated coordinates after combination: ", sum(duplicated_coordinates))) + unique_coordinates = data.frame(coordinates_combined)[!duplicated_coordinates,] + + filtered_dataset = msidata_combined [!duplicated_coordinates] + coordinates_matrix = as.matrix(unique_coordinates[,1:2]) - ## save msidata as imzML file - #if str($imzml_output) == "imzml_format": - writeImzML(msidata, "out") - #elif str($imzml_output) == "rdata_format": - ## save as (.RData) - iData(msidata) = iData(msidata)[] - save(msidata, file="$outfile_rdata") + ## save msidata as imzML file MALDIquant + MALDIquantForeign::exportImzMl(filtered_dataset, file="out.imzML", processed=TRUE, coordinates=coordinates_matrix) + + ## create x,y,sample_name dataframe for QC pdf + ## position_df = unique_coordinates ### ! anders + ## colnames(position_df)[3] = "sample_name" + ##coordinates_combined = coordinates_combined[pixelsofinterest,] ###! anders + coordinates_combined = unique_coordinates +##TODO: hier aufräumen kann alles weg?! + #end if - ## create x,y,sample_name dataframe for QC pdf - - position_df = cbind(coord(msidata)[,1:2], msidata\$combined_sample) - colnames(position_df)[3] = "sample_name" - #end if - -################################## outputs #################################### +################################## outputs ##################################### ################################################################################ ########### QC with pixels and their annotations ################################ @@ -280,7 +313,7 @@ pdf("Combined_qc.pdf", width=15, height=15) ## combined plot -combine_plot = ggplot(position_df, aes(x=x, y=y, fill=sample_name))+ +combine_plot = ggplot(coordinates_combined[,1:3], aes(x=x, y=y, fill=sample_name))+ geom_tile() + coord_fixed()+ ggtitle("Spatial orientation of combined data")+ @@ -288,125 +321,39 @@ theme(text=element_text(family="ArialMT", face="bold", size=15))+ theme(legend.position="bottom",legend.direction="vertical")+ guides(fill=guide_legend(ncol=4,byrow=TRUE)) -coord_labels = aggregate(cbind(x,y)~sample_name, data=position_df, mean) +coord_labels = aggregate(cbind(x,y)~sample_name, data=coordinates_combined[,1:3], mean) coord_labels\$file_number = gsub( "_.*$", "", coord_labels\$sample_name) -for(file_count in 1:nrow(coord_labels)) - {combine_plot = combine_plot + annotate("text",x=coord_labels[file_count,"x"], - y=coord_labels[file_count,"y"],label=toString(coord_labels[file_count,4]))} + print(combine_plot) #if str($annotation_cond.annotation_tabular) == 'annotation' ## annotation plots - - ## plot 1 - column1_df = cbind(coord(msidata)[,1:2], msidata\$column1) - colnames(column1_df)[3] = "column1" - - if (sum(is.na(column1_df[3])) < nrow(column1_df)){ - column1_plot = ggplot(column1_df, aes(x=x, y=y, fill=column1))+ - geom_tile() + - coord_fixed()+ - ggtitle(paste0(annotation_colnames[1]))+ - theme_bw()+ - theme(text=element_text(family="ArialMT", face="bold", size=15))+ - theme(legend.position="bottom",legend.direction="vertical")+ - guides(fill=guide_legend(ncol=4,byrow=TRUE, title=annotation_colnames[1])) - print(column1_plot)} - ##rename columnname for output tabular file - colnames(column1_df)[3] = annotation_colnames[1] - - ## plot 2 - column2_df = cbind(coord(msidata)[,1:2], msidata\$column2) - colnames(column2_df)[3] = "column2" - - if (sum(is.na(column2_df[3])) < nrow(column2_df)){ - column2_plot = ggplot(column2_df, aes(x=x, y=y, fill=column2))+ - geom_tile() + - coord_fixed()+ - ggtitle(paste0(annotation_colnames[2]))+ - theme_bw()+ - theme(text=element_text(family="ArialMT", face="bold", size=15))+ - theme(legend.position="bottom",legend.direction="vertical")+ - guides(fill=guide_legend(ncol=4,byrow=TRUE, title=annotation_colnames[2])) - print(column2_plot)} - - ##rename columnname for output tabular file - colnames(column2_df)[3] = annotation_colnames[2] + for (inputcolumns in 4:ncol(coordinates_combined)){ + ## plot 1 + column1_df = coordinates_combined[,c(1,2,inputcolumns)] + colnames(column1_df)[3] = "column1" - ## plot 3 - column3_df = cbind(coord(msidata)[,1:2], msidata\$column3) - colnames(column3_df)[3] = "column3" - if (sum(is.na(column3_df[3])) < nrow(column3_df)){ - column3_plot = ggplot(column3_df, aes(x=x, y=y, fill=column3))+ - geom_tile() + - coord_fixed()+ - ggtitle(paste0(annotation_colnames[3]))+ - theme_bw()+ - theme(text=element_text(family="ArialMT", face="bold", size=15))+ - theme(legend.position="bottom",legend.direction="vertical")+ - guides(fill=guide_legend(ncol=4,byrow=TRUE, title=annotation_colnames[3])) - print(column3_plot)} - ##rename columnname for output tabular file - colnames(column3_df)[3] = annotation_colnames[3] - - ## plot 4 - column4_df = cbind(coord(msidata)[,1:2], msidata\$column4) - colnames(column4_df)[3] = "column4" + if (sum(is.na(column1_df[3])) < nrow(column1_df)){ + column1_plot = ggplot(column1_df, aes(x=x, y=y, fill=column1))+ + geom_tile() + + coord_fixed()+ + ggtitle(paste0(annotation_colnames[inputcolumns-1]))+ + theme_bw()+ + theme(text=element_text(family="ArialMT", face="bold", size=15))+ + theme(legend.position="bottom",legend.direction="vertical")+ + guides(fill=guide_legend(ncol=4,byrow=TRUE, title=annotation_colnames[1])) + print(column1_plot)} + ##rename columnname for output tabular file + colnames(column1_df)[3] = annotation_colnames[inputcolumns-1] - if (sum(is.na(column4_df[3])) < nrow(column4_df)){ - column4_plot = ggplot(column4_df, aes(x=x, y=y, fill=column4))+ - geom_tile() + - coord_fixed()+ - ggtitle(paste0(annotation_colnames[4]))+ - theme_bw()+ - theme(text=element_text(family="ArialMT", face="bold", size=15))+ - theme(legend.position="bottom",legend.direction="vertical")+ - guides(fill=guide_legend(ncol=4,byrow=TRUE, title=annotation_colnames[4])) - print(column4_plot)} - ##rename columnname for output tabular file - colnames(column4_df)[3] = annotation_colnames[4] - - ## plot5 - - column5_df = cbind(coord(msidata)[,1:2], msidata\$column5) - colnames(column5_df)[3] = "column5" - if (sum(is.na(column5_df[3])) < nrow(column5_df)){ - column5_plot = ggplot(column5_df, aes(x=x, y=y, fill=column5))+ - geom_tile() + - coord_fixed()+ - ggtitle(paste0(annotation_colnames[5]))+ - theme_bw()+ - theme(text=element_text(family="ArialMT", face="bold", size=15))+ - theme(legend.position="bottom",legend.direction="vertical")+ - guides(fill=guide_legend(ncol=4,byrow=TRUE, title=annotation_colnames[5])) - print(column5_plot)} - ##rename columnname for output tabular file - colnames(column5_df)[3] = annotation_colnames[5] + } #end if dev.off() ##################### annotation tabular output ################################ - if (length(features(msidata))> 0 & length(pixels(msidata)) > 0){ - position_df\$sample_name = gsub("^[^_]*_","",position_df\$sample_name) - - #if str($annotation_cond.annotation_tabular) == 'no_annotation': - - write.table(position_df, file="$pixel_annotations", quote = FALSE, row.names = FALSE, col.names=TRUE, sep = "\t") - - #else - annotation_df_list = list(position_df, column1_df, column2_df, column3_df, column4_df, column5_df) - combined_annotations = Reduce(function(...) merge(..., by=c("x", "y"), all=TRUE), annotation_df_list) - write.table(combined_annotations, file="$pixel_annotations", quote = FALSE, row.names = FALSE, col.names=TRUE, sep = "\t") - #end if - - }else{ - print("No annotation tabular output because file has no features or pixels left") - } - - - + write.table(coordinates_combined, file="$pixel_annotations", quote = FALSE, row.names = FALSE, col.names=TRUE, sep = "\t") ]]> @@ -438,7 +385,7 @@ + help="Same number and order of files as input files. First column x values, second column y values, further columns with annotations"/> @@ -447,7 +394,9 @@ - + + + @@ -455,21 +404,13 @@ + - - - - + - - imzml_output=='imzml_format' - - - imzml_output == 'rdata_format' - + @@ -486,10 +427,29 @@ - + - + + + + + + + + + + + + + + + + + + + + @@ -497,7 +457,7 @@ - + @@ -513,10 +473,13 @@ - + - + + + + @@ -526,7 +489,7 @@ - + @@ -540,10 +503,13 @@ - + - + + + + @@ -553,17 +519,16 @@ ----- -This tool uses the Cardinal combine function to combine several mass spectrometry imaging data. +This tool combines several mass spectrometry imaging data files. @MSIDATA_INPUT_DESCRIPTION@ -- MSI data files must have the same m/z values (to obtain same m/z values for different files: filtering tool same m/z range and preprocessing tool same binning width) - Coordinates stored as decimals rather than integers will be rounded to obtain a regular pixel grid. This might lead to duplicated coordinates which will be automatically removed before the tools analysis starts. @SPECTRA_TABULAR_INPUT_DESCRIPTION@ - For xy shifts with tabular file: Tabular file with x and y coordinates shift and file name - - Each input file is shifted in x and y direction according to this tabular file. In the example the files have about the same pixel dimensions which is smaller than 510x260. - - The file can have any column names as header (in this case set "Tabular file contains a header line" to yes) or no header at all + - Each input file is renamed and shifted in x and y direction according to this tabular file. In the example the files have about the same pixel dimensions which is smaller than 510x260. + - The file can have any column names as header (in this case set "Tabular file contains a header line" to "Yes") or no header at all (set "Tabular file contains a header line" to "No"). :: @@ -580,24 +545,28 @@ **Options** -- "automatic combination": files are automatically arranged in a grid (duplicated pixels are allowed), subfiles are named according to the input file name +- "automatic combination": files are automatically arranged in a grid, subfiles are named according to the input file name - "xy shifts": each file can be moved in x and y direction according to the users need (define one tabular file in the order in which the files are loaded in the history (bottom to top) and define for each file the x and y coordinates shifts in separate columns and the file name in a third column as shown above). The xy shift option combines all datasets and removes all duplicated pixels (same x and y coordinates). +- "Set all file coordinates to 1/1 as origin" can be choosen to override current pixel coordinates of the input file and set their minimal x and minimal y values to 1. Then the shifts from the xy shift tabular files are used to move the pixels of each dataset. +- In case the input files have not exactly the same m/z values set "Do the files have different m/z axis?" to "Yes". Then functionalities of the "MALDIquant" package are used to combine the datasets. + **Tips** -- The combine tools puts all samples into a common x-y-grid, therefore pixel coordinates will change. In case the pixels are already annotated, the annotations should be provided as tabular files and the tool will return an annotation file with the new pixel coordinates. This annotation file can then be used together with the combined MSI data for tools in which the annotation is required (e.g. 'MSI classification') or useful (e.g. 'MSI spectra plots'). -- In case more annotations are required: The annotation input file should have an identifier column, for example the patient_ID. A second tabular file that contains more annotations and also one column with the identifier column (e.g. 'patient_ID') can be merged to the annotation output file of this tool with the tool 'join two files' and then set the 'Column to use' parameters for both files to the identifier column. - +- The combine tool puts all samples into a common x-y-grid, therefore pixel coordinates will change. In case the pixels are already annotated, the annotations should be provided as tabular files and the tool will return an annotation file with the new pixel coordinates. This annotation file can then be used together with the combined MSI data for tools in which the annotation is required (e.g. 'MSI classification') or useful (e.g. 'MSI spectra plots'). **Output** -- MSI data as imzML file or .RData (can be read with the Cardinal package in R) -- pdf that shows the pixel positions and annotations of the combined files -- Tabular file with pixel annotations (x,y,column with input file names and up to five annotation columns) +- MSI data as imzML file (in continous format when m/z axis were the same; in processed format when m/z axis were different) +- Pdf with pixel positions and annotations of the combined files +- Tabular file with pixel annotations (x,y,column with input file names and annotation columns) ]]> - + + 10.1093/bioinformatics/btv146 + 10.1007/978-3-319-45809-0_6 + diff -r 48c07268f341 -r b41107d8fe89 test-data/112_annotation_output.tabular --- a/test-data/112_annotation_output.tabular Fri Mar 22 08:18:29 2019 -0400 +++ b/test-data/112_annotation_output.tabular Fri Dec 13 13:54:23 2019 -0500 @@ -1,16 +1,16 @@ -x y sample_name file_name column_name NA.x NA.y NA -1 1 msidata_1.RData file_one col1 NA NA NA -1 2 msidata_1.RData file_one col1 NA NA NA -1 3 msidata_1.RData file_one col1 NA NA NA -10 1 123_combined.RData file_two col3 NA NA NA -10 2 123_combined.RData file_two col3 NA NA NA -10 3 123_combined.RData file_two col3 NA NA NA -15 1 123_combined.RData file_three col3 NA NA NA -15 2 123_combined.RData file_three col3 NA NA NA -15 3 123_combined.RData file_three col3 NA NA NA -7 1 123_combined.RData file_one col1 NA NA NA -7 2 123_combined.RData file_one col1 NA NA NA -7 3 123_combined.RData file_one col1 NA NA NA -9 1 123_combined.RData file_two col2 NA NA NA -9 2 123_combined.RData file_two col2 NA NA NA -9 3 123_combined.RData file_two col2 NA NA NA +x y sample_name file_name column_name +1 1 msidata_1.RData file_one col1 +1 2 msidata_1.RData file_one col1 +1 3 msidata_1.RData file_one col1 +7 1 123_combined.RData file_one col1 +7 2 123_combined.RData file_one col1 +7 3 123_combined.RData file_one col1 +9 1 123_combined.RData file_two col2 +10 1 123_combined.RData file_two col3 +9 2 123_combined.RData file_two col2 +10 2 123_combined.RData file_two col3 +9 3 123_combined.RData file_two col2 +10 3 123_combined.RData file_two col3 +15 1 123_combined.RData file_three col3 +15 2 123_combined.RData file_three col3 +15 3 123_combined.RData file_three col3 diff -r 48c07268f341 -r b41107d8fe89 test-data/112_auto_combined.ibd Binary file test-data/112_auto_combined.ibd has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/112_auto_combined.imzml --- a/test-data/112_auto_combined.imzml Fri Mar 22 08:18:29 2019 -0400 +++ b/test-data/112_auto_combined.imzml Fri Dec 13 13:54:23 2019 -0500 @@ -9,8 +9,8 @@ - - + + @@ -22,19 +22,18 @@ - - + - + @@ -43,18 +42,24 @@ - + - + + + + + - + + + diff -r 48c07268f341 -r b41107d8fe89 test-data/112_auto_combined.imzml.txt --- a/test-data/112_auto_combined.imzml.txt Fri Mar 22 08:18:29 2019 -0400 +++ b/test-data/112_auto_combined.imzml.txt Fri Dec 13 13:54:23 2019 -0500 @@ -1,4 +1,4 @@ imzML file: total 556 --rw-r--r-- 1 meli meli 537552 Feb 12 12:25 ibd --rw-r--r-- 1 meli meli 25466 Feb 12 12:25 imzml +-rw-r--r-- 1 meli meli 537552 Dez 11 00:10 ibd +-rw-r--r-- 1 meli meli 25811 Dez 11 00:10 imzml diff -r 48c07268f341 -r b41107d8fe89 test-data/112_auto_combined_QC.pdf Binary file test-data/112_auto_combined_QC.pdf has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_annotation_output.tabular --- a/test-data/123_annotation_output.tabular Fri Mar 22 08:18:29 2019 -0400 +++ b/test-data/123_annotation_output.tabular Fri Dec 13 13:54:23 2019 -0500 @@ -1,13 +1,13 @@ -x y sample_name file_name column_name NA.x NA.y NA -1 1 File1 file_one col1 NA NA NA -1 2 File1 file_one col1 NA NA NA -1 3 File1 file_one col1 NA NA NA -3 1 File2 file_two col2 NA NA NA -3 2 File2 file_two col2 NA NA NA -3 3 File2 file_two col2 NA NA NA -4 1 File2 file_two col3 NA NA NA -4 2 File2 file_two col3 NA NA NA -4 3 File2 file_two col3 NA NA NA -9 1 File3 file_three col3 NA NA NA -9 2 File3 file_three col3 NA NA NA -9 3 File3 file_three col3 NA NA NA +x y sample_name file_name column_name +1 1 File1 file_one col1 +1 2 File1 file_one col1 +1 3 File1 file_one col1 +3 1 File2 file_two col2 +4 1 File2 file_two col3 +3 2 File2 file_two col2 +4 2 File2 file_two col3 +3 3 File2 file_two col2 +4 3 File2 file_two col3 +9 1 File3 file_three col3 +9 2 File3 file_three col3 +9 3 File3 file_three col3 diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combine.rdata Binary file test-data/123_combine.rdata has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined.RData Binary file test-data/123_combined.RData has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined.ibd Binary file test-data/123_combined.ibd has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/123_combined.imzml Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,399 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/123_combined.imzml.txt Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 452 +-rw-r--r-- 1 meli meli 436764 Dez 11 00:02 ibd +-rw-r--r-- 1 meli meli 21511 Dez 11 00:02 imzml diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined_QC.pdf Binary file test-data/123_combined_QC.pdf has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined_auto.ibd Binary file test-data/123_combined_auto.ibd has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined_auto.imzml --- a/test-data/123_combined_auto.imzml Fri Mar 22 08:18:29 2019 -0400 +++ b/test-data/123_combined_auto.imzml Fri Dec 13 13:54:23 2019 -0500 @@ -9,8 +9,8 @@ - - + + @@ -22,19 +22,18 @@ - - + - + @@ -43,18 +42,24 @@ - + - - + + + + + + - + + + diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined_auto.imzml.txt --- a/test-data/123_combined_auto.imzml.txt Fri Mar 22 08:18:29 2019 -0400 +++ b/test-data/123_combined_auto.imzml.txt Fri Dec 13 13:54:23 2019 -0500 @@ -1,4 +1,4 @@ imzML file: total 452 --rw-r--r-- 1 meli meli 436764 Feb 12 00:51 ibd --rw-r--r-- 1 meli meli 21166 Feb 12 00:51 imzml +-rw-r--r-- 1 meli meli 436764 Dez 11 00:05 ibd +-rw-r--r-- 1 meli meli 21514 Dez 11 00:05 imzml diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined_auto.pdf Binary file test-data/123_combined_auto.pdf has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined_picked.rdata Binary file test-data/123_combined_picked.rdata has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/123_combined_picked2.rdata Binary file test-data/123_combined_picked2.rdata has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/12_annotation_output.tabular --- a/test-data/12_annotation_output.tabular Fri Mar 22 08:18:29 2019 -0400 +++ b/test-data/12_annotation_output.tabular Fri Dec 13 13:54:23 2019 -0500 @@ -1,10 +1,10 @@ -x y sample_name file_name column_name NA.x NA.y NA -1 1 msidata_1.RData file_one col1 NA NA NA -1 2 msidata_1.RData file_one col1 NA NA NA -1 3 msidata_1.RData file_one col1 NA NA NA -7 1 msidata_2.RData file_two col2 NA NA NA -7 2 msidata_2.RData file_two col2 NA NA NA -7 3 msidata_2.RData file_two col2 NA NA NA -8 1 msidata_2.RData file_two col3 NA NA NA -8 2 msidata_2.RData file_two col3 NA NA NA -8 3 msidata_2.RData file_two col3 NA NA NA +x y sample_name file_name column_name +1 1 msidata_1.RData file_one col1 +1 2 msidata_1.RData file_one col1 +1 3 msidata_1.RData file_one col1 +7 1 msidata_2.RData file_two col2 +8 1 msidata_2.RData file_two col3 +7 2 msidata_2.RData file_two col2 +8 2 msidata_2.RData file_two col3 +7 3 msidata_2.RData file_two col2 +8 3 msidata_2.RData file_two col3 diff -r 48c07268f341 -r b41107d8fe89 test-data/12_combined.RData Binary file test-data/12_combined.RData has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/12_combined.ibd Binary file test-data/12_combined.ibd has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/12_combined.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/12_combined.imzml Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,318 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 48c07268f341 -r b41107d8fe89 test-data/12_combined.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/12_combined.imzml.txt Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 352 +-rw-r--r-- 1 meli meli 335976 Dez 11 00:07 ibd +-rw-r--r-- 1 meli meli 17217 Dez 11 00:07 imzml diff -r 48c07268f341 -r b41107d8fe89 test-data/12_combined_QC.pdf Binary file test-data/12_combined_QC.pdf has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/2123_auto_combined.RData Binary file test-data/2123_auto_combined.RData has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/2123_auto_combined.ibd Binary file test-data/2123_auto_combined.ibd has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/2123_auto_combined.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/2123_auto_combined.imzml Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,561 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 48c07268f341 -r b41107d8fe89 test-data/2123_auto_combined.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/2123_auto_combined.imzml.txt Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 656 +-rw-r--r-- 1 meli meli 638340 Dez 11 00:12 ibd +-rw-r--r-- 1 meli meli 30107 Dez 11 00:12 imzml diff -r 48c07268f341 -r b41107d8fe89 test-data/2123_auto_combined_QC.pdf Binary file test-data/2123_auto_combined_QC.pdf has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/picked.ibd Binary file test-data/picked.ibd has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/picked.imzml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/picked.imzml Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,580 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 48c07268f341 -r b41107d8fe89 test-data/picked.imzml.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/picked.imzml.txt Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,4 @@ +imzML file: +total 192 +-rw-r--r-- 1 meli meli 157984 Dez 11 00:03 ibd +-rw-r--r-- 1 meli meli 35012 Dez 11 00:03 imzml diff -r 48c07268f341 -r b41107d8fe89 test-data/picked.tabular --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/picked.tabular Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,19 @@ +x y sample_name +1 1 File1 +1 2 File1 +1 3 File1 +3 1 File1 +4 1 File1 +3 2 File1 +4 2 File1 +3 3 File1 +4 3 File1 +11 1 File2 +12 1 File2 +11 2 File2 +12 2 File2 +11 3 File2 +12 3 File2 +17 1 File2 +17 2 File2 +17 3 File2 diff -r 48c07268f341 -r b41107d8fe89 test-data/picked_QC.pdf Binary file test-data/picked_QC.pdf has changed diff -r 48c07268f341 -r b41107d8fe89 test-data/xy_coordinates2.tabular --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/xy_coordinates2.tabular Fri Dec 13 13:54:23 2019 -0500 @@ -0,0 +1,2 @@ +0 0 File1 +8 0 File2