Title: | A package for the clinical proteomic profiling data analysis |
---|---|
Description: | Methods for the nalysis of data from clinical proteomic profiling studies. The focus is on the studies of human subjects, which are often observational case-control by design and have technical replicates. A method for sample size determination for planning these studies is proposed. It incorporates routines for adjusting for the expected heterogeneities and imbalances in the data and the within-sample replicate correlations. |
Authors: | Stephen Nyangoma |
Maintainer: | Stephen Nyangoma <[email protected]> |
License: | GPL (>=2) |
Version: | 1.57.0 |
Built: | 2024-10-30 04:40:43 UTC |
Source: | https://github.com/bioc/clippda |
This package is still under development but it is intended to provide
a range of tools for analysing clinical genomics,
methylation and proteomics, data with the non-standard repeated
expression measurments
arising from technical replicates.
Most of these studies are observational
case-control by design and the results of analyses must be
appropriately adjusted for confounding factors and
imbalances in the data.
This regression-type problem is different from the
regression problem in
limma
, in which all the covariates
are some kind
of contrasts
and are
therefore important. Our method is specifically suitable for
analysing single-channel microarrays and proteomics data with repeated
probe, or peak
measurements, especially
in the case where
there is no one-to-one correspondence between cases and controls
and the data cannot be analysed as log-ratios.
In the current version (version 0.1.0),
we are more concerned with the problem of sample size calculations for these data sets.
But some tools for pre-processing of the repeated peaks data,
including tools for checking for the consistency in the
number
of replicates across samples, the consistency of
the peak information
between replicate
spectra and tools for data formatting
and averaging, are included.
clippda
also implements
a routine
for evaluating differential-expression between cases and controls, especially for data
in which each sample is assayed more than once, and are obtained from
studies which are observational, or
those for which the data are heterogeneous
(e.g. data for cancer studies in which controls are not directly sampled,
but are obtained
from samples from suspected cases that turn out to be benign disease,
after an operation, for example.
In this case there could be serious
imbalances in demographics between the cases and controls).
The test statistics considered are derived from the methods developed by Nyangoma
et al. (2009). These new methods for evaluating differential-expression
are compared with the empirical Bayes method in the
limma
package.
To limit the number of false positive discoveries, we control
the tail probability of the proportion of false positives, (TPPFP).
Further details can be found in the package vignette
.
Package: | anRpackage |
Type: | Package |
Version: | 0.1.0 |
Date: | 2009-03-25 |
License: | GPL (>=2) |
LazyLoad: | yes |
This package provides a method for calculating the sample size required when planning
proteomic profiling studies using repeated peak measurements. At the planning stage,
an experimenter typically does not yet have information on the heterogeneity of the data expected.
We provide a method which makes it possible to input, and adjust for the effect of,
the expected
heterogeneity in the sample size
calculations. The code for calculating sample size is
the sampleSize
function. It requires the computation of the
between- and within-sample variations, the differences in mean between
cases and controls, the intraclass correlations
between duplicate
peak data, and the heterogeneity correction factor. These can be computed
from pilot data using the functions:
betweensampleVariance
, withinsampleVariance
,
replicateCorrelations
and FisherInformation
, respectively.
Before the data can be analysed using these functions, it must be adequately
pre-processed,
and this package provides a number of tools for doing this.
We provide a grid of the clinically important differences versus
protein variances (with superimposed sample size contours). On this grid, we
have plotted sample sizes computed using parameters from several real-life
proteomic data
from a range of cancer-types, fluid-types, cancer stages and experimental
protocols of SELDI and MALDI. These values provide sample size
ranges which may be used to estimate the
number of samples required. The example below takes you through some of the processes
of sample size calculations using this package.
Stephen Nyangoma
Maintainer: S Nyangoma [email protected]
Birkner, et al. Issues of processing and multiple testing of SELDI-TOF MS Proteomic Data. Stat Appl Genet Mol Biol 2006, 5.1
Nyangoma, Stephen O.; Collins, Stuart I.; Altman, Douglas G.; Johnson, Philip; and Billingham, Lucinda J. (2012) Sample Size Calculations for Designing Clinical Proteomic Profiling Studies Using Mass Spectrometry, Statistical Applications in Genetics and Molecular Biology: Vol. 11: Iss. 3, Article 2.
Nyangoma SO, et al. Multiple Testing Issues in Discriminating Compound-Related Peaks and Chromatograms from High Frequency Noise, Spikes and Solvent-Based Noise in LC - MS Data Sets. Stat Appl Genet Mol Biol 2007, 6, 1, Article 23
Smyth GK, et al.: Use of within-array replicate spots for assessing differential expression in microarray experiments. Bioinformatics 2005, 21, 2067 - 75
Smyth GK: Linear models and emperical Bayes methods for assessing differential expression in microarray experiments. Stat Appl Genet Mol Biol 2004, 3, 1, Article 3
######################################################################################### # The routine for calculating sample size required when planning a clinical proteomic # profiling study is provided in the sampleSize function. First, this functions performs # computations for sample size parameters, that include: the biological variance, the # tecnical variance, the differences to be estimated, the intraclass correlation # (if unknown). These computations are done ase follows: ######################################################################################### ######################################################################################### # biological variation, difference to be estimated, and the p-values for differential- # expression are computed using the generic function: betweensampleVariance # It requires data of a aclinicalProteomicsData class, as input ######################################################################## ################################################### # Creating data of a aclinicalProteomicsData class ################################################### data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 Data=OBJECT ################################################################################# # Data manipulation carried out internally by the betweensampleVariance function ################################################################################# rawData <- proteomicsExprsData(Data) no.peaks <- [email protected] JUNK_DATA <- sampleClusteredData(rawData,no.peaks) JUNK_DATA=negativeIntensitiesCorrection(JUNK_DATA) # we use the log base 2 expression values LOG_DATA <- log2(JUNK_DATA) ####################################################################################### # compute biological variation, difference to be estimated, and the p-values ####################################################################################### BiovarDiffSig <- betweensampleVariance(OBJECT) BiovarDiffSig ##################### # technical variance ##################### sample_technicalVariance(Data) ####################################################################################### # heterogeneity correction-factor is the second diagonal element of the output # matrix from the fisherInformation function, i.e. from the expected Fisher Information ######################################################################################## Z <- as.vector(fisherInformation(Data)[2,2])/2 Z ################################################################################### # The outputs of these functions are converted into statistics used in # the sample size calculations using a wraper function sampleSizeParameters # it gives the consensus parameter values. You must specify the p-value and the # intraclass correation, cutoff. The description of how these parameters # are chosen is given in Nyangoma, et al. (2009). ################################################################################### intraclasscorr <- 0.60 #cut-off for intraclass correlation signifcut <- 0.05 #significance cut-off sampleparameters=sampleSizeParameters(Data,intraclasscorr,signifcut) ####################################################################################### # SAMPLE SIZE CALCULATIONS #The function sampleSize calculates the protein variance, difference to be estimated, # the technical varaince. These parameters are computed from statistics of peaks with # medium biological variation. # It also gives sample sizes for beta=c(0.90,0.80,0.70) and alpha = c(0.001, 0.01,0.05) ####################################################################################### samplesize <- sampleSize(OBJECT,intraclasscorr,signifcut) samplesize
######################################################################################### # The routine for calculating sample size required when planning a clinical proteomic # profiling study is provided in the sampleSize function. First, this functions performs # computations for sample size parameters, that include: the biological variance, the # tecnical variance, the differences to be estimated, the intraclass correlation # (if unknown). These computations are done ase follows: ######################################################################################### ######################################################################################### # biological variation, difference to be estimated, and the p-values for differential- # expression are computed using the generic function: betweensampleVariance # It requires data of a aclinicalProteomicsData class, as input ######################################################################## ################################################### # Creating data of a aclinicalProteomicsData class ################################################### data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 Data=OBJECT ################################################################################# # Data manipulation carried out internally by the betweensampleVariance function ################################################################################# rawData <- proteomicsExprsData(Data) no.peaks <- Data@no.peaks JUNK_DATA <- sampleClusteredData(rawData,no.peaks) JUNK_DATA=negativeIntensitiesCorrection(JUNK_DATA) # we use the log base 2 expression values LOG_DATA <- log2(JUNK_DATA) ####################################################################################### # compute biological variation, difference to be estimated, and the p-values ####################################################################################### BiovarDiffSig <- betweensampleVariance(OBJECT) BiovarDiffSig ##################### # technical variance ##################### sample_technicalVariance(Data) ####################################################################################### # heterogeneity correction-factor is the second diagonal element of the output # matrix from the fisherInformation function, i.e. from the expected Fisher Information ######################################################################################## Z <- as.vector(fisherInformation(Data)[2,2])/2 Z ################################################################################### # The outputs of these functions are converted into statistics used in # the sample size calculations using a wraper function sampleSizeParameters # it gives the consensus parameter values. You must specify the p-value and the # intraclass correation, cutoff. The description of how these parameters # are chosen is given in Nyangoma, et al. (2009). ################################################################################### intraclasscorr <- 0.60 #cut-off for intraclass correlation signifcut <- 0.05 #significance cut-off sampleparameters=sampleSizeParameters(Data,intraclasscorr,signifcut) ####################################################################################### # SAMPLE SIZE CALCULATIONS #The function sampleSize calculates the protein variance, difference to be estimated, # the technical varaince. These parameters are computed from statistics of peaks with # medium biological variation. # It also gives sample sizes for beta=c(0.90,0.80,0.70) and alpha = c(0.001, 0.01,0.05) ####################################################################################### samplesize <- sampleSize(OBJECT,intraclasscorr,signifcut) samplesize
This is a class object for the mass spectrometry data sets, which are in the same format as the raw data from the Biomarkers wizard software. It has slots of matrices of raw mass spectrometry and phenotypic data sets, a character variable for the classes of all the covariates in the phenotypic data matrix, a character variable for the covariates of interest, and numeric value for the number of peaks of interest.
Objects can be created by calls of the form new("aclinicalProteomicsData", ...)
.
rawSELDIdata
:Object of class "matrix"
phenotypicData
:Object of class "matrix"
variableClass
:Object of class "character"
covariates
:Object of class "character"
no.peaks
:Object of class "numeric"
Display an aclinicalProteomicsData
instance.
S Nyangoma
showClass("aclinicalProteomicsData") data(liverdata) data(liver_pheno) OBJECT = new("aclinicalProteomicsData", rawSELDIdata=as.matrix(liverdata), phenotypicData=as.matrix(liver_pheno), variableClass=c('numeric','factor','factor'), no.peaks=53) show(OBJECT)
showClass("aclinicalProteomicsData") data(liverdata) data(liver_pheno) OBJECT = new("aclinicalProteomicsData", rawSELDIdata=as.matrix(liverdata), phenotypicData=as.matrix(liver_pheno), variableClass=c('numeric','factor','factor'), no.peaks=53) show(OBJECT)
An S4 method for the object aclinicalProteomicsData
class objects.
setClass("clinicalProteomicsData",representation(rawSELDIdata="matrix",phenotypicData="matrix",varInfo="character", variableClass="character",no.peaks="numeric"), prototype(rawSELDIdata=matrix(0),phenotypicData=matrix(0),varInfo=as.character(0),variableClass=as.character(0),no.peaks=0)) slotNames("aclinicalProteomicsData") setMethod("show","aclinicalProteomicsData", function(object) { cat("clinical proteomics data") cat("Type :", class(object), "\n") cat("raw data :", paste(object@rawSELDIdata), "\n") cat("phenotypic data :", paste(object@phenotypicData), "\n") cat("variable information :", paste(object@varInfo), "\n") cat("variable class :", paste(object@variableClass), "\n") cat("number of peaks :", paste([email protected]), "\n") } ) slotNames( new("clinicalProteomicsData")) ## library(clippda) data(liverdata) data(liver_pheno) OBJECT=new("clinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@varInfo=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 show(OBJECT)
setClass("clinicalProteomicsData",representation(rawSELDIdata="matrix",phenotypicData="matrix",varInfo="character", variableClass="character",no.peaks="numeric"), prototype(rawSELDIdata=matrix(0),phenotypicData=matrix(0),varInfo=as.character(0),variableClass=as.character(0),no.peaks=0)) slotNames("aclinicalProteomicsData") setMethod("show","aclinicalProteomicsData", function(object) { cat("clinical proteomics data") cat("Type :", class(object), "\n") cat("raw data :", paste(object@rawSELDIdata), "\n") cat("phenotypic data :", paste(object@phenotypicData), "\n") cat("variable information :", paste(object@varInfo), "\n") cat("variable class :", paste(object@variableClass), "\n") cat("number of peaks :", paste(object@no.peaks), "\n") } ) slotNames( new("clinicalProteomicsData")) ## library(clippda) data(liverdata) data(liver_pheno) OBJECT=new("clinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@varInfo=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 show(OBJECT)
This generic function fits a regression model to the averaged replicate data. The outputs are the between sample variance, and the differences in mean expression between cases and controls, adjusted for confounders.
betweensampleVariance(Data, ...)
betweensampleVariance(Data, ...)
Data |
An object of |
... |
Some methods for this generic function may take additional, optional arguments. At present none do. |
It returns a list with the following components:
betweensamplevariance |
A vector of the between-sample variance for each peak. |
differences |
A vector of the differences in mean expression values between the cases and controls, adjusted for confounders for each peak. |
significance |
A dataframe, or a vector of the differential-expression p-values for each peak. |
Stephen Nyangoma
######################################## ##### methods for the generic function ######################################## showMethods("betweensampleVariance") ################################################### # Creating data of a aclinicalProteomicsData class ################################################### data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 Data=OBJECT ################################################################################# # Data manipulation carried out internally by the betweensampleVariance function ################################################################################# rawData <- proteomicsExprsData(Data) no.peaks <- [email protected] JUNK_DATA <- sampleClusteredData(rawData,no.peaks) JUNK_DATA=negativeIntensitiesCorrection(JUNK_DATA) # we use the log-basetwo2 expression values LOG_DATA <- log2(JUNK_DATA) ####################################################################################### # compute biological variation, difference to be estimated, and the p-values ####################################################################################### BiovarDiffSig <- betweensampleVariance(OBJECT) BiovarDiffSig
######################################## ##### methods for the generic function ######################################## showMethods("betweensampleVariance") ################################################### # Creating data of a aclinicalProteomicsData class ################################################### data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 Data=OBJECT ################################################################################# # Data manipulation carried out internally by the betweensampleVariance function ################################################################################# rawData <- proteomicsExprsData(Data) no.peaks <- Data@no.peaks JUNK_DATA <- sampleClusteredData(rawData,no.peaks) JUNK_DATA=negativeIntensitiesCorrection(JUNK_DATA) # we use the log-basetwo2 expression values LOG_DATA <- log2(JUNK_DATA) ####################################################################################### # compute biological variation, difference to be estimated, and the p-values ####################################################################################### BiovarDiffSig <- betweensampleVariance(OBJECT) BiovarDiffSig
Methods for function betweensampleVariance
are
defined with class "aclinicalProteomicsData" in the signature.
This is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
Sometimes in a mass spectrometry experiment, it happens that
a few samples have been mislabelled. Mislabelling means that some replicates are
in the wrong sample group, and this results in some
samples having more (or less) replicates than the number intended by the experimentalist.
Apart from disparity in the number of replicates due to mislabelling, a few samples, e.g.
the quality control (QC) samples, are often assayed
several times. The aim is to analyze data with the same number of technical
replicates (in this case, duplicates) for every sample.
The function checkNo.replicates
identifies samples with a disparate
number of replicates. The identified samples are treated as follows:
(i) The QC samples can be independently analysed to ascertain the reproducibility of the data.
(ii) The samples with no replicates are discarded from further analysis.
(iii) The samples with more replicates than expected, due to mislabelling (or otherwise), are
pre-processed using the function: mostSimilarTwo
which detects and discards
replicates which give conflicting peak information compared to the rest of the replicates.
Here, the two most similar replicates are treated as the correct replicates for
the sample in question.
checkNo.replicates(rawData, no.peaks, no.replicates)
checkNo.replicates(rawData, no.peaks, no.replicates)
rawData |
Duplicate data in the same format as the raw data from the Biomarker wizard software. |
no.peaks |
The number of peaks detected by the Biomarker wizard |
no.replicates |
The number of replicates intended by the biologist. |
It returns a vector whose elements are labels for samples with a disparate number peaks.
Stephen Nyangoma
data(liverRawData) rawData <- liverRawData no.peaks <- 53 no.replicates <- 2 checkNo.replicates(rawData,no.peaks,no.replicates)
data(liverRawData) rawData <- liverRawData no.peaks <- 53 no.replicates <- 2 checkNo.replicates(rawData,no.peaks,no.replicates)
A function to compute the Z values when planning an experiment with a binary exposure and a binary confounder. You input the probabilities of 3-cells of the resulting multinomial distribution.
f(x, y, z)
f(x, y, z)
x |
Proportion of elements in cell 1 of a multinomial population with four cells. |
y |
Proportion of elements in cell 2 of a multinomial population with four cells. |
z |
Proportion of elements in cell 1 of a multinomial population with four cells. The z here is different from the Z which contains information on the effect of covariates and data imbalance on sample size. |
It returns a single real number (greater than or equal 2), representing Z.
Stephen Nyangoma
Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. (Working paper)
The function ZvaluesformultinomialPlots
# for a 1:1:1:1 experiment x=.25;y=.25;z=.25 # compute Z Z=f(x,y,z) Z ## The function is currently defined as function (x,y,z) { Z=(1-x-z)*(x+y)/(2*(((1-x-z)*(1-x-y)*(1-y-z))-(1-x-y-z)^2)) Z }
# for a 1:1:1:1 experiment x=.25;y=.25;z=.25 # compute Z Z=f(x,y,z) Z ## The function is currently defined as function (x,y,z) { Z=(1-x-z)*(x+y)/(2*(((1-x-z)*(1-x-y)*(1-y-z))-(1-x-y-z)^2)) Z }
This generic function computes the inverse of the expected 'Fisher' information matrix,
I^-1/theta
(see
the definition of theta in section 2.3 of Nyangoma et al
., 2009). The
second diagonal element of this matrix is the variance of the mean difference
between cases and controls, having adjusted for the effect of confounders.
The elements of I
are sums of the proportions
of samples having given attributes, or sums of proportions of class memberships
of given conditional
contingency tables obtained from the cross
tabulated the attributes of the samples under study. Thus it
contains information on the heterogeneity in the
data due to imbalances in the proportions of samples having given
attributes.
fisherInformation(Data, ...)
fisherInformation(Data, ...)
Data |
An object of |
... |
Some methods for this generic function may take additional, optional arguments. At present none do. |
Note that continuous variables must first be discretized, and the variable
names must coincide
with the column
names of PhenoInfo
extracted from the object
.
Currently this function only accepts a maximum of three binary variables.
The existing methods (e.g. Diggle et al. 1997, page 31)
for continuous repeated data
consider only a single exposure variable.
We
recommend that some form of variable selection be used to determine which covariates
to include
in the analysis.
This function returns a matrix: and its second diagonal element (divided by 2) is the
quantity called Z
(or the heterogeneity-correction factor)
in the sample size calculation function, sampleSize
.
Stephen Nyangoma
1. Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ (2009): Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. Bioinformatics (Submitted)
2. Diggle PJ, Heagerty P, Liang K.-Y and Zeger SL. (2002). Analysis of Longitudinal Data (second edition). Oxford: Oxford University Press
######################################################################################### #The matrices of interest are of the form (see eq. 15, 18 and 22 Nyangoma et al. (2009)) ######################################################################################### #Examples are: ################### # 1 binary variable ################### data.frame(x1=c(1,'b'),x2=c('b','b')) ##################### # 2 binary variables ##################### data.frame(x1=c(1,'b','c'),x2=c('b','b','d'),x3=c('c','d','c')) ########################################## # 3 binary variables data.frame(x1=c(1,'b','c','d'),x2=c('b','b','e','f'),x3=c('c','e','c','g'),x4=c('d','f','g','d')) ############################################################################## ############################################################################## # Data # pheno_urine # the phenotypic information of the urine cancer patients and normal controls. ##### # I have discretized protein concentration # concentration<=70 and concentration>70 ########################################## ########################################## #data(pheno_urine) #PhenoInfo <- pheno_urine #variables <- c('Tumor','Sex','Protein_concIndex') #variables=c('Tumor','Sex') #variables=c('Tumor') # Tumor must contain characters "c" and "n" #Protein_concIndex <- pheno_urine[!(pheno_urine$stage == 'late'),]$Protein_conc #Protein_concIndex[Protein_concIndex<=70] <- 0 #Protein_concIndex[Protein_concIndex>70] <- 1 #Protein_concIndex=as.factor(Protein_concIndex) #PhenoInfo <- data.frame(pheno_urine[!(pheno_urine$stage == 'late'),],Protein_concIndex) #FisherInformation(PhenoInfo,variables) data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 inversefisherinformation <- fisherInformation(OBJECT) inversefisherinformation
######################################################################################### #The matrices of interest are of the form (see eq. 15, 18 and 22 Nyangoma et al. (2009)) ######################################################################################### #Examples are: ################### # 1 binary variable ################### data.frame(x1=c(1,'b'),x2=c('b','b')) ##################### # 2 binary variables ##################### data.frame(x1=c(1,'b','c'),x2=c('b','b','d'),x3=c('c','d','c')) ########################################## # 3 binary variables data.frame(x1=c(1,'b','c','d'),x2=c('b','b','e','f'),x3=c('c','e','c','g'),x4=c('d','f','g','d')) ############################################################################## ############################################################################## # Data # pheno_urine # the phenotypic information of the urine cancer patients and normal controls. ##### # I have discretized protein concentration # concentration<=70 and concentration>70 ########################################## ########################################## #data(pheno_urine) #PhenoInfo <- pheno_urine #variables <- c('Tumor','Sex','Protein_concIndex') #variables=c('Tumor','Sex') #variables=c('Tumor') # Tumor must contain characters "c" and "n" #Protein_concIndex <- pheno_urine[!(pheno_urine$stage == 'late'),]$Protein_conc #Protein_concIndex[Protein_concIndex<=70] <- 0 #Protein_concIndex[Protein_concIndex>70] <- 1 #Protein_concIndex=as.factor(Protein_concIndex) #PhenoInfo <- data.frame(pheno_urine[!(pheno_urine$stage == 'late'),],Protein_concIndex) #FisherInformation(PhenoInfo,variables) data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 inversefisherinformation <- fisherInformation(OBJECT) inversefisherinformation
Methods for function fisherInformation
are
defined with class "aclinicalProteomicsData" in the signature.
This is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
A dataframe containing the sample phenotypic information.
data(liver_pheno)
data(liver_pheno)
A data frame with 131 observations on the following 3 variables.
SampleTag
a character/numeric vector of sample ID.
tumor
a factor, with levels c
and n
, describing
the class of the samples.
sex
a factor, with levels F
and M,
describing the gender of the persons
from which the sample has been taken.
Ward DG, Cheng Y, N'Kontchou G, Thar TT, Barget N, Wei W, Billingham LJ, Martin A, Beaugrand M, Johnson PJ: Changes in the serum proteome associated with the development of hepatocellular carcinoma in hepatitis C-related cirrhosis. Br J Cancer. 2006, 94(2):287-92.
Ward DG, Cheng Y, N'Kontchou G, Thar TT, Barget N, Wei W, Billingham LJ, Martin A, Beaugrand M, Johnson PJ: Changes in the serum proteome associated with the development of hepatocellular carcinoma in hepatitis C-related cirrhosis. Br J Cancer. 2006, 94(2):287-92.
data(liver_pheno)
data(liver_pheno)
A dataframe of the duplicate protein expression data, peak information,
sample information (e.g. sample ID, stage, gender, etc.).
This is a pre-processed version of “raw .csv
” file from the
Biomarker wizard. The pre-processing involves filtering out samples with
conflicting peak information, and detecting and discarding samples with no replicates.
data(liverdata)
data(liverdata)
A data frame with 13886 observations on the following 6 variables.
SampleTag
a numeric vector of sample ID.
CancerType
a factor, with levels c
and n
, indicating
cancer class
Spectrum
a numeric vector, indicating the experimental run.
Peak
a numeric vector identifying the peak.
Intensity
a numeric vector of expression values.
Substance.Mass
a numeric vector contaning the m/z (mass-to-charge ratio) value.
Ward DG, Cheng Y, N'Kontchou G, Thar TT, Barget N, Wei W, Billingham LJ, Martin A, Beaugrand M, Johnson PJ: Changes in the serum proteome associated with the development of hepatocellular carcinoma in hepatitis C-related cirrhosis. Br J Cancer. 2006, 94(2):287-92.
Ward DG, Cheng Y, N'Kontchou G, Thar TT, Barget N, Wei W, Billingham LJ, Martin A, Beaugrand M, Johnson PJ: Changes in the serum proteome associated with the development of hepatocellular carcinoma in hepatitis C-related cirrhosis. Br J Cancer. 2006, 94(2):287-92.
####################################################### ####################################################### ## a pre-proceesed version of the raw .csv file from the ## Biomarker wizard. ####################################################### ####################################################### data(liverdata) data(liverRawData) ############################################################################################ ############################################################################################ # liverdata is obtained by pre-processing of the raw .csv file from the Biomarker wizard # as follows. These samples pre-processed to: # (i) discard the information on samples which have no replicate data, and # (ii) for samples with more than 2 replicate expression data, only duplicates with most # similar peak information are retained for use in subsequent analyses. # A wrapper function for executing these two pre-processing steps is preProcRepeatedPeakData ############################################################################################# ############################################################################################# threshold <- 0.80 no.replicates <- 2 no.peaks <- 53 Data <- preProcRepeatedPeakData(liverRawData, no.peaks, no.replicates, threshold) ########################################################################################### ########################################################################################### # Only sample with ID 250 has no replicates and has been omitted from the data to be used # in subsequent analyses. This fact may varified by using: ########################################################################################### ########################################################################################### setdiff(unique(liverRawData$SampleTag),unique(liverdata$SampleTag)) setdiff(unique(Data$SampleTag),unique(liverdata$SampleTag)) ######################################################################### # Now filter out the samples with conflicting replicate peak information # using the spectrumFilter function: ######################################################################### TAGS <- spectrumFilter(Data,threshold,no.peaks)$SampleTag NewRawData2 <- spectrumFilter(Data,threshold,no.peaks) dim(Data) dim(liverdata) dim(NewRawData2) ######################################################################################### ######################################################################################### # In the case of this data (the liver data), all technical replicates have coherent peak # information, since no sample information has been discarded by spectra filter. ######################################################################################### ######################################################################################### ########################################################################################## ########################################################################################## # Let us have a look at what the pre-processing does to samples with more than 2 replicate # spectra. Both samples with IDs 25 and 40 have more than 2 replicates. ########################################################################################## ########################################################################################## length(liverRawData[liverRawData$SampleTag == 25,]$Intensity)/no.peaks length(liverRawData[liverRawData$SampleTag == 40,]$Intensity)/no.peaks ###################################################################################### ###################################################################################### # Take correlations of the log-intensities to find which of the 2 replicates have the # most coherent peak information. ######################################################################################## ######################################################################################## Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) cor(log2(Mat1)) cor(log2(Mat2)) #use mostSimilarTwo function to get duplicate spectra with most coherent peak information Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) sort(mostSimilarTwo(cor(log2(Mat1)))) sort(mostSimilarTwo(cor(log2(Mat2)))) ####################################################################################### ####################################################################################### #Next, check that the pre-processed data, \Robject{NewRawData2}, contains similar # information to liverdata (the allready pre-processed data, included in the clippda). ####################################################################################### ####################################################################################### names(NewRawData2) dim(NewRawData2) names(liverdata) dim(liverdata) setdiff(NewRawData2$SampleTag,liverdata$SampleTag) setdiff(liverdata$SampleTag,NewRawData2$SampleTag) summary(NewRawData2$Intensity) summary(liverdata$Intensity)
####################################################### ####################################################### ## a pre-proceesed version of the raw .csv file from the ## Biomarker wizard. ####################################################### ####################################################### data(liverdata) data(liverRawData) ############################################################################################ ############################################################################################ # liverdata is obtained by pre-processing of the raw .csv file from the Biomarker wizard # as follows. These samples pre-processed to: # (i) discard the information on samples which have no replicate data, and # (ii) for samples with more than 2 replicate expression data, only duplicates with most # similar peak information are retained for use in subsequent analyses. # A wrapper function for executing these two pre-processing steps is preProcRepeatedPeakData ############################################################################################# ############################################################################################# threshold <- 0.80 no.replicates <- 2 no.peaks <- 53 Data <- preProcRepeatedPeakData(liverRawData, no.peaks, no.replicates, threshold) ########################################################################################### ########################################################################################### # Only sample with ID 250 has no replicates and has been omitted from the data to be used # in subsequent analyses. This fact may varified by using: ########################################################################################### ########################################################################################### setdiff(unique(liverRawData$SampleTag),unique(liverdata$SampleTag)) setdiff(unique(Data$SampleTag),unique(liverdata$SampleTag)) ######################################################################### # Now filter out the samples with conflicting replicate peak information # using the spectrumFilter function: ######################################################################### TAGS <- spectrumFilter(Data,threshold,no.peaks)$SampleTag NewRawData2 <- spectrumFilter(Data,threshold,no.peaks) dim(Data) dim(liverdata) dim(NewRawData2) ######################################################################################### ######################################################################################### # In the case of this data (the liver data), all technical replicates have coherent peak # information, since no sample information has been discarded by spectra filter. ######################################################################################### ######################################################################################### ########################################################################################## ########################################################################################## # Let us have a look at what the pre-processing does to samples with more than 2 replicate # spectra. Both samples with IDs 25 and 40 have more than 2 replicates. ########################################################################################## ########################################################################################## length(liverRawData[liverRawData$SampleTag == 25,]$Intensity)/no.peaks length(liverRawData[liverRawData$SampleTag == 40,]$Intensity)/no.peaks ###################################################################################### ###################################################################################### # Take correlations of the log-intensities to find which of the 2 replicates have the # most coherent peak information. ######################################################################################## ######################################################################################## Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) cor(log2(Mat1)) cor(log2(Mat2)) #use mostSimilarTwo function to get duplicate spectra with most coherent peak information Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) sort(mostSimilarTwo(cor(log2(Mat1)))) sort(mostSimilarTwo(cor(log2(Mat2)))) ####################################################################################### ####################################################################################### #Next, check that the pre-processed data, \Robject{NewRawData2}, contains similar # information to liverdata (the allready pre-processed data, included in the clippda). ####################################################################################### ####################################################################################### names(NewRawData2) dim(NewRawData2) names(liverdata) dim(liverdata) setdiff(NewRawData2$SampleTag,liverdata$SampleTag) setdiff(liverdata$SampleTag,NewRawData2$SampleTag) summary(NewRawData2$Intensity) summary(liverdata$Intensity)
A dataframe of the protein expression data, peak information,
sample information (e.g. sample ID, stage, gender, etc.). This is the "raw .csv
" files from the
Biomarker wizard.
data(liverRawData)
data(liverRawData)
A data frame with 14098 observations on the following 6 variables.
SampleTag
a numeric vector of sample ID.
CancerType
a factor, with levels c
and n
, indicating
cancer class
Spectrum
a numeric vector indicating the experimental run.
Peak
a numeric vector identifying a peak.
Intensity
a numeric vector of expression values.
Substance.Mass
a numeric vector indicating the m/z value.
Ward DG, Cheng Y, N'Kontchou G, Thar TT, Barget N, Wei W, Billingham LJ, Martin A, Beaugrand M, Johnson PJ: Changes in the serum proteome associated with the development of hepatocellular carcinoma in hepatitis C-related cirrhosis. Br J Cancer. 2006, 94(2):287-92.
Ward DG, Cheng Y, N'Kontchou G, Thar TT, Barget N, Wei W, Billingham LJ, Martin A, Beaugrand M, Johnson PJ: Changes in the serum proteome associated with the development of hepatocellular carcinoma in hepatitis C-related cirrhosis. Br J Cancer. 2006, 94(2):287-92.
data(liverRawData)
data(liverRawData)
A common practice in the
analysis of repeated mass spectrometry data is to average the replicate expression
values, a method which is only valid if there is some coherence
in the peak information across
replicates.
The function mostSimilarTwo
identifies the two columns of a
matrix (or a dataframe) with the highest pairwise
positive correlations.
The most highly correlated replicates contain the most similar compounds.
This function may also be used to reduce the number of spectra being analysed to two.
mostSimilarTwo(Mat)
mostSimilarTwo(Mat)
Mat |
A dataframe, with the columns being the variables of interest, for example the spectra. |
The main application of this function is in the pre-processing of mass spectrometry data. In a mass spectrometry experiment, it often happens that there is mislabelling of samples, which results in some replicates being assigned to the wrong sample class. This function sifts through this data to identify the two spectra with the most coherent signal information between them. Thus, its function has the potential to help in reducing the number of false-positive discoveries. Its other application is in the reduction of the number of replicates to two, which are then analysed using tools for duplicate peak (or gene) expression data.
It returns a vector with two elements, being the column indices for the two most correlated variables.
Stephen Nyangoma
Ward DG, Nyangoma S, Joy H, Hamilton E, Wei W, Tselepis C, Steven N, Wakelam MJ, Johnson PJ, Ismail T, Martin A: Proteomic profiling of urine for the detection of colon cancer. Proteome Sci. 2008, 16(6):19
n <- 10 Mat <- data.frame(x1=rnorm(n, mean = 0, sd = 1),x2=rnorm(n, mean = 0, sd = 3),x3=rnorm(n, mean = 1, sd = 1),x4= rnorm(n,mean=2,sd=2)) mostSimilarTwo(Mat)
n <- 10 Mat <- data.frame(x1=rnorm(n, mean = 0, sd = 1),x2=rnorm(n, mean = 0, sd = 3),x3=rnorm(n, mean = 1, sd = 1),x4= rnorm(n,mean=2,sd=2)) mostSimilarTwo(Mat)
This function corrects the mass spectra data, which has been pre-processed using
tools tools from the Biomarkers Wizard PROcess
softwares, for the negative
intensities caused by their normalization and background correction
procedures.
negativeIntensitiesCorrection(Data)
negativeIntensitiesCorrection(Data)
Data |
is a dataframe , or a matrix, or a vector, of numerical values. |
A dataframe , or a matrix, or a vector (whichever is the input quantity), of nonnegative numerical values.
Stephen Nyangoma
data(liverdata) no.peaks <- 53 JUNK_DATA <- sampleClusteredData(liverdata,no.peaks) Data=JUNK_DATA Data=JUNK_DATA Data=Data+1 temp=negativeIntensitiesCorrection(Data) temp[,1] Data[,1]
data(liverdata) no.peaks <- 53 JUNK_DATA <- sampleClusteredData(liverdata,no.peaks) Data=JUNK_DATA Data=JUNK_DATA Data=Data+1 temp=negativeIntensitiesCorrection(Data) temp[,1] Data[,1]
A dataframe containing the sample phenotypic information.
data(pheno_urine)
data(pheno_urine)
A data frame with 167 observations on the following 6 variables.
SpectrumTag
a character/numeric vector of sample ID.
Tumor
a factor, with levels c
and n
, describing
the sample class
Age
a numeric vector of age.
Sex
a factor, with levels female
and male
, indicating gender.
stage
a factor, with levels early
, late
and normal
,
indicating tumor stage.
Protein_conc
a numeric vector of urine concentration.
Ward DG, Nyangoma S, Joy H, Hamilton E, Wei W, Tselepis C, Steven N, Wakelam MJ, Johnson PJ, Ismail T, Martin A: Proteomic profiling of urine for the detection of colon cancer. Proteome Sci. 2008, 16(6):19.
Ward DG, Nyangoma S, Joy H, Hamilton E, Wei W, Tselepis C, Steven N, Wakelam MJ, Johnson PJ, Ismail T, Martin A: Proteomic profiling of urine for the detection of colon cancer. Proteome Sci. 2008, 16(6):19.
data(pheno_urine)
data(pheno_urine)
A function to set classes (e.g. as numeric or factor) to the variables in the dataframe.
phenoDataFrame(PhenoData, variableClass)
phenoDataFrame(PhenoData, variableClass)
PhenoData |
is the dataframe of phenotypic information extracted from an |
variableClass |
a character vector of length equal to the number of columns of the dataframe of phenotypic information, giving classes of the variables studied. |
A dataframe of class-corrected phenotypic variables.
Stephen Nyangoma
data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 Data=OBJECT variableClass =Data@variableClass variables = c("SampleTag","tumor","sex") PhenoInfo <- data.frame(Data@phenotypicData) PhenoData <- data.frame(Data@phenotypicData) pData=phenoDataFrame(PhenoData, variableClass) class(pData$sex) class(pData$SampleTag) class(pData$tumor)
data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 Data=OBJECT variableClass =Data@variableClass variables = c("SampleTag","tumor","sex") PhenoInfo <- data.frame(Data@phenotypicData) PhenoData <- data.frame(Data@phenotypicData) pData=phenoDataFrame(PhenoData, variableClass) class(pData$sex) class(pData$SampleTag) class(pData$tumor)
This function pre-processes repeated peak data from the Biomarker wizard.
It identifies, and removes, samples which have no replicates.
Then, for the samples with two or more replicates, it selects and returns data
for the two replicates with most similar expression pattern.
Then, the samples with conflicting
peak information may be removed using the function:
spectrumFilter
.
The output is similar to the liverdata
, a pre-processed data which is included in this package.
preProcRepeatedPeakData(rawData, no.peaks, no.replicates,threshold)
preProcRepeatedPeakData(rawData, no.peaks, no.replicates,threshold)
rawData |
the raw data from the Biomarker wizard. |
no.peaks |
the number of peaks detected by the Biomarker wizard. |
no.replicates |
the intended number of replicates. The departures from this number could be due to mislabelling, quality control (QC) assays, or a few other samples which could have been assayed more times than the majority of samples. |
threshold |
The threshold for declaring expression patterns between duplicates as being “similar”.
It is especially needed in the function |
It returns a dataframe of duplicate expression data for all peaks in the same format as the “.csv” data from the Biomarker wizard.
Stephen Nyangoma
Ward DG, Nyangoma S, Joy H, Hamilton E, Wei W, Tselepis C, Steven N, Wakelam MJ, Johnson PJ, Ismail T, Martin A: Proteomic profiling of urine for the detection of colon cancer. Proteome Sci. 2008, 16(6):19
####################################################### ####################################################### # a pre-proceesed version of the raw .csv file from the # Biomarker wizard. ####################################################### ####################################################### data(liverdata) # allready pre-processed data data(liverRawData) # raw version of liverdata ############################################################################################ ############################################################################################ # These samples pre-processed to: # (i) discard the information on samples which have no replicate data, and # (ii) for samples with more than 2 replicate expression data, only duplicates with most # similar peak information are retained for use in subsequent analyses. # A wrapper function for executing these two pre-processing steps is preProcRepeatedPeakData ############################################################################################# ############################################################################################# threshold <- 0.80 no.replicates <- 2 no.peaks <- 53 Data <- preProcRepeatedPeakData(liverRawData, no.peaks, no.replicates, threshold) ########################################################################################### ########################################################################################### # Only sample with ID 250 has no replicates and has been omitted from the data to be used # in subsequent analyses. This fact may varified by using: ########################################################################################### ########################################################################################### setdiff(unique(liverRawData$SampleTag),unique(liverdata$SampleTag)) setdiff(unique(Data$SampleTag),unique(liverdata$SampleTag)) ######################################################################### # Now filter out the samples with conflicting replicate peak information # using the spectrumFilter function: ######################################################################### #TAGS <- spectrumFilter(Data,threshold,no.peaks)$SampleTag NewRawData2 <- spectrumFilter(Data,threshold,no.peaks) dim(Data) dim(liverdata) dim(NewRawData2) ######################################################################################### ######################################################################################### # In the case of this data (the liver data), all technical replicates have coherent peak # information, since no sample information has been discarded by spectra filter. ######################################################################################### ######################################################################################### ########################################################################################## ########################################################################################## # Let us have a look at what the pre-processing does to samples with more than 2 replicate # spectra. Both samples with IDs 25 and 40 have more than 2 replicates. ########################################################################################## ########################################################################################## length(liverRawData[liverRawData$SampleTag == 25,]$Intensity)/no.peaks length(liverRawData[liverRawData$SampleTag == 40,]$Intensity)/no.peaks ###################################################################################### ###################################################################################### # Take correlations of the log-intensities to find which of the 2 replicates have the # most coherent peak information. ######################################################################################## ######################################################################################## Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) cor(log2(Mat1)) cor(log2(Mat2)) #use mostSimilarTwo function to get duplicate spectra with most coherent peak information Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) sort(mostSimilarTwo(cor(log2(Mat1)))) sort(mostSimilarTwo(cor(log2(Mat2)))) ####################################################################################### ####################################################################################### #Next, check that the pre-processed data, \Robject{NewRawData2}, contains similar # information to liverdata (the allready pre-processed data, included in the clippda). ####################################################################################### ####################################################################################### names(NewRawData2) dim(NewRawData2) names(liverdata) dim(liverdata) setdiff(NewRawData2$SampleTag,liverdata$SampleTag) setdiff(liverdata$SampleTag,NewRawData2$SampleTag) summary(NewRawData2$Intensity) summary(liverdata$Intensity)
####################################################### ####################################################### # a pre-proceesed version of the raw .csv file from the # Biomarker wizard. ####################################################### ####################################################### data(liverdata) # allready pre-processed data data(liverRawData) # raw version of liverdata ############################################################################################ ############################################################################################ # These samples pre-processed to: # (i) discard the information on samples which have no replicate data, and # (ii) for samples with more than 2 replicate expression data, only duplicates with most # similar peak information are retained for use in subsequent analyses. # A wrapper function for executing these two pre-processing steps is preProcRepeatedPeakData ############################################################################################# ############################################################################################# threshold <- 0.80 no.replicates <- 2 no.peaks <- 53 Data <- preProcRepeatedPeakData(liverRawData, no.peaks, no.replicates, threshold) ########################################################################################### ########################################################################################### # Only sample with ID 250 has no replicates and has been omitted from the data to be used # in subsequent analyses. This fact may varified by using: ########################################################################################### ########################################################################################### setdiff(unique(liverRawData$SampleTag),unique(liverdata$SampleTag)) setdiff(unique(Data$SampleTag),unique(liverdata$SampleTag)) ######################################################################### # Now filter out the samples with conflicting replicate peak information # using the spectrumFilter function: ######################################################################### #TAGS <- spectrumFilter(Data,threshold,no.peaks)$SampleTag NewRawData2 <- spectrumFilter(Data,threshold,no.peaks) dim(Data) dim(liverdata) dim(NewRawData2) ######################################################################################### ######################################################################################### # In the case of this data (the liver data), all technical replicates have coherent peak # information, since no sample information has been discarded by spectra filter. ######################################################################################### ######################################################################################### ########################################################################################## ########################################################################################## # Let us have a look at what the pre-processing does to samples with more than 2 replicate # spectra. Both samples with IDs 25 and 40 have more than 2 replicates. ########################################################################################## ########################################################################################## length(liverRawData[liverRawData$SampleTag == 25,]$Intensity)/no.peaks length(liverRawData[liverRawData$SampleTag == 40,]$Intensity)/no.peaks ###################################################################################### ###################################################################################### # Take correlations of the log-intensities to find which of the 2 replicates have the # most coherent peak information. ######################################################################################## ######################################################################################## Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) cor(log2(Mat1)) cor(log2(Mat2)) #use mostSimilarTwo function to get duplicate spectra with most coherent peak information Mat1 <- matrix(liverRawData[liverRawData$SampleTag == 25,]$Intensity,53,3) Mat2 <-matrix(liverRawData[liverRawData$SampleTag == 40,]$Intensity,53,4) sort(mostSimilarTwo(cor(log2(Mat1)))) sort(mostSimilarTwo(cor(log2(Mat2)))) ####################################################################################### ####################################################################################### #Next, check that the pre-processed data, \Robject{NewRawData2}, contains similar # information to liverdata (the allready pre-processed data, included in the clippda). ####################################################################################### ####################################################################################### names(NewRawData2) dim(NewRawData2) names(liverdata) dim(liverdata) setdiff(NewRawData2$SampleTag,liverdata$SampleTag) setdiff(liverdata$SampleTag,NewRawData2$SampleTag) summary(NewRawData2$Intensity) summary(liverdata$Intensity)
This generic function extracts a matrix of duplicate SELDI data from an object of aclinicalProteomicsData class. It then converts it into a dataframe which is in the same format as the data from Biomarkers wizard. In this dataframe, the intensities and the subject mass-to-charge ratio are represented as numeric variables, while the sample-tag is represented as a character variable.
proteomicsExprsData(Data, ...)
proteomicsExprsData(Data, ...)
Data |
is an object of a |
... |
means other defined arguments. Currently, we have not defined additional arguments. |
A dataframe of expression values, the substance mass, patient labels, and any other defined sample information.
S Nyangoma
data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 head(proteomicsExprsData(OBJECT))
data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 head(proteomicsExprsData(OBJECT))
Methods for function proteomicsExprsData
are
defined with class "aclinicalProteomicsData" in the signature.
This is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
This function takes an object of aclinicalProteomicsData
class,
extracts a matrix of phenotypic data, and converts it to a dataframe with
with variables having defined classes.
proteomicspData(Data, ...)
proteomicspData(Data, ...)
Data |
is an object of |
... |
means other defined arguments. Currently, we have not defined additional arguments. |
Returns a dataframe with variables having defined classes.
S Nyangoma
######################################## ##### the data ######################################## data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 head(proteomicspData(OBJECT))
######################################## ##### the data ######################################## data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 head(proteomicspData(OBJECT))
Methods for function proteomicspData
are
defined with class "aclinicalProteomicsData" in the signature.
This is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
This generic function computes intraclass correlations for duplicate peak data.
replicateCorrelations(Data, ...)
replicateCorrelations(Data, ...)
Data |
An object of |
... |
Some methods for this generic function may take additional, optional arguments. At present none do. |
consensus: |
consensus intraclass correlation. |
correlations: |
intraclass correlations for each peak. |
Stephen Nyangoma
Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. Bioinformatics (Submitted)
Smyth GK, et al.: Use of within-array replicate spots for assessing differential expression in microarray experiments. Bioinformatics 2005, 21, 2067 - 75
Smyth GK: Linear models and emperical Bayes methods for assessing differential expression in microarray experiments. Stat Appl Genet Mol Biol 2004, 3, 1, Article 3
data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 replicateCorrelations(OBJECT)
data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 replicateCorrelations(OBJECT)
Methods for function replicateCorrelations
are
defined with class "aclinicalProteomicsData" in the signature.
This is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
This generic function computes the within-sample (technical) variance.
It fits a simple regression model for repeated measures using the mixedModel2
function in the statmod
package.
The technical variance is the block component of the varcomp
output.
sample_technicalVariance(Data, ...)
sample_technicalVariance(Data, ...)
Data |
An object of |
... |
Some methods for this generic function may take additional, optional arguments. At present none do. |
It returns a vector of the within-sample variances, one for each peak.
Stephen Nyangoma
#arrange the data in a form that can be averaged by limma function dupcor # use the function called limmaData data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 sample_technicalVariance(OBJECT)
#arrange the data in a form that can be averaged by limma function dupcor # use the function called limmaData data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 sample_technicalVariance(OBJECT)
Methods for function sample_technicalVariance
are
defined with class "aclinicalProteomicsData" in the signature.
This is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
This function arranges the duplicate data, grouped by samples,
in a form which can be averaged using the limma
function
avedups
.
sampleClusteredData(Data, no.peaks)
sampleClusteredData(Data, no.peaks)
Data |
A data frame of duplicate data from the biomarker wizard. |
no.peaks |
The number of peaks detected by the biomarker wizard. |
The output is a dataframe of repeated sample expression values, clustered by samples.
This data is used as an input to the betweensampleVariance
function, and is then
averaged and used to compute
the biological variance as well as the mean difference in the expression values between
cancer and noncancer controls.
The output is a dataframe of repeated sample expression values, clustered by samples.
Stephen Nyangoma
# arrange the data in a form which can be averaged by the limma function dupcor # use the function called limmaData data(liverdata) no.peaks <- 53 Data <- liverdata JUNK_DATA <- sampleClusteredData(Data,no.peaks)
# arrange the data in a form which can be averaged by the limma function dupcor # use the function called limmaData data(liverdata) no.peaks <- 53 Data <- liverdata JUNK_DATA <- sampleClusteredData(Data,no.peaks)
This generic function sampleSize
calculates the protein variance and the sample size required to estimate the clinically important differences (DIFF
).
The input data are the consensus parameters of peaks with medium biological variation.
sampleSize(Data,intraclasscorr,signifcut, ...)
sampleSize(Data,intraclasscorr,signifcut, ...)
Data |
An object of |
intraclasscorr |
An object of |
signifcut |
An object of |
... |
Some methods for this generic function may take additional, optional arguments. At present none do. |
The sample sizes are computed for various combinations of the power with
values beta=c(0.90,0.80,0.70)
and the significance values, alpha = c(0.001, 0.01,0.05)
.
Note that here we use beta
for power rather
than the conventional 1-beta
.
protein_variance |
consensus protein variance |
replicate_correlation |
consensus intraclass correlation |
sample_size |
the sample size required |
Stephen Nyangoma
Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. Bioinformatics (Submitted)
Smyth GK, et al.: Use of within-array replicate spots for assessing differential expression in microarray experiments. Bioinformatics 2005, 21, 2067 - 75
Smyth GK: Linear models and emperical Bayes methods for assessing differential expression in microarray experiments. Stat Appl Genet Mol Biol 2004, 3, 1, Article 3
######################################################################## ## SAMPLE SIZE ####################################################################### #The function sampleSize calculates the biological variance, differences. #These are the consensus values of peaks with median biological variation # It also gives sample sizes for beta=c(0.90,0.80,0.70) and alpha = c(0.001, 0.01,0.05) #################################################################### #################################################################### #################################################################### intraclasscorr <- 0.60 #cut-off for intraclass correlation signifcut <- 0.05 #significance cut-off data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 sampleSize(OBJECT,intraclasscorr,signifcut) #################################################################### #################################################################### ####################################################################
######################################################################## ## SAMPLE SIZE ####################################################################### #The function sampleSize calculates the biological variance, differences. #These are the consensus values of peaks with median biological variation # It also gives sample sizes for beta=c(0.90,0.80,0.70) and alpha = c(0.001, 0.01,0.05) #################################################################### #################################################################### #################################################################### intraclasscorr <- 0.60 #cut-off for intraclass correlation signifcut <- 0.05 #significance cut-off data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 sampleSize(OBJECT,intraclasscorr,signifcut) #################################################################### #################################################################### ####################################################################
Methods for function sampleSize
are defined with: the class object,
"aclinicalProteomicsData", intraclasscorr, and signifcut, in the signature.
aclinicalProteomicsData
is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
intraclasscorr
is a numeric variable for intraclass correlation,
and signifcut
is the
desired significance value for declearing a protein to be differentially expressed.
Displays the sample sizes computed using the clinically important parameters. This plot complements the contours plot.
sampleSize3DscatterPlots(Z,m,DIFF,VAR,beta,alpha,observedDIFF,observedVAR,observedSampleSize,Angle,Indicator)
sampleSize3DscatterPlots(Z,m,DIFF,VAR,beta,alpha,observedDIFF,observedVAR,observedSampleSize,Angle,Indicator)
Z |
the heterogeneity correction factor. |
m |
the number of replicates |
DIFF |
the clinically important difference. |
VAR |
the protein variance. |
beta |
the power to estimated the clinically important difference. |
alpha |
the significance level. |
observedDIFF |
the clinically important difference from your pilot data. |
observedVAR |
the clinically important variance from your pilot data. |
observedSampleSize |
the sample size estimated from your pilot data. |
Angle |
the angle for setting the orientation of the 3D-scatterplot. |
Indicator |
An indicator variable for controlling items to include in the plot. If it takes the value 1, then the parameters and sample size of previous proteomic profiling studies together with the results from your pilot study are plotted as points on the sample size calculation grid. If it is set to 0, then only the latter will be plotted. |
It returns a 3D plot of sample size against the variance versus differences.
Stephen Nyangoma
1. Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. Bioinformatics, 2009, Submitted
2. Nyangoma SO, Collins SI, Douglas GW, Altman DG, Johnson PJ, and Billingham LJ: Issues in sample size calculations for designing cancer proteomic profiling studies. BMC Bioinformatics, 2009, Submitted
sampleSizeContourPlots
# the plot will be saved in your working directory Z <- 2.460018 m <- 2 ###### DIFF <- seq(0.1,0.50,0.01) VAR <- seq(0.2,4,0.1) beta <- c(0.90,0.80,0.70) alpha <- 1 - c(0.001, 0.01,0.05)/2 #### observedDIFF <- 0.4 observedVAR <- 1.0 observedSampleSize <- 80 ######### # indicator for including results of previous studies on the 3D plot. Indicator <- 1 # sets the orientation of the 3D plot. Angle <- 60 sampleSize3DscatterPlots(Z,m,DIFF,VAR,beta,alpha,observedDIFF,observedVAR,observedSampleSize,Angle,Indicator)
# the plot will be saved in your working directory Z <- 2.460018 m <- 2 ###### DIFF <- seq(0.1,0.50,0.01) VAR <- seq(0.2,4,0.1) beta <- c(0.90,0.80,0.70) alpha <- 1 - c(0.001, 0.01,0.05)/2 #### observedDIFF <- 0.4 observedVAR <- 1.0 observedSampleSize <- 80 ######### # indicator for including results of previous studies on the 3D plot. Indicator <- 1 # sets the orientation of the 3D plot. Angle <- 60 sampleSize3DscatterPlots(Z,m,DIFF,VAR,beta,alpha,observedDIFF,observedVAR,observedSampleSize,Angle,Indicator)
This function draws a grid for calculating the sample size based on the clinically important
values of
variances versus differences.
Based on the analysis of data from past proteomic
profiling studies of cancer, we define the clinically important
parameters as the summary statistics
of
the intensities of the peaks with medium biological
variation. On the grid, you may display
the parameter
values from a wide range of real-life data from past proteomic
profiling studies, including:
data from urine
and serum samples of
early- and
late-stage colorectal cancer patients; serum samples of colorectal cancer patients
assayed on four SELDI chip-types (IMAC, H50, Q10 and CM10);
plasma samples from Limanda limanda fish; and urine samples of
colorectal cancer patients analysed using both
SELDI and MALDI sample processing protocols.
These values may be used as
guidelines for choosing the sample size calculation parameters.
If your study involves profiling samples from
late-stage disease
or sera assayed on the IMAC chip, then the sample
size is probably a value close to that of the outer left contour.
The urine profiling studies require more samples to detect differences
and
the value of the contours to the right
of grid may be used
as bounds.
You may also display parameters and sample size from your pilot study in this grid by
inputting a vector (observedPara
) of
consensus values of the variance and the corresponding difference,
or rbind
several vectors of such parameters into a
matrix/dataframe if you have multiple pilots.
sampleSizeContourPlots(Z,m,DIFF,VAR,beta,alpha,observedPara,Indicator)
sampleSizeContourPlots(Z,m,DIFF,VAR,beta,alpha,observedPara,Indicator)
Z |
the heterogeneity correction factor. |
m |
the number of replicates. |
DIFF |
the clinically important difference. |
VAR |
the protein variance. |
beta |
the power to estimate the clinically important difference. |
alpha |
the significance level. |
observedPara |
a vector or a matrix/dataframe (if there is more than one pilot study) containing the variance(s) and the clinically important difference(s) observed from your pilot data. The first element (column) of the vector (matrix) contains the observed variances, while the second contains the information on the clinically important difference(s). |
Indicator |
an indicator variable. If it is set to 1, then the results of previous proteomic profiling studies together with the results of your pilot study are included in the plot. If it is set to 0, it leads to a plot of only the latter. |
Plots of grids of variance versus the clinically important differences with sample size contours superimposed on it.
Stephen Nyangoma
1. Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. Bioinformatics, 2009, Submitted
2. Nyangoma SO, Collins SI, Douglas GW, Altman DG, Johnson PJ, and Billingham LJ: Issues in sample size calculations for designing cancer proteomic profiling studies. BMC Bioinformatics, 2009, Submitted
# The plot will be saved in your working directory. # On the grid, we have plotted a number of sample sizes we computed from real life data. #From these values you can gauge how many samples you may need. # Fewer samples than 50, will not result in any meaningful estimation of differences. # For late-stage cancer you need the fewest samples, even from a very variable sample such as urine. # You need more samples, over 200, to estimate differences between early stage cancer and #noncancer controls. #etc. m <- 2 DIFF <- seq(0.1,0.50,0.01) # 0.01 VAR <- seq(0.2,4,0.1) beta <- c(0.90,0.80,0.70) alpha <- 1 - c(0.001, 0.01,0.05)/2 Corr <- c(0.70,0.90) #intraclass correlation also fixed Z <- 2.6 # fix at 2.6 or use FisherInformation(???) # You may input parameters from your pilot study. Suppose they are: #observedPara=c(1,0.4) #the variance you computed from pilot data observedPara <- data.frame(var=c(0.7,0.5,1.5),DIFF=c(0.37,0.33,0.43)) # you may set these values to 0, if you do not have pilot data #observedVAR=0 #observedDIFF=0 # in this case the values computed from my pilot studies (dotted on the plot) # may be used as guidelines. Indicator <- 0 #1 sampleSizeContourPlots(Z,m,DIFF,VAR,beta,alpha,observedPara,Indicator)
# The plot will be saved in your working directory. # On the grid, we have plotted a number of sample sizes we computed from real life data. #From these values you can gauge how many samples you may need. # Fewer samples than 50, will not result in any meaningful estimation of differences. # For late-stage cancer you need the fewest samples, even from a very variable sample such as urine. # You need more samples, over 200, to estimate differences between early stage cancer and #noncancer controls. #etc. m <- 2 DIFF <- seq(0.1,0.50,0.01) # 0.01 VAR <- seq(0.2,4,0.1) beta <- c(0.90,0.80,0.70) alpha <- 1 - c(0.001, 0.01,0.05)/2 Corr <- c(0.70,0.90) #intraclass correlation also fixed Z <- 2.6 # fix at 2.6 or use FisherInformation(???) # You may input parameters from your pilot study. Suppose they are: #observedPara=c(1,0.4) #the variance you computed from pilot data observedPara <- data.frame(var=c(0.7,0.5,1.5),DIFF=c(0.37,0.33,0.43)) # you may set these values to 0, if you do not have pilot data #observedVAR=0 #observedDIFF=0 # in this case the values computed from my pilot studies (dotted on the plot) # may be used as guidelines. Indicator <- 0 #1 sampleSizeContourPlots(Z,m,DIFF,VAR,beta,alpha,observedPara,Indicator)
This generic function computes input parameters for the sample size calculation function.
sampleSizeParameters(Data,intraclasscorr,signifcut, ...)
sampleSizeParameters(Data,intraclasscorr,signifcut, ...)
Data |
An object of |
intraclasscorr |
An object of |
signifcut |
An object of |
... |
Some methods for this generic function may take additional, optional arguments. At present none do. |
A list of parameters:
Corr |
the intraclass correlation from your pilot data. |
techVar |
the technical variance from your pilot data. |
bioVar |
the biological variance from your pilot data. |
DIFF |
the clinically important difference from your pilot data. |
no.peaks |
the number of peaks detected by the Biomarker wizard. |
Stephen Nyangoma
Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. Bioinformatics, 2009, Submitted
Smyth GK, et al.: Use of within-array replicate spots for assessing differential expression in microarray experiments. Bioinformatics 2005, 21, 2067 - 75
Smyth GK: Linear models and emperical Bayes methods for assessing differential expression in microarray experiments. Stat Appl Genet Mol Biol 2004, 3, 1, Article 3
intraclasscorr <- 0.60 #cut-off for intraclass correlation signifcut <- 0.05 #significance cut-off data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') [email protected]=53 sampleSizeParameters(OBJECT,intraclasscorr,signifcut)
intraclasscorr <- 0.60 #cut-off for intraclass correlation signifcut <- 0.05 #significance cut-off data(liverdata) data(liver_pheno) OBJECT=new("aclinicalProteomicsData") OBJECT@rawSELDIdata=as.matrix(liverdata) OBJECT@covariates=c("tumor" , "sex") OBJECT@phenotypicData=as.matrix(liver_pheno) OBJECT@variableClass=c('numeric','factor','factor') OBJECT@no.peaks=53 sampleSizeParameters(OBJECT,intraclasscorr,signifcut)
Methods for function sampleSize
are defined with: the class object,
"aclinicalProteomicsData", intraclasscorr, and signifcut, in the signature.
aclinicalProteomicsData
is a class object for the mass spectrometry data sets, which
are in the same format as the raw data from the Biomarkers wizard software.
It has slots of matrices of raw mass spectrometry and phenotypic data sets, a
character variable for the classes of all the covariates in the phenotypic data
matrix, a character variable for the covariates of interest, and numeric value for
the number of peaks of interest. See also aclinicalProteomicsData-class
.
intraclasscorr
is a numeric variable for intraclass correlation,
and signifcut
is the
desired significance value for declearing a protein to be differentially expressed.
Methods for function show
in Package ‘methods’.
object = "aclinicalProteomicsData" This is a class object for the mass spectrometry data sets, which are in the same format as the raw data from the Biomarkers wizard software. It has slots of matrices of raw mass spectrometry and phenotypic data sets, a character variable for the classes of all the covariates in the phenotypic data matrix, a character variable for the covariates of interest, and numeric value for the number of peaks of interest.
This function filters out samples whose spectra have poor pairwise correlations. These samples give conflicting TIC information.
spectrumFilter(Data,threshold,no.peaks)
spectrumFilter(Data,threshold,no.peaks)
Data |
a data frame of duplicate peak data, in the format of "raw .csv" data
from the Biomarker wizard. The original data frame to have the following columns:
|
threshold |
indicates the threshold for rejecting samples whose spectra contain conflicting signal information. |
no.peaks |
the number of peaks. |
A data frame with two columns: the first contains the IDs of the samples meeting the threshold and the second contains the corresponding correlations (i.e. similarities in peak information across spectra).
Stephen Nyangoma
Ward DG, Nyangoma S, Joy H, Hamilton E, Wei W, Tselepis C, Steven N, Wakelam MJ, Johnson PJ, Ismail T, Martin A: Proteomic profiling of urine for the detection of colon cancer. Proteome Sci. 2008, 16(6):19
####################################################### ####################################################### data(liverRawData) # raw version of liverdata ############################################################################################ ############################################################################################ # These samples pre-processed to: # (i) discard the information on samples which have no replicate data, and # (ii) for samples with more than 2 replicate expression data, only duplicates with most # similar peak information are retained for use in subsequent analyses. # A wrapper function for executing these two pre-processing steps is preProcRepeatedPeakData ############################################################################################# ############################################################################################# threshold <- 0.80 no.replicates <- 2 no.peaks <- 53 Data <- preProcRepeatedPeakData(liverRawData, no.peaks, no.replicates, threshold) head(spectrumFilter(Data,threshold,no.peaks))
####################################################### ####################################################### data(liverRawData) # raw version of liverdata ############################################################################################ ############################################################################################ # These samples pre-processed to: # (i) discard the information on samples which have no replicate data, and # (ii) for samples with more than 2 replicate expression data, only duplicates with most # similar peak information are retained for use in subsequent analyses. # A wrapper function for executing these two pre-processing steps is preProcRepeatedPeakData ############################################################################################# ############################################################################################# threshold <- 0.80 no.replicates <- 2 no.peaks <- 53 Data <- preProcRepeatedPeakData(liverRawData, no.peaks, no.replicates, threshold) head(spectrumFilter(Data,threshold,no.peaks))
This function computes the effects of covariates (Z values) needed when designing a study in simple cases where the only covariate available is the cancer class. The Z values computed may, however, be used in more complex setups, when additional covariates are expected.
ztwo(x, y)
ztwo(x, y)
x |
expected proportion of cases |
y |
expected proportion of controls |
produces the Z value
Stephen Nyangoma
Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. (Working paper)
function ZvaluescasesVcontrolsPlots
x=1/3;y=1-x ztwo(x,y)
x=1/3;y=1-x ztwo(x,y)
A function for ploting the odds of being a case vs control and their effects on adjustments for confounders. It may be useful in cases when it is envisaged that no confounders are expected. It automatically plots the values of Z for the common experimental designs (e.g. 1:1, 1:3 and 1:4). You input alarge number of hypothetical ratios of proportions of cases to controls. It uses another function (ztwo), which computes the Z values.
ZvaluescasesVcontrolsPlots(probs)
ZvaluescasesVcontrolsPlots(probs)
probs |
A vector of a large number of hypothetical ratios of proportions of cases to controls. |
It returns a pdf plot of the odds of being a case vs control and their effects on adjustments for confounders.
Stephen Nyangoma
Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. (Working paper)
function ztwo
# provide hypothetical proportions of cases vs controls probs=seq(0,1,0.01) ZvaluescasesVcontrolsPlots(probs)
# provide hypothetical proportions of cases vs controls probs=seq(0,1,0.01) ZvaluescasesVcontrolsPlots(probs)
A functon to plot Density of Z values from a simulation from a multinomial population using the balanced and unbalanced studies and a 3D representaion of the Z values. These plots are useful as visual tools for the confounding effects. The median values are indicated on these plots and these can be used as the consesus values of the effects of covariates in sample size calculations.
ZvaluesfrommultinomPlots(nsim,nobs,proposeddesign,balanceddesign,...)
ZvaluesfrommultinomPlots(nsim,nobs,proposeddesign,balanceddesign,...)
nsim |
number of simulations to be done |
nobs |
number of multinomial observation |
proposeddesign |
a numeric vector with four elements indicating the design weights |
balanceddesign |
a numeric vector with all the four elements being one, indicating equal weights |
... |
other arguments |
This function generates saples from a given four cell multinomial populaton then uses the resulting multinomial probabilities in calculating the effect of covariates (Z values). Currently we implement a design arising from a proteomics study in which there is a binary confounder and a binary exposure. The cross-tabulation of the categories of these covariates results into a 4-cell multinomial categories.
density plot |
Density plot of the Z values |
3D plot of Z values |
3D plot of the Z values against a two dimensional subspace of the 3-D space of multinomial probabilities |
Stephen Nyangoma
Nyangoma SO, Ferreira JA, Collins SI, Altman DG, Johnson PJ, and Billingham LJ: Sample size calculations for planning clinical proteomic profiling studies using mass spectrometry. (Working paper)
Also see the function f.
#density plots nsim=10000;nobs=300;proposeddesign=c(1,2,1,7);balanceddesign=c(1,1,1,1) f=function (x,y,z) { Z=(1-x-z)*(x+y)/(2*(((1-x-z)*(1-x-y)*(1-y-z))-(1-x-y-z)^2)) Z } mul_1=rmultinom(nsim, nobs, prob = proposeddesign)/nobs mul_1=t(mul_1) mul_1=data.frame(mul_1) names(mul_1)=c('x','y','z') x=mul_1$x y=mul_1$y z=mul_1$z # compute Z values (see Nyangoma et al. 2009) Z=f(x,y,z) x1=x y1=y z1=Z ######################################### ##### pr=c(1,1,1,1)# balanced design ######################################### mul_2=rmultinom(nsim, nobs, prob = balanceddesign)/nobs mul_2=t(mul_2) mul_2=data.frame(mul_2) names(mul_2)=c('x','y','z') x=mul_2$x y=mul_2$y z=mul_2$z Zb=f(x,y,z) x2=x y2=y z2=Zb ##################################### ##################################### #summary(Zb) pdf('ZvaluesDensityPlots.pdf') densityZ=density(Z,bw=0.1) densityZb=density(Zb,bw=0.1) plot(density(Zb,bw=0.1),xlim=c(min(c(densityZ$x,densityZb$x)),max(c(densityZ$x,densityZb$x))), ylim=c(min(c(densityZ$y,densityZb$y)),max(c(densityZ$y,densityZb$y))),col='blue',lwd=2,lty=1,xlab='confounding effect - Z values',main='') lines(density(Z,bw=0.1),lwd=2,xlab='',main='') abline(v=median(Z),lty=2,col='red') abline(v=median(Zb),lty=2,col='green') legend(max(c(densityZ$x,densityZb$x)) - 2, max(c(densityZ$y,densityZb$y)) - 0.2, legend=c("blanced","unblanced"), col = c("blue","black"), lty = 1) dev.off() #################################### #################################### library(lattice) library(rgl) library(scatterplot3d) a=c(x1,x2) b=c(y1,y2) Z1=c(z1,z2) group=c(rep(1,10000),rep(2,10000)) Data=data.frame(a,b,Z=Z1,group) Data$group=as.factor(Data$group) Plot3D=cloud(b ~ a*Z,scales = list(arrows = FALSE), data=Data, group=group,screen = list(x = 30, y = -60),ylim=c(0,15),zlim=c(0.05,0.45),xlim=c(0,0.45)) Plot3D nsim=10000;nobs=300;proposeddesign=c(1,2,1,7);balanceddesign=c(1,1,1,1) ZvaluesfrommultinomPlots(nsim,nobs,proposeddesign,balanceddesign)
#density plots nsim=10000;nobs=300;proposeddesign=c(1,2,1,7);balanceddesign=c(1,1,1,1) f=function (x,y,z) { Z=(1-x-z)*(x+y)/(2*(((1-x-z)*(1-x-y)*(1-y-z))-(1-x-y-z)^2)) Z } mul_1=rmultinom(nsim, nobs, prob = proposeddesign)/nobs mul_1=t(mul_1) mul_1=data.frame(mul_1) names(mul_1)=c('x','y','z') x=mul_1$x y=mul_1$y z=mul_1$z # compute Z values (see Nyangoma et al. 2009) Z=f(x,y,z) x1=x y1=y z1=Z ######################################### ##### pr=c(1,1,1,1)# balanced design ######################################### mul_2=rmultinom(nsim, nobs, prob = balanceddesign)/nobs mul_2=t(mul_2) mul_2=data.frame(mul_2) names(mul_2)=c('x','y','z') x=mul_2$x y=mul_2$y z=mul_2$z Zb=f(x,y,z) x2=x y2=y z2=Zb ##################################### ##################################### #summary(Zb) pdf('ZvaluesDensityPlots.pdf') densityZ=density(Z,bw=0.1) densityZb=density(Zb,bw=0.1) plot(density(Zb,bw=0.1),xlim=c(min(c(densityZ$x,densityZb$x)),max(c(densityZ$x,densityZb$x))), ylim=c(min(c(densityZ$y,densityZb$y)),max(c(densityZ$y,densityZb$y))),col='blue',lwd=2,lty=1,xlab='confounding effect - Z values',main='') lines(density(Z,bw=0.1),lwd=2,xlab='',main='') abline(v=median(Z),lty=2,col='red') abline(v=median(Zb),lty=2,col='green') legend(max(c(densityZ$x,densityZb$x)) - 2, max(c(densityZ$y,densityZb$y)) - 0.2, legend=c("blanced","unblanced"), col = c("blue","black"), lty = 1) dev.off() #################################### #################################### library(lattice) library(rgl) library(scatterplot3d) a=c(x1,x2) b=c(y1,y2) Z1=c(z1,z2) group=c(rep(1,10000),rep(2,10000)) Data=data.frame(a,b,Z=Z1,group) Data$group=as.factor(Data$group) Plot3D=cloud(b ~ a*Z,scales = list(arrows = FALSE), data=Data, group=group,screen = list(x = 30, y = -60),ylim=c(0,15),zlim=c(0.05,0.45),xlim=c(0,0.45)) Plot3D nsim=10000;nobs=300;proposeddesign=c(1,2,1,7);balanceddesign=c(1,1,1,1) ZvaluesfrommultinomPlots(nsim,nobs,proposeddesign,balanceddesign)