Package PROcess. R topics documented: June 15, Title Ciphergen SELDI-TOF Processing Version Date Author Xiaochun Li

Size: px
Start display at page:

Download "Package PROcess. R topics documented: June 15, Title Ciphergen SELDI-TOF Processing Version Date Author Xiaochun Li"

Transcription

1 Title Ciphergen SELDI-TOF Processing Version Date Author Package PROcess June 15, 2018 A package for processing protein mass spectrometry data. Depends Icens Imports graphics, grdevices, Icens, stats, utils biocviews MassSpectrometry, Proteomics Maintainer <xiaochun@jimmy.harvard.edu> License Artistic-2.0 LazyLoad yes git_url git_branch RELEASE_3_7 git_last_commit 4a5f9ac git_last_commit_date Date/Publication R topics documented: align avesd avespec binning bslnoff gelmap getmzs getpeaks getpeaks intg is.multiple ispeak lnn peaks pk2bmkr quality

2 2 avesd read.files renorm rmbaseline speczoom Index 17 align Align peaks for a specified precision. A vector of peaks are expanded to a collection of intervals, eps * m/z of the peak to the left and right of the peak position. They are then aligned using the method of intersection graphs by Gentleman and Vandal. align(pvec, eps = 0.003) pvec eps A vector of peaks. A user specified precision of peak position. A vector of aligned peaks. References R. Gentleman and A. C. Vandal, Computational Algorithms for Censored-Data Problems Using Intersection Graphs. (2001), J. Comput. Graphic Statist., vol. 10, p avesd Compute the Average Standard Deviation for a Set of Spectra and a Given Cutoff Point Compute the Average Standard Deviation for a Set of Spectra and a Given Cutoff Point avesd(ma, cutoff) Ma cutoff A matrix with rows the m/z values and columns samples/spectra A number of m/z

3 avespec 3 For a given cutoff point, the standard deviation of all spectra will be calculated at each m/z above this cutoff point. The resulting sd s are then averaged and returned. A real number. avespec Compute mean spectrum of a set of spectra Compute mean spectrum of a set of spectra. avespec(nvec) nvec A character vector of file names. avespec computes the point-wise mean of intensities of a set of spectra over the whole range of the m/z values. A matrix with 2 columns, the first being the m/z values and the 2nd being the average of intensities corresponding to the m/z value in the first column of the same row. testfs <- dir(system.file("test", package = "PROcess"), full.names=true) testave <- avespec(testfs)

4 4 bslnoff binning Binning the Mass Spectrometry Data The function binning takes a matrix of spectra and constructs a matrix of intensities of reduced dimensions based on a equally spaced mesh of breaks intervals over the entire m/z range. binning(ma, breaks = 400) Ma breaks a matrix of spectra by column. number of bins, or equally-spaced intervals for the image of reduced resolution A matrix of dimensions c(dim(ma)[1], breaks ). See Also See Also gelmap. bslnoff Baseline Substraction This function estimates the baseline and then removes baseline from the raw spectrum. bslnoff(f, breaks = 200, qntl = 0, method = c("loess", "approx"), bw = 0.005, plot = FALSE,...) f breaks qntl method bw plot a matrix with M/Z values in the first column and intensities in the second column number of breaks set to M/Z values for finding the local minima or points below a centain quantile of intensities; breaks -1 equally spaced intervals on the log M/Z scale. if 0, find local minima; if >0 find intensities < qntl*100th quantile locally. "loess" or "approx" (linear interpolation). the bandwidth to be passed to loess. TRUE or FALSE, if true, it will plot the raw spectrum, theestimated baseline and the baseline substracted spectrum.... Further parameters that get passed on to plot.

5 gelmap 5 a matrix of two columns: the first column being the M/Z values same as the input, and the second column being the baseline substracted spectra. fdat <- system.file("test", package = "PROcess") fs <- list.files(fdat, pattern="\\.*csv\\.*", full.names=true) f1 <- read.files(fs[1]) fcut <- f1[f1[,1]>0,] bseoff <-bslnoff(fcut,method="loess",plot=true, bw=0.1) title(basename(fs[1])) gelmap Plot the image of a set of spectra This function takes its argument as a intensity matrix of a set of spectra and plots the image as a heatmap. gelmap(ma, cols = gray(seq(1, 0, by = -0.01)), at.mz = NULL, at.col = NULL, cexcol = /log10(n Ma cols at.mz at.col cexcol a matrix of intensities; spectra are arranged column-wise. a vector of color to represent continuum of intensities. a vector of m/z values where labels are desired. a vector of sample indices, useful to label particular samples. If NULL, samples will be labelled from down up by 1:ncol(Ma). text size of the sample labels. See Also See Also binning.

6 6 getpeaks getmzs Extract M/Z values from the biomarker dataframe. Turn column names of the biomarker dataframe to numeric M/Z values. getmzs(df) df The biomarker dataframe with rows as spectra and columns as biomarkers. A numeric vector. getpeaks Peak Detection For given threshold criteria, find peaks. getpeaks(bseoffm, peakinfofile,son = 2,span = 81,sm.span=11, zerothrsh=2, area.w = 0.003, ratio = 0.2) bseoffm peakinfofile SoN span sm.span zerothrsh area.w ratio a matrix holding the baseline-substracted spectra, with row-names as the m/z values and column-names as the spectrum names. a.csv file in the same format as Ciphergen s peak info file, with 5 columns data. More details later. see ispeak(). see ispeak(). see ispeak(). ignore peaks whose intensity values are below zerothrsh. see ispeak(). see ispeak(). For given threshold criteria, detect peaks and write the following columns of information into peakinfofile, spectrum name (Spectrum.Tag), spectrum sequential number (Spectrum.), peak sequential number within a spectrum (Peak.), relative intensity (Intensity) and the m/z value where the relative intensity occurs (Substance.Mass).

7 getpeaks2 7 See Also rmbaseline example(renorm) peakfile <- paste(tempdir(),"testpeakinfo.csv", sep="/") getpeaks(rtm, peakfile) getpeaks2 Quantify peaks for individual spectra. For a vector of given peak locations, quantify peaks for individual spectra. getpeaks2(bseoffm, pvec, eps = 0.003) bseoffm pvec eps A matrix of intensities, with rows the m/z values and columns samples. A vector of given peak locations. Relative precision of peak location. Each peak is expanded to an interval, eps * m/z to the left and right of the peak. Intensities of individual spectra are quantified by the maxima in this interval. A matrix of intensities with rows the peaks pvec and column the samples. The m/z values of pvec is stored as the rownames of the returned matrix.

8 8 is.multiple intg Integration This function calculates the integration of y with respect to x. intg(y, x) x a vector of real values, not necessarily sorted. y a vector of function values at x. (x,y)s are sorted according to ascending x values and then the integration is calculated as sum of the products of average of adjacent y values and the difference of adjacent x values. x <- seq(0, 1,length=100) y <- x^2 intg(y, x) is.multiple Find multiple-charged polypeptides. For each of the polypeptides in a vector, find its multiple-charged species in the vector. is.multiple(v, k = 2, eps = 0.003) v k eps a vector of polypeptides. a vector of integers, that is, multiples of interest. a user specified precision of peak position.

9 ispeak 9 If abs(v-k*u)/v <= eps, then v is considered to be u with k charges. A list named with the m/z values of polypeptides who have multiple-charged species; each component is a named vector of polypeptides with number of charges as names. bmks <- c( , , , , , , , , , , , , ) is.multiple(bmks, k=2:5) ispeak Locate Peaks in a Spectrum Find local maxima of a spectrum. ispeak(f,son = 2,span = 81,sm.span=11,plot=FALSE,add = FALSE, zerothrsh=2,area.w = 0.003, ratio = 0.2,...) f SoN a matrix of two columns representing a spectrum, with the first column the m/z value and second the intensity signal to noise ratio criterion for peak detection span parameter for estimating local variance before peak detection; default is 81 points, that is, 40 points to the left and right of a point of which the variance is being estimated. sm.span plot add zerothrsh area.w ratio parameter for smoothing the spectrum before peak detection; default is 11 points, that is, 5 points to the left and right of a point being smoothed logical, plot the smoothed spectrum and peaks? add to the existing raw and baseline-substracted plot? ignore peaks whose intensity values are below zerothrsh. the neighbourhood of a peak m/z, mz*(1-area.w, 1+area.w).to calculate area of the peak, if area/max(area) > ratio, the peak is retained.... further arguments that get passed on to plot.

10 10 lnn A spectrum is smoothed first using the nearest span neighbours. A larger span sm.span is needed to estimate the local variation so that it is not overestimated due to the peaks nearby. Then potential peaks are identified using Ripley s peaks function with span points. Peaks that satify the conditions that the (smoothed) signal to noise ratio is greater than SoN and that the smoothed signal is greater than 1.64 * mad(sm) are returned. A data frame with five components, peak, smooth, mz and sigmas, each of length the number of rows in f. peak is logical indicating whethere there is a peak or not (Y/N), smooth the smooth of the spectrum, mz the same as f[,1], sigmas the estimates of local variation and area the area associated with each peak after the first pass. example(bslnoff) pkobj <- ispeak(bseoff,span=81,sm.span=11,plot=true) lnn Estimate Signal and Variation of a Spectrum Estimate the signal and the variation of a spectrum. lnn(x, span = 21, sm.span = 11) x span a vector of real values. the window widith for estimation of local variation. sm.span the window width for estimation of the signal of x. The signal of a spectrum is estimated by moving average and its local variation is estimated by moving mad, possibly in a large window. A list with two components: fitted sigma estimated signal, estimated local variation.

11 peaks 11 peaks Peak Detection Finds the local maxima, local noise and its associated standard deviations in a vector. peaks(x, span = 3) noise(x, span = 5) sigma(x, span = 5) x span a vector. a local miximum is defined as an element in a sequence which is greater than all other elements within a window of width span centered at that element. The default value is 3, meaning that a peak is bigger than both of its neighbors. Local noise is definedas an element minus the mean of all elements within a window of width span centered at that element. Local standard deviation of an element is defined as the standard deviation of all elements within a window of width span centered at that element. a logical vector of the same length as series indicating where the peaks are. x <- seq(0, 10*pi, by=0.1) y <- sin(x)*x plot(x,y, type="l") is.max <- peaks(y) points(x[is.max],y[is.max], pch=21, bg="red") legend(2, 25, legend = "Peaks",pch = 19, col="red", bty = "n") # can be used for local minima too: # is.min <- peaks(-y) # points(x[is.min],y[is.min], pch=21, bg="blue")

12 12 pk2bmkr pk2bmkr Find Biomarkers. Align peaks of spectra in peakinfofile and find biomarkers by a procedure described in Gentleman and Geyer (1994). pk2bmkr(peakinfofile, bseoffm, bmkfile, eps = 0.003, binary = F,p.fltr = 0.1) peakinfofile bseoffm bmkfile eps binary p.fltr a.csv file in the same format as Ciphergen s peakinfo file with 5 columns data, Spectrum.Tag, Spectrum., Peak., Intensity and Substance.Mass. a matrix holding the baseline-substracted spectra, with row-names as the m/z values and column-names as the spectrum names. a.csv file in the same format as Ciphergen s biomarker file, with spectra (samples) as columns, and biomarkers as rows. expected experimental variation in the m/z values. output intensity or binary peak presence/absence signals. a number between 0 and 1. If a proto-biomarker is identified as peak in > p.fltr x 100 percent of spectra, it s kept in bmkfile. A dataframe with spectra as rows and biomarkers as columns. Spectrum labels and biomarker positions may be in the names of the dataframe. References Gentleman, R. and Geyer, C.J. (1994). Maximum likelihood for interval censored data: Consistency and computation. Biometrika, 81: See Also rmbaseline,getpeaks example(getpeaks) bmkfile <- paste(tempdir(),"testbiomarker.csv",sep="/") testbio <- pk2bmkr(peakfile, rtm, bmkfile) ## plot biomarker intensities of the 2 spectra

13 quality 13 mzs <- as.numeric(rownames(rtm)) matplot(mzs, rtm, type="l", xlim=c(1000, 10000)) bks <- getmzs(testbio) abline(v=bks, col="green") quality Quality Check on a Set of Spectra Compute three quality parameters for a set of spectra. quality(ma, peakinfofile, cutoff) Ma peakinfofile cutoff a Matrix where the baseline-subtracted spectra are stored column wise. a.csv file in the same format as Ciphergen s peak info file, with 5 columns data. See of getpeaks. The point in m/z below which spectra are cutoff. The quality parameters are computed a la fashion de Mani. 1. Estimate noise by moving average with a 5 point window. 2. Estimate the noise envelop by 3 times the standard deviation of noise in a 251 point moving window. 3. Compute the area under the baseline-subtracted curve, area0. 4. Compute the area after subtracting the noise envelop from the baseline-subtracted curve, area1. 5. Parameter Quality is defined as area1/area0. 6. Parameter Retain is defined as the number of points with height above 5 times the noise envelop over total number of points in the spectrum. 7. Detect peaks in each spectrum by getpeaks or Ciphergen software. 8. Parameter peak is defined as the number of peaks in a spectrum divided by the mean number of peaks across spectra. A spectrum is considered to be of poor quality if Quality<0.4, Retain<0.1 and peak<0.5 simultaneously. A matrix with three named columns, Quality, Retain and peak, with spectrum file names as row names. example(getpeaks) qualres <- quality(testm, peakfile, cutoff=1500)

14 14 renorm read.files Read a Spectrum from a Comma Deliminated File Read a Spectrum from a Comma Deliminated File, maybe compressed. read.files(fn) fn path to a.csv file, possibly compressed. renorm Renormalize Spectra Renormalize spectra for m/z values greater than cutoff. renorm(ma, cutoff) Ma cutoff a matrix, with rows the m/z values and the columns the samples. a real value, before which the portion of a spectrum will be ignored. A sample of spectra will be normalized to have the same AUC, the median of the AUCs of spectra. Each AUC is calculated as the sum of the intensities whose m/z values are greater than cutoff. A matrix, with rows the m/z values and the columns the samples. Only rows with m/z values greater than cutoff are kept. example(rmbaseline) rtm <- renorm(testm, cutoff=1500)

15 rmbaseline 15 rmbaseline Batch Baseline Subtraction. Baseline subtraction from each raw spectrum in fldr. rmbaseline(fldr, bseoffrda = NULL, breaks = 200, qntl = 0, method = "loess", bw = 0.1, SpecNames = list.files(fldr, pattern = "\\.*csv\\.*")) fldr bseoffrda breaks qntl method bw SpecNames a path to where the raw spectra are stored optional; name of the file (with extension.rda) where the baseline-substracted spectra, a matrix with row-names as the m/z values and column-names as the spectrum tags, will be saved to. see bslnoff(). see bslnoff(). see bslnoff(). see bslnoff(). a vector of character strings as spectrum names. A matrix whose columns correspond to baseline-subtracted spectra with row-names as the m/z values and column-names as the spectrum names. See Also bslnoff. testdir <- system.file("test", package = "PROcess") testm <- rmbaseline(testdir)

16 16 speczoom speczoom Plotting a Spectrum with Peaks Function for plotting an object returned by ispeak. speczoom(pks, xlim = NULL, cols = c("cyan", "red", "black"),...) pks xlim cols an object (a list) returned by ispeak. a range of m/z values over which a zoomed-in view of the spectrum is desired. a vector of color specification for the smooth (signal), peaks and local noise.... further arguments that get passed on to plot. example(ispeak) speczoom(pkobj, xlim=c(5000, 10000))

17 Index Topic arith avesd, 2 avespec, 3 is.multiple, 8 Topic hplot gelmap, 5 speczoom, 16 Topic manip align, 2 binning, 4 getpeaks2, 7 Topic math intg, 8 quality, 13 Topic nonparametric bslnoff, 4 getpeaks, 6 ispeak, 9 lnn, 10 peaks, 11 pk2bmkr, 12 rmbaseline, 15 Topic utilities getmzs, 6 read.files, 14 renorm, 14 noise (peaks), 11 peaks, 11 pk2bmkr, 12 quality, 13 read.files, 14 renorm, 14 rmbaseline, 7, 12, 15 sigma (peaks), 11 speczoom, 16 align, 2 avesd, 2 avespec, 3 binning, 4, 5 bslnoff, 4 gelmap, 4, 5 getmzs, 6 getpeaks, 6, 12 getpeaks2, 7 intg, 8 is.multiple, 8 ispeak, 9 lnn, 10 17

PROcess. June 1, Align peaks for a specified precision. A user specified precision of peak position.

PROcess. June 1, Align peaks for a specified precision. A user specified precision of peak position. PROcess June 1, 2010 align Align peaks for a specified precision. A vector of peaks are expanded to a collection of intervals, eps * m/z of the peak to the left and right of the peak position. They are

More information

Package MSstatsTMT. February 26, Title Protein Significance Analysis in shotgun mass spectrometry-based

Package MSstatsTMT. February 26, Title Protein Significance Analysis in shotgun mass spectrometry-based Package MSstatsTMT February 26, 2019 Title Protein Significance Analysis in shotgun mass spectrometry-based proteomic experiments with tandem mass tag (TMT) labeling Version 1.1.2 Date 2019-02-25 Tools

More information

Package ORIClust. February 19, 2015

Package ORIClust. February 19, 2015 Type Package Package ORIClust February 19, 2015 Title Order-restricted Information Criterion-based Clustering Algorithm Version 1.0-1 Date 2009-09-10 Author Maintainer Tianqing Liu

More information

Package ordibreadth. R topics documented: December 4, Type Package Title Ordinated Diet Breadth Version 1.0 Date Author James Fordyce

Package ordibreadth. R topics documented: December 4, Type Package Title Ordinated Diet Breadth Version 1.0 Date Author James Fordyce Type Package Title Ordinated Diet Breadth Version 1.0 Date 2015-11-11 Author Package ordibreadth December 4, 2015 Maintainer James A. Fordyce Calculates ordinated diet breadth with some

More information

Package BUScorrect. September 16, 2018

Package BUScorrect. September 16, 2018 Type Package Package BUScorrect September 16, 2018 Title Batch Effects Correction with Unknown Subtypes Version 0.99.12 Date 2018-06-07 Author , Yingying Wei Maintainer

More information

Package citccmst. February 19, 2015

Package citccmst. February 19, 2015 Version 1.0.2 Date 2014-01-07 Package citccmst February 19, 2015 Title CIT Colon Cancer Molecular SubTypes Prediction Description This package implements the approach to assign tumor gene expression dataset

More information

Package prognosticroc

Package prognosticroc Type Package Package prognosticroc February 20, 2015 Title Prognostic ROC curves for evaluating the predictive capacity of a binary test Version 0.7 Date 2013-11-27 Author Y. Foucher

More information

Package xseq. R topics documented: September 11, 2015

Package xseq. R topics documented: September 11, 2015 Package xseq September 11, 2015 Title Assessing Functional Impact on Gene Expression of Mutations in Cancer Version 0.2.1 Date 2015-08-25 Author Jiarui Ding, Sohrab Shah Maintainer Jiarui Ding

More information

Package cancer. July 10, 2018

Package cancer. July 10, 2018 Type Package Package cancer July 10, 2018 Title A Graphical User Interface for accessing and modeling the Cancer Genomics Data of MSKCC. Version 1.14.0 Date 2018-04-16 Author Karim Mezhoud. Nuclear Safety

More information

Backcalculating HIV incidence and predicting AIDS in Australia, Cambodia and Vietnam. Australia

Backcalculating HIV incidence and predicting AIDS in Australia, Cambodia and Vietnam. Australia Backcalculating HIV incidence and predicting AIDS in Australia, Cambodia and Vietnam The aim of today s practical is to give you some hands-on experience with a nonparametric method for backcalculating

More information

A Quick-Start Guide for rseqdiff

A Quick-Start Guide for rseqdiff A Quick-Start Guide for rseqdiff Yang Shi (email: shyboy@umich.edu) and Hui Jiang (email: jianghui@umich.edu) 09/05/2013 Introduction rseqdiff is an R package that can detect differential gene and isoform

More information

Package AbsFilterGSEA

Package AbsFilterGSEA Type Package Package AbsFilterGSEA September 21, 2017 Title Improved False Positive Control of Gene-Permuting GSEA with Absolute Filtering Version 1.5.1 Author Sora Yoon Maintainer

More information

Package p3state.msm. R topics documented: February 20, 2015

Package p3state.msm. R topics documented: February 20, 2015 Package p3state.msm February 20, 2015 Type Package Depends R (>= 2.8.1),survival,base Title Analyzing survival data Version 1.3 Date 2012-06-03 Author Luis Meira-Machado and Javier Roca-Pardinas

More information

LC-MS. Pre-processing (xcms) W4M Core Team. 29/05/2017 v 1.0.0

LC-MS. Pre-processing (xcms) W4M Core Team. 29/05/2017 v 1.0.0 LC-MS Pre-processing (xcms) W4M Core Team 29/05/2017 v 1.0.0 Acquisition files upload and pre-processing with xcms: extraction, alignment and retention time drift correction. SECTION 1 2 LC-MS Data What

More information

Package msgbsr. January 17, 2019

Package msgbsr. January 17, 2019 Type Package Package msgbsr January 17, 2019 Title msgbsr: methylation sensitive genotyping by sequencing (MS-GBS) R functions Version 1.6.1 Date 2017-04-24 Author Benjamin Mayne Maintainer Benjamin Mayne

More information

Package pathifier. August 17, 2018

Package pathifier. August 17, 2018 Type Package Title Quantify deregulation of pathways in cancer Version 1.19.0 Date 2013-06-27 Author Yotam Drier Package pathifier August 17, 2018 Maintainer Assif Yitzhaky

More information

Package MethPed. September 1, 2018

Package MethPed. September 1, 2018 Type Package Version 1.8.0 Date 2016-01-01 Package MethPed September 1, 2018 Title A DNA methylation classifier tool for the identification of pediatric brain tumor subtypes Depends R (>= 3.0.0), Biobase

More information

dataset1 <- read.delim("c:\dca_example_dataset1.txt", header = TRUE, sep = "\t") attach(dataset1)

dataset1 <- read.delim(c:\dca_example_dataset1.txt, header = TRUE, sep = \t) attach(dataset1) Worked examples of decision curve analysis using R A note about R versions The R script files to implement decision curve analysis were developed using R version 2.3.1, and were tested last using R version

More information

Package NarrowPeaks. August 3, Version Date Type Package

Package NarrowPeaks. August 3, Version Date Type Package Package NarrowPeaks August 3, 2013 Version 1.5.0 Date 2013-02-13 Type Package Title Analysis of Variation in ChIP-seq using Functional PCA Statistics Author Pedro Madrigal , with contributions

More information

Package speff2trial. February 20, 2015

Package speff2trial. February 20, 2015 Version 1.0.4 Date 2012-10-30 Package speff2trial February 20, 2015 Title Semiparametric efficient estimation for a two-sample treatment effect Author Michal Juraska , with contributions

More information

Package HAP.ROR. R topics documented: February 19, 2015

Package HAP.ROR. R topics documented: February 19, 2015 Type Package Title Recursive Organizer (ROR) Version 1.0 Date 2013-03-23 Author Lue Ping Zhao and Xin Huang Package HAP.ROR February 19, 2015 Maintainer Xin Huang Depends R (>=

More information

Package sbpiper. April 20, 2018

Package sbpiper. April 20, 2018 Version 1.7.0 Date 2018-04-20 Package sbpiper April 20, 2018 Title Data Analysis Functions for 'SBpipe' Package Depends R (>= 3.2.0) Imports colorramps, data.table, factoextra, FactoMineR, ggplot2 (>=

More information

Package seqcombo. R topics documented: March 10, 2019

Package seqcombo. R topics documented: March 10, 2019 Package seqcombo March 10, 2019 Title Visualization Tool for Sequence Recombination and Reassortment Version 1.5.1 Provides useful functions for visualizing sequence recombination and virus reassortment

More information

Package Actigraphy. R topics documented: January 15, Type Package Title Actigraphy Data Analysis Version 1.3.

Package Actigraphy. R topics documented: January 15, Type Package Title Actigraphy Data Analysis Version 1.3. Type Package Title Actigraphy Data Analysis Version 1.3.2 Date 2016-01-14 Package Actigraphy January 15, 2016 Author William Shannon, Tao Li, Hong Xian, Jia Wang, Elena Deych, Carlos Gonzalez Maintainer

More information

Continuous Wavelet Transform (CWT)

Continuous Wavelet Transform (CWT) cwt Continuous Wavelet Transform (CWT) CWT(Continuous Wavelet Transform) with Mexican Hat wavelet (by default) to match the peaks in Mass Spectrometry spectrum cwt(ms, scales = 1, wavelet = "mexh") ms

More information

Using CART to Mine SELDI ProteinChip Data for Biomarkers and Disease Stratification

Using CART to Mine SELDI ProteinChip Data for Biomarkers and Disease Stratification Using CART to Mine SELDI ProteinChip Data for Biomarkers and Disease Stratification Kenna Mawk, D.V.M. Informatics Product Manager Ciphergen Biosystems, Inc. Outline Introduction to ProteinChip Technology

More information

Genetic Algorithms and their Application to Continuum Generation

Genetic Algorithms and their Application to Continuum Generation Genetic Algorithms and their Application to Continuum Generation Tracy Moore, Douglass Schumacher The Ohio State University, REU, 2001 Abstract A genetic algorithm was written to aid in shaping pulses

More information

Package inctools. January 3, 2018

Package inctools. January 3, 2018 Encoding UTF-8 Type Package Title Incidence Estimation Tools Version 1.0.11 Date 2018-01-03 Package inctools January 3, 2018 Tools for estimating incidence from biomarker data in crosssectional surveys,

More information

Comparing Two ROC Curves Independent Groups Design

Comparing Two ROC Curves Independent Groups Design Chapter 548 Comparing Two ROC Curves Independent Groups Design Introduction This procedure is used to compare two ROC curves generated from data from two independent groups. In addition to producing a

More information

List of Figures. List of Tables. Preface to the Second Edition. Preface to the First Edition

List of Figures. List of Tables. Preface to the Second Edition. Preface to the First Edition List of Figures List of Tables Preface to the Second Edition Preface to the First Edition xv xxv xxix xxxi 1 What Is R? 1 1.1 Introduction to R................................ 1 1.2 Downloading and Installing

More information

Hour 2: lm (regression), plot (scatterplots), cooks.distance and resid (diagnostics) Stat 302, Winter 2016 SFU, Week 3, Hour 1, Page 1

Hour 2: lm (regression), plot (scatterplots), cooks.distance and resid (diagnostics) Stat 302, Winter 2016 SFU, Week 3, Hour 1, Page 1 Agenda for Week 3, Hr 1 (Tuesday, Jan 19) Hour 1: - Installing R and inputting data. - Different tools for R: Notepad++ and RStudio. - Basic commands:?,??, mean(), sd(), t.test(), lm(), plot() - t.test()

More information

Package seqdesign. April 27, Version 1.1 Date

Package seqdesign. April 27, Version 1.1 Date Version 1.1 Date 2015-04-23 Package seqdesign April 27, 2015 Title Simulation and Group Sequential Monitoring of Randomized Two-Stage Treatment Efficacy Trials with Time-to-Event Endpoints Author Michal

More information

PSYCH-GA.2211/NEURL-GA.2201 Fall 2016 Mathematical Tools for Cognitive and Neural Science. Homework 5

PSYCH-GA.2211/NEURL-GA.2201 Fall 2016 Mathematical Tools for Cognitive and Neural Science. Homework 5 PSYCH-GA.2211/NEURL-GA.2201 Fall 2016 Mathematical Tools for Cognitive and Neural Science Homework 5 Due: 21 Dec 2016 (late homeworks penalized 10% per day) See the course web site for submission details.

More information

Package frailtyhl. February 19, 2015

Package frailtyhl. February 19, 2015 Type Package Title Frailty Models via H-likelihood Version 1.1 Date 2012-05-04 Author Il Do HA, Maengseok Noh, Youngjo Lee Package frailtyhl February 19, 2015 Maintainer Maengseok Noh

More information

Early Learning vs Early Variability 1.5 r = p = Early Learning r = p = e 005. Early Learning 0.

Early Learning vs Early Variability 1.5 r = p = Early Learning r = p = e 005. Early Learning 0. The temporal structure of motor variability is dynamically regulated and predicts individual differences in motor learning ability Howard Wu *, Yohsuke Miyamoto *, Luis Nicolas Gonzales-Castro, Bence P.

More information

Package bgafun. R topics documented: August 12, Type Package

Package bgafun. R topics documented: August 12, Type Package Type Package Package bgafun August 12, 2018 Title BGAfun A method to identify specifity determining residues in protein families Version 1.42.0 Date 2007-08-03 Author Iain Wallace Maintainer Iain Wallace

More information

CHAPTER ONE CORRELATION

CHAPTER ONE CORRELATION CHAPTER ONE CORRELATION 1.0 Introduction The first chapter focuses on the nature of statistical data of correlation. The aim of the series of exercises is to ensure the students are able to use SPSS to

More information

Package nopaco. R topics documented: April 13, Type Package Title Non-Parametric Concordance Coefficient Version 1.0.

Package nopaco. R topics documented: April 13, Type Package Title Non-Parametric Concordance Coefficient Version 1.0. Type Package Title Non-Parametric Concordance Coefficient Version 1.0.3 Date 2017-04-10 Package nopaco April 13, 2017 A non-parametric test for multi-observer concordance and differences between concordances

More information

Package CorMut. January 21, 2019

Package CorMut. January 21, 2019 Type Package Package CorMut January 21, 2019 Title Detect the correlated mutations based on selection pressure Version 1.24.0 Date 2018-02-21 Author Maintainer Depends methods,seqinr,igraph

More information

OUTLIER SUBJECTS PROTOCOL (art_groupoutlier)

OUTLIER SUBJECTS PROTOCOL (art_groupoutlier) OUTLIER SUBJECTS PROTOCOL (art_groupoutlier) Paul K. Mazaika 2/23/2009 Outlier subjects are a problem in fmri data sets for clinical populations. This protocol and program are a method to identify outlier

More information

SmartVA-Analyze 2.0 Help

SmartVA-Analyze 2.0 Help SmartVA-Analyze 2.0 Help An instruction manual for using SmartVA-Analyze 2.0, which implements the Tariff 2.0 Method for computer certification of verbal autopsy (VA). Contents Contents Overview System

More information

Package preference. May 8, 2018

Package preference. May 8, 2018 Type Package Package preference May 8, 2018 Title 2-Stage Preference Trial Design and Analysis Version 0.2.2 URL https://github.com/kaneplusplus/preference BugReports https://github.com/kaneplusplus/preference/issues

More information

Package flowtype. R topics documented: July 18, Type Package. Title Phenotyping Flow Cytometry Assays. Version

Package flowtype. R topics documented: July 18, Type Package. Title Phenotyping Flow Cytometry Assays. Version Package flowtype July 18, 2013 Type Package Title Phenotyping Flow Cytometry Assays Version 1.6.0 Date 2011-04-27 Author Nima Aghaeepour Maintainer Nima Aghaeepour Phenotyping Flow

More information

Package diggitdata. April 11, 2019

Package diggitdata. April 11, 2019 Type Package Title Example data for the diggit package Version 1.14.0 Date 2014-08-29 Author Mariano Javier Alvarez Package diggitdata April 11, 2019 Maintainer Mariano Javier Alvarez

More information

Data processing software for TGI/TGE series

Data processing software for TGI/TGE series 1/19 1. Overview Used with TGI or TGE series tensile and compression testing machines, the software enables efficient static strength testing in single tests, cyclical tests, or controlled (customized)

More information

Package singlecase. April 19, 2009

Package singlecase. April 19, 2009 Package singlecase April 19, 2009 Type Package Title statistical tests for single case studies in neuropsychology Version 0.1 Date 2008-05-07 Author Matthieu Dubois Maintainer Matthieu

More information

Package AIMS. June 29, 2018

Package AIMS. June 29, 2018 Type Package Package AIMS June 29, 2018 Title AIMS : Absolute Assignment of Breast Cancer Intrinsic Molecular Subtype Version 1.12.0 Date 2014-06-25 Description This package contains the AIMS implementation.

More information

Reveal Relationships in Categorical Data

Reveal Relationships in Categorical Data SPSS Categories 15.0 Specifications Reveal Relationships in Categorical Data Unleash the full potential of your data through perceptual mapping, optimal scaling, preference scaling, and dimension reduction

More information

AB Sciex QStar XL. AIMS Instrumentation & Sample Report Documentation. chemistry

AB Sciex QStar XL. AIMS Instrumentation & Sample Report Documentation. chemistry Mass Spectrometry Laboratory AIMS Instrumentation & Sample Report Documentation AB Sciex QStar XL chemistry UNIVERSITY OF TORONTO AIMS Mass Spectrometry Laboratory Department of Chemistry, University of

More information

[ APPLICATION NOTE ] High Sensitivity Intact Monoclonal Antibody (mab) HRMS Quantification APPLICATION BENEFITS INTRODUCTION WATERS SOLUTIONS KEYWORDS

[ APPLICATION NOTE ] High Sensitivity Intact Monoclonal Antibody (mab) HRMS Quantification APPLICATION BENEFITS INTRODUCTION WATERS SOLUTIONS KEYWORDS Yun Wang Alelyunas, Henry Shion, Mark Wrona Waters Corporation, Milford, MA, USA APPLICATION BENEFITS mab LC-MS method which enables users to achieve highly sensitive bioanalysis of intact trastuzumab

More information

cn.mops - Mixture of Poissons for CNV detection in NGS data Günter Klambauer Institute of Bioinformatics, Johannes Kepler University Linz

cn.mops - Mixture of Poissons for CNV detection in NGS data Günter Klambauer Institute of Bioinformatics, Johannes Kepler University Linz Software Manual Institute of Bioinformatics, Johannes Kepler University Linz cn.mops - Mixture of Poissons for CNV detection in NGS data Günter Klambauer Institute of Bioinformatics, Johannes Kepler University

More information

ANOVA in SPSS (Practical)

ANOVA in SPSS (Practical) ANOVA in SPSS (Practical) Analysis of Variance practical In this practical we will investigate how we model the influence of a categorical predictor on a continuous response. Centre for Multilevel Modelling

More information

Outlier Analysis. Lijun Zhang

Outlier Analysis. Lijun Zhang Outlier Analysis Lijun Zhang zlj@nju.edu.cn http://cs.nju.edu.cn/zlj Outline Introduction Extreme Value Analysis Probabilistic Models Clustering for Outlier Detection Distance-Based Outlier Detection Density-Based

More information

BIOL 458 BIOMETRY Lab 7 Multi-Factor ANOVA

BIOL 458 BIOMETRY Lab 7 Multi-Factor ANOVA BIOL 458 BIOMETRY Lab 7 Multi-Factor ANOVA PART 1: Introduction to Factorial ANOVA ingle factor or One - Way Analysis of Variance can be used to test the null hypothesis that k or more treatment or group

More information

Analysis of Variance: repeated measures

Analysis of Variance: repeated measures Analysis of Variance: repeated measures Tests for comparing three or more groups or conditions: (a) Nonparametric tests: Independent measures: Kruskal-Wallis. Repeated measures: Friedman s. (b) Parametric

More information

How to interpret scientific & statistical graphs

How to interpret scientific & statistical graphs How to interpret scientific & statistical graphs Theresa A Scott, MS Department of Biostatistics theresa.scott@vanderbilt.edu http://biostat.mc.vanderbilt.edu/theresascott 1 A brief introduction Graphics:

More information

Benchmark Dose Modeling Cancer Models. Allen Davis, MSPH Jeff Gift, Ph.D. Jay Zhao, Ph.D. National Center for Environmental Assessment, U.S.

Benchmark Dose Modeling Cancer Models. Allen Davis, MSPH Jeff Gift, Ph.D. Jay Zhao, Ph.D. National Center for Environmental Assessment, U.S. Benchmark Dose Modeling Cancer Models Allen Davis, MSPH Jeff Gift, Ph.D. Jay Zhao, Ph.D. National Center for Environmental Assessment, U.S. EPA Disclaimer The views expressed in this presentation are those

More information

Package pepdat. R topics documented: March 7, 2015

Package pepdat. R topics documented: March 7, 2015 Package pepdat March 7, 2015 Type Package Title Peptide microarray data package Version 1.0.0 Author Renan Sauteraud, Raphael Gottardo Maintainer Renan Sauteraud Date 2012-08-14 Provides

More information

ECDC HIV Modelling Tool User Manual

ECDC HIV Modelling Tool User Manual ECDC HIV Modelling Tool User Manual Version 1.3.0 European Centre for Disease Prevention and Control 20 December 2017 1 Table of Contents 2 Introduction... 3 2.1 Incidence Method... 3 2.2 London Method...

More information

Probability-Based Protein Identification for Post-Translational Modifications and Amino Acid Variants Using Peptide Mass Fingerprint Data

Probability-Based Protein Identification for Post-Translational Modifications and Amino Acid Variants Using Peptide Mass Fingerprint Data Probability-Based Protein Identification for Post-Translational Modifications and Amino Acid Variants Using Peptide Mass Fingerprint Data Tong WW, McComb ME, Perlman DH, Huang H, O Connor PB, Costello

More information

CNV PCA Search Tutorial

CNV PCA Search Tutorial CNV PCA Search Tutorial Release 8.1 Golden Helix, Inc. March 18, 2014 Contents 1. Data Preparation 2 A. Join Log Ratio Data with Phenotype Information.............................. 2 B. Activate only

More information

Nature Neuroscience: doi: /nn Supplementary Figure 1. Behavioral training.

Nature Neuroscience: doi: /nn Supplementary Figure 1. Behavioral training. Supplementary Figure 1 Behavioral training. a, Mazes used for behavioral training. Asterisks indicate reward location. Only some example mazes are shown (for example, right choice and not left choice maze

More information

cn.mops - Mixture of Poissons for CNV detection in NGS data Günter Klambauer Institute of Bioinformatics, Johannes Kepler University Linz

cn.mops - Mixture of Poissons for CNV detection in NGS data Günter Klambauer Institute of Bioinformatics, Johannes Kepler University Linz Software Manual Institute of Bioinformatics, Johannes Kepler University Linz cn.mops - Mixture of Poissons for CNV detection in NGS data Günter Klambauer Institute of Bioinformatics, Johannes Kepler University

More information

Package cssam. February 19, 2015

Package cssam. February 19, 2015 Type Package Package cssam February 19, 2015 Title cssam - cell-specific Significance Analysis of Microarrays Version 1.2.4 Date 2011-10-08 Author Shai Shen-Orr, Rob Tibshirani, Narasimhan Balasubramanian,

More information

Package CLL. April 19, 2018

Package CLL. April 19, 2018 Type Package Title A Package for CLL Gene Expression Data Version 1.19.0 Author Elizabeth Whalen Package CLL April 19, 2018 Maintainer Robert Gentleman The CLL package contains the

More information

Clustering mass spectrometry data using order statistics

Clustering mass spectrometry data using order statistics Proteomics 2003, 3, 1687 1691 DOI 10.1002/pmic.200300517 1687 Douglas J. Slotta 1 Lenwood S. Heath 1 Naren Ramakrishnan 1 Rich Helm 2 Malcolm Potts 3 1 Department of Computer Science 2 Department of Wood

More information

Comparison of ESI-MS Spectra in MassBank Database

Comparison of ESI-MS Spectra in MassBank Database BMEI 2008 Comparison of ESI-MS Spectra in MassBank Database Hisayuki Horai 1,2, Masanori Arita 1,2,3,4, Takaaki Nishioka 1,2 1 IAB, Keio Univ., 2 JST-BIRD, 3 Univ. of Tokyo, 4 RIKEN PSC 1 Table of Contents

More information

Chapter 1. Introduction

Chapter 1. Introduction Chapter 1 Introduction 1.1 Motivation and Goals The increasing availability and decreasing cost of high-throughput (HT) technologies coupled with the availability of computational tools and data form a

More information

ECDC HIV Modelling Tool User Manual version 1.0.0

ECDC HIV Modelling Tool User Manual version 1.0.0 ECDC HIV Modelling Tool User Manual version 1 Copyright European Centre for Disease Prevention and Control, 2015 All rights reserved. No part of the contents of this document may be reproduced or transmitted

More information

Package CTT. February 4, 2018

Package CTT. February 4, 2018 Type Package Title Classical Test Theory Functions Version 2.3.2 Date 2018-02-02 Author John T. Willse Maintainer John T. Willse Package CTT February 4, 2018 A collection of common test

More information

PROC CORRESP: Different Perspectives for Nominal Analysis. Richard W. Cole. Systems Analyst Computation Center. The University of Texas at Austin

PROC CORRESP: Different Perspectives for Nominal Analysis. Richard W. Cole. Systems Analyst Computation Center. The University of Texas at Austin PROC CORRESP: Different Perspectives for Nominal Analysis Richard W. Cole Systems Analyst Computation Center The University of Texas at Austin 35 ABSTRACT Correspondence Analysis as a fundamental approach

More information

CRITERIA FOR USE. A GRAPHICAL EXPLANATION OF BI-VARIATE (2 VARIABLE) REGRESSION ANALYSISSys

CRITERIA FOR USE. A GRAPHICAL EXPLANATION OF BI-VARIATE (2 VARIABLE) REGRESSION ANALYSISSys Multiple Regression Analysis 1 CRITERIA FOR USE Multiple regression analysis is used to test the effects of n independent (predictor) variables on a single dependent (criterion) variable. Regression tests

More information

Package CompareTests

Package CompareTests Type Package Package CompareTests February 6, 2017 Title Correct for Verification Bias in Diagnostic Accuracy & Agreement Version 1.2 Date 2016-2-6 Author Hormuzd A. Katki and David W. Edelstein Maintainer

More information

R documentation. of GSCA/man/GSCA-package.Rd etc. June 8, GSCA-package. LungCancer metadi... 3 plotmnw... 5 plotnw... 6 singledc...

R documentation. of GSCA/man/GSCA-package.Rd etc. June 8, GSCA-package. LungCancer metadi... 3 plotmnw... 5 plotnw... 6 singledc... R topics documented: R documentation of GSCA/man/GSCA-package.Rd etc. June 8, 2009 GSCA-package....................................... 1 LungCancer3........................................ 2 metadi...........................................

More information

Introduction to SPSS S0

Introduction to SPSS S0 Basic medical statistics for clinical and experimental research Introduction to SPSS S0 Katarzyna Jóźwiak k.jozwiak@nki.nl November 10, 2017 1/55 Introduction SPSS = Statistical Package for the Social

More information

Package QualInt. February 19, 2015

Package QualInt. February 19, 2015 Title Test for Qualitative Interactions Version 1.0.0 Package QualInt February 19, 2015 Author Lixi Yu, Eun-Young Suh, Guohua (James) Pan Maintainer Lixi Yu Description Used for testing

More information

Package EpiEstim. R topics documented: February 19, Version Date 2013/03/08

Package EpiEstim. R topics documented: February 19, Version Date 2013/03/08 Version 1.1-2 Date 2013/03/08 Package EpiEstim February 19, 2015 Title EpiEstim: a package to estimate time varying reproduction numbers from epidemic curves. Author Anne Cori Maintainer

More information

Dividing up the data

Dividing up the data Dividing up the data Stephen Barnes Analysis of the control genistein data The Excel download from the XCMS analysis contained 7840 ion features Too many to load them onto MetaboAnalyst (restricted to

More information

General Single Ion Calibration. Pete 14-May-09

General Single Ion Calibration. Pete 14-May-09 General Single Ion Calibration Pete 14-May-09 Purpose of SI calibration Measure the instrument response of a single ion. Necessary for understanding of error in instrument (counting statistics) Calculation

More information

Lab 4 (M13) Objective: This lab will give you more practice exploring the shape of data, and in particular in breaking the data into two groups.

Lab 4 (M13) Objective: This lab will give you more practice exploring the shape of data, and in particular in breaking the data into two groups. Lab 4 (M13) Objective: This lab will give you more practice exploring the shape of data, and in particular in breaking the data into two groups. Activity 1 Examining Data From Class Background Download

More information

Package propoverlap. R topics documented: February 20, Type Package

Package propoverlap. R topics documented: February 20, Type Package Type Package Package propoverlap February 20, 2015 Title Feature (gene) selection based on the Proportional Overlapping Scores Version 1.0 Date 2014-09-15 Author Osama Mahmoud, Andrew Harrison, Aris Perperoglou,

More information

Introducing.. PIKA (Ochotona princeps)

Introducing.. PIKA (Ochotona princeps) Introducing.. PIKA (Ochotona princeps) Pikas are hearty little mammals who live in rock piles high in the mountains of western North America. PIKA, or Peak Integration by Key Analysis is a software tool

More information

HS Exam 1 -- March 9, 2006

HS Exam 1 -- March 9, 2006 Please write your name on the back. Don t forget! Part A: Short answer, multiple choice, and true or false questions. No use of calculators, notes, lab workbooks, cell phones, neighbors, brain implants,

More information

Metabolomic Data Analysis with MetaboAnalyst

Metabolomic Data Analysis with MetaboAnalyst Metabolomic Data Analysis with MetaboAnalyst User ID: guest6501 April 16, 2009 1 Data Processing and Normalization 1.1 Reading and Processing the Raw Data MetaboAnalyst accepts a variety of data types

More information

Statistical Analysis of Biological Rhythm Data

Statistical Analysis of Biological Rhythm Data Analysis of Biological Rhythms 29 2 Statistical Analysis of Biological Rhythm Data Harold B. Dowse Summary The author has developed an ensemble of digital signal analysis techniques applicable to biological

More information

User Guide. Association analysis. Input

User Guide. Association analysis. Input User Guide TFEA.ChIP is a tool to estimate transcription factor enrichment in a set of differentially expressed genes using data from ChIP-Seq experiments performed in different tissues and conditions.

More information

CIS192 Python Programming

CIS192 Python Programming CIS192 Python Programming Scientific Computing Eric Kutschera University of Pennsylvania March 20, 2015 Eric Kutschera (University of Pennsylvania) CIS 192 March 20, 2015 1 / 28 Course Feedback Let me

More information

How To Use MiRSEA. Junwei Han. July 1, Overview 1. 2 Get the pathway-mirna correlation profile(pmset) and a weighting matrix 2

How To Use MiRSEA. Junwei Han. July 1, Overview 1. 2 Get the pathway-mirna correlation profile(pmset) and a weighting matrix 2 How To Use MiRSEA Junwei Han July 1, 2015 Contents 1 Overview 1 2 Get the pathway-mirna correlation profile(pmset) and a weighting matrix 2 3 Discovering the dysregulated pathways(or prior gene sets) based

More information

Chapter 3 Software Packages to Install How to Set Up Python Eclipse How to Set Up Eclipse... 42

Chapter 3 Software Packages to Install How to Set Up Python Eclipse How to Set Up Eclipse... 42 Table of Contents Preface..... 21 About the Authors... 23 Acknowledgments... 24 How This Book is Organized... 24 Who Should Buy This Book?... 24 Where to Find Answers to Review Questions and Exercises...

More information

Package mediation. September 18, 2009

Package mediation. September 18, 2009 Version 2.1 Date 2009-09-14 Title R Package for Causal Mediation Analysis Package mediation September 18, 2009 Author Luke Keele , Dustin Tingley , Teppei

More information

Package StepReg. November 3, 2017

Package StepReg. November 3, 2017 Type Package Title Stepwise Regression Analysis Version 1.0.0 Date 2017-10-30 Author Junhui Li,Kun Cheng,Wenxin Liu Maintainer Junhui Li Package StepReg November 3, 2017 Description

More information

SimLipid 3.5. Manual PREMIER. Biosoft International Corina Way, Palo Alto, CA Tel: (650) FAX: (650)

SimLipid 3.5. Manual PREMIER. Biosoft International Corina Way, Palo Alto, CA Tel: (650) FAX: (650) SimLipid 3.5 Manual PREMIER Biosoft International 3786 Corina Way, Palo Alto, CA 94303-4504 Tel: (650) 856-2703 FAX: (650) 843-1250 E-mail: sales@premierbiosoft.com Copyright 2003 by PREMIER Biosoft International.

More information

Package longroc. November 20, 2017

Package longroc. November 20, 2017 Type Package Package longroc November 20, 2017 Title Time-Dependent Prognostic Accuracy with Multiply Evaluated Bio Markers or Scores Version 1.0 Date 2017-11-18 Author Alessio Farcomeni Maintainer Alessio

More information

Lipid annotation with MS2Analyzer. Yan Ma 10/24/2013

Lipid annotation with MS2Analyzer. Yan Ma 10/24/2013 Lipid annotation with MS2Analyzer Yan Ma 10/24/2013 Checklist before you start You need to have: 1.A computer with Java environment and Office(2003 or higher) 2.MS/MS spectra in MGF files 3.Latest version

More information

Unsupervised Identification of Isotope-Labeled Peptides

Unsupervised Identification of Isotope-Labeled Peptides Unsupervised Identification of Isotope-Labeled Peptides Joshua E Goldford 13 and Igor GL Libourel 124 1 Biotechnology institute, University of Minnesota, Saint Paul, MN 55108 2 Department of Plant Biology,

More information

To open a CMA file > Download and Save file Start CMA Open file from within CMA

To open a CMA file > Download and Save file Start CMA Open file from within CMA Example name Effect size Analysis type Level Tamiflu Hospitalized Risk ratio Basic Basic Synopsis The US government has spent 1.4 billion dollars to stockpile Tamiflu, in anticipation of a possible flu

More information

LAB ASSIGNMENT 4 INFERENCES FOR NUMERICAL DATA. Comparison of Cancer Survival*

LAB ASSIGNMENT 4 INFERENCES FOR NUMERICAL DATA. Comparison of Cancer Survival* LAB ASSIGNMENT 4 1 INFERENCES FOR NUMERICAL DATA In this lab assignment, you will analyze the data from a study to compare survival times of patients of both genders with different primary cancers. First,

More information

CSDplotter user guide Klas H. Pettersen

CSDplotter user guide Klas H. Pettersen CSDplotter user guide Klas H. Pettersen [CSDplotter user guide] [0.1.1] [version: 23/05-2006] 1 Table of Contents Copyright...3 Feedback... 3 Overview... 3 Downloading and installation...3 Pre-processing

More information

Package TFEA.ChIP. R topics documented: January 28, 2018

Package TFEA.ChIP. R topics documented: January 28, 2018 Type Package Title Analyze Transcription Factor Enrichment Version 0.99.8 Author Laura Puente Santamaría, Luis del Peso Package TFEA.ChIP January 28, 2018 Maintainer Laura Puente Santamaría

More information