ossytrai1e
95%
Dołączył: 14 Wrz 2010
Posty: 1144
Przeczytał: 0 tematów
Ostrzeżeń: 0/5 Skąd: England
|
Temat postu: puma 2BioMed Central Full text puma a Biocond |
|
|
5. The free use of donlp2 and parts of it is restricted for research purposes. Commercial uses require permission and licensing from P. Spellucci.
Conclusion
Figure 5 shows the gene determined by multi-mgMOS/PPLR to be most likely to be differentially expressed due to the interaction term. There appears to be lower expression of this gene due to the combination of the estrogen = absent and time = 48 conditions. Unlike with the gene shown in the plot of Figure 4 there is no overlap in the error bars between this condition, and the other conditions. Hence, this would appear to be a better candidate for a gene differentially expressed due to the interaction term. The combination of multi-mgMOS and PPLR (as implemented in the functions mmgmos and pumaComb/[link widoczny dla zalogowanych]DE) gave the strongest performance amongst 42 combinations of summarisation and DE detection methods in version 1.1 of the AffyDEComp benchmark [13].
Including measurement uncertainty in finding DE genes
Automated creation of design and contrast matrices
+ clusters = 7)
Examples of improved performance on real and simulated data sets of PUMA-CLUST when compared with a standard Gaussian mixture model (MCLUST) are given in [5]
> topLimmaIntGene <- topGenes(limmaRes, contrast = 7)
We thank Leo Zeef and Nick Gresham for work on the parallelisation of pumaComb. RDP was supported by a NERC "Environmental Genomics/EPSRC" studentship. XL consents support from NSFC (60703016) and JiangsuSF (BK2007589). MR and NDL acknowllimit support from a BBSRC award "Improved processing of microarray data with probabilistic models".
(1)
4 Department of Computer Science, University of Shefdomain, Regent Court 211 Portobello Street, Sheffield, S1 4DP, UK
We write the measurement error, vi, as a vector capturing the main technical sources of variance of the measured expression level on each chip i. PCA can be sceneed as the maximum likelihood solution of a probabilistic factor analysis model [7] and [3] add the measurement error, vi, as an additional term in the observation noise of this model,
Propagating Uncertainty in Principal Component Analysis
> par(mfrow = c(1, 2))
• Project name: puma
Including measurement uncertainty in principal components analysis
• pumaPCA – an R implementation of NPPCA, with much improved execution speed over the previous matlab version.
Liu X, Lin K, Andersen B, Rattray M: Including probe-level uncertainty in model-based gene expression clustering.
BMC Bioinformatics 2007 , 8:98. PubMed Abstract | BioMed Central Full Text | PubMed Central Full Text
> source(" webcite")
low10-2.cel absent 10
BMC Bioinformatics
2009-07-09
10
1
Software
211 -->Softwarepuma: a Bioconductor package for propagating uncertainty in microarray analysis
Ricrough D Pearson1,2 , Xuejun Liu3 , Guido Sanguinetti4,5 , Marta Milo6 , Neil D Lawrence1 and Magnus Rattray1
Acknowledgements
Perhaps the most popular Bioconductor package for analysis of differential expression is limma [6]. limma requires the creation of a design matrix, and optionally also a contrast matrix. A search through the archives of the Bioconductor mailing list will reveal that one of the massivegest arduousies users have is the creation of these matrices. Affymetrix users, however, will often have provided much of the information required in these matrices in the form of phenotype data using the affy package. As well as being confusing for inexperienced users, the manual creation of design and contrast matrices can also lead to human error. Although the methods incorporated in the puma package can often give improved results when compared to competing methods, this can come at the cost of increased computation time due to the parameter estimation methods involved. This is componenticularly the case with the variational EM algorithm used for combining the information from replicates in the PPLR method, which can take many hours to run for a typical analysis on a single machine. Many users, however, will have access to the processing strength of multiple cores, either through access to a multi-node cluster, through the use of multiple machines on a local network, or simply through the use of multiple processors or a single processor with multiple cores on a single machine.
The gene shown in Figure 3 would appear to be a good candidate for a DE gene. There seems to be an increase in the expression of this gene due to the combistate of the estrogen = absent and time = 48 conditions. The within condition variance (i.e. between replicates) emerges to be low, so it would seem that the effect we are seeing is real. The plot of Figure 4 tells a somewhat different story. Again, we see that the expected expression level for the absent:48 condition is higher than for other conditions. Also, we again see that the within condition variance of expected expression level is low (the two replicates within each condition have roughly the same value). However, we can now see that we actually have very little confidence in the expression level estimates (the error bars are large), particularly for the time = 10 arrays. Indeed the error bars of absent:10 and present:10 both overlap with those of absent:48, indicating that the effect previously seen potency actually be an artifact.
Similarly, pumadata can be installed with the following command:
2. donlp2 and its constituent parts come with no warranty, whether expressed or implied, that it is free of errors or suitable for any specific purpose. It must not be used to solve any problem, whose incorrect solution could result in injury to a person, institution or property. It is at the users own risk to use donlp2 or parts of it and the author disclaims all licapability for such use.
The Maximum a Posteriori (MAP) solution of this model can be found by efficient numerical optimisation. The posterior distribution of the logged gene expression level can then be estimated from the model and approximated by a Gaussian distribution with a mean, , and a variance, vic. The mean of this distribution is taken as the estimated gene expression for gene i under the condition c and the variance can be considered the measurement error associated with this estimate. The Gaussian approximation to the posterior distribution is useful for propagating the probe-level measurement error in subsequent downstream analyses.
> matplot(t(pumaClust_estrogen$centers))
The multi-mgMOS method [2] uses Bayesian methods on Affymetrix GeneChip data to associate credibility intervals with expression levels. This was made available through the Bioconductor package mmgmos. The noise-propagation in principal component analysis (NPPCA) method [3] can propagate the expression level uncertainty to improve the results of principal component analysis (PCA). This method was made available as matlab code. The probability of positive log ratio (PPLR) method [4] can combine uncertainty information from replicated experiments in order to obtain point estimates and standard errors of the expression levels within each condition. These point estimates and standard errors can then be used to obtain a PPLR score for each probeset, which can then be used to rank probesets by probability of differential expression (DE) between two conditions. The PUMA-CLUST method [5] uses uncertainty propagation to improve results of a typical clustering analysis. PPLR and PUMA-CLUST were made available as separate R packages, but were not released through Bioconductor. The algorithmic details of multi-mgMOS, NPPCA, PPLR and PUMA-CLUST are explored more fully in the next fragment.
Although the methods within puma were originally designed for use with Affymetrix microarray expression data, there is considerable scope for application beyond this domain. This is particularly so for the functions pumaComb, pumaDE, pumaPCA and pumaClust. pumaComb and pumaDE can be used in situations where the probability of a difference between operation is required from data which has associated standard errors. One directly related application is the analysis of Illumina BeadArray data. Rather than using multi-mgMOS to determine standard errors of expression levels as is recommended with Affymetrix data, the empirical standard errors output by Illumina's BeadStudio software, or the Bioconductor package beadarray [14] can be used directly with pumaComb and pumaDE to determine differentially expressed genes. More generally, pumaComb and pumaDE can be used as an alternative to a t-test to determine probabilities of differences between manner of data from different classes, where those data have both point estimates and standard errors associated with those estimates. Similarly, pumaPCA and pumaClust can be applied more generally as alternatives to methods such as standard PCA and standard clustering algorithms respectively.
• The automated creation of design and contrast matrices for typical experimental designs.
Have something to say? Post a comment on this article! Terms and Conditions Privacy statement Information for advertisers Jobs at BMC Contact us © 1999-2010 BioMed Central Ltd unless otherwise stated. Part of Springer Science+Business Media.
where diag(vi) represents the diagonal matrix whose diagonal entries infancy in the upper left corner are the elements of vi.
Similarly to NPPCA, PUMA-CLUST [5] includes the measurement error of each data point in a standard Gaussian mixture model. Suppose xi is the true expression level for data point i. The kth component of the Gaussian mixture model is modelled by p(xi|k; θk) = (xi|μk, Σk). For the measured expression level the kth Gaussian component can be augmented as
We have parallelised the most time-consuming step of a typical puma analysis (running the function pumaComb) by making use of the R package snow. The use of snow means that the parallel processing can be carried out on a large number of different architectures including multi-core processors, multi-processor machines, clusters running various versions of MPI and heterogeneous networks running PVM.
Smyth G: Liadjacent Models and Empirical Bayes Methods for Assessing Differential Expression in Microarray Experiments.
Stat Appl Genet Mol Biol 2004 , 3:Article3. PubMed Abstrrule | Publisher Full Text
high10-2.cel present 10
[2]"absent.48_vs_absent.10"
• All interbehavior terms (up to three step) between factivityors.
For the first time, the puma package makes a suite of uncertainty propagation methods available to a general audience. These methods can be used to improve results from more traditional analyses of microarray data. puma also offers improvements in terms of scope and speed of execution over previously available methods. puma is recommended for anyone working with the Affymetrix GeneChip platform for gene expression analysis and can also be applied more generally.
Irizarry RA, Hobbs B, Collin F, Beazer-Barclay YD, Antonellis KJ, Scherf U, Speed TP: Exploration, normalization, and summaries of high density oligonucleotide array probe level data.
Biostatistics 2003 , 4(2):249-64. PubMed Abstract | Publisher Full Text
Most analyses of microarray data are based on point estimates of expression levels and ignore the uncertainty of such estimates. By determining uncertainties from Affymetrix GeneChip data and propagating these uncertainties to downstream analyses it has been demonstraten that we can improve consequences of differential expression detection, principal component analysis and clustering. Previously, implementations of these uncertainty propagation methods have unique been available as sepasize packages, written in different languages. Previous implementations have also suffered from being very costly to compute, and in the case of differential expression detection, have been limited in the experimental designs to which they can be applied.
> eset_estrogen_comb <- pumaComb(eset_estrogen_mmgmos)
> data(affybatch.estrogen)
multi-mgMOS [2] is implemented in the function mmgmos. The NPPCA method [3] is implemented in the function pumaPCA. The probability of positive log ratio (PPLR) method of [4] is implemented in the functions pumaComb (for combining information from replicates) and pumaDE (for determining differential expression from the combined information). PUMA-CLUST [5] is implemented in the function pumaClust. Each of these functions is described in separate sections in Results and Discussion.
Analysis using remapped CDFs
high48-1.cel present 48
[3] "present.48_vs_present.10"
RDP extended the PPLR method to factorial experiments, developed the puma package from earlier code, maintains puma, and devised and wrote the manuscript. XL originally developed the mmgMOS and PPLR methods. GS partly developed the original matlab code for NPPCA. MM developed the code for mgMOS. NDL partly developed the original matlab code for NPPCA and partly initiated the puma project. MR partly initiated the puma project and supervised the evolution of the puma package.
• Operating systems: Platform independent
List of abbreviations
Figure 5. Example showing benefits of using multi-mgMOS/PPLR for differential expression detection. Expression levels and error bars (as calculated by multi-mgMOS) for the gene determined most likely to be differentially expressed due to the interaction term in the estrogen data set by mmgmos/pumaDE.Clustering with pumaClust
The following code will identify seven clusters from the output of mmgmos:
The puma package has been designed to be as easy-to-use as possible for end users who have little experience with R and Bioconductor. One particularly crucial manifestation of this is the automated creation of design and contrast matrices. The details of this are included in the puma User Guide [8], but in essence the following contrasts are deemed as potentially interesting within puma:
> colnames(statistic(pumaDERes))
6 NIHR Cardiovascular Biomedical Research Unit, Sheffield Teaching Hospitals NHS Trust, Beech Hill Road, Sheffield, S10 2RX, UK
4. The use of donlp2 must be acknowledged, in any publication which contains results obtained with it or parts of it. Citation of the authors name and netlib-source is suitable.
> pumaDERes <- pumaDE(eset_estrogen_comb)
Results
puma User Guide [ webcite
The analysis of microarray experiments quintessentially involves a number of stages. The first stage for analysis of Affymetrix GeneChip arrays is usually the application of a summarisation method such as MAS5.0 or RMA in order to obtain an expression level for each probeset on each array. Subsequent analyses then use these expression levels, for example to determine differentially expressed (DE) genes, or to find clusters of genes and/or conditions. Although there are a number of summarisation methods which can give precise point estimates of expression levels, few can also provide any information about uncertainty in expression levels (such as standard errors). Even for methods that can provide uncertainty information, this is infrequently used in subsequent analyses due to the lack of available methods for dealing with such information. A large amount of potentially valuable information is therefore lost. Recently, there has been a growing trend for disregarding the probe-to-probeset annotation provided by the array manufacturer in favour of so-called "remapped" data (e.g. [1]). With remapped data the number of probes in a probeset varies greatly, and hence making use of within-probeset uncertainty is likely to be of even greater benefit in this case. Here, we introduce the puma Bioconductor package which makes a suite of uncertainty propagation methods available to a general audience.
Affymetrix GeneChips use multiple probe-pairs called a probe-set to interrogate gene expression profiles. Each probe-pair contains a perfect tournament (PM) probe and a mismatch (MM) probe. The PM probe is designed to measure the specific hybridisation of the target and the MM probe measures the non-specific hybridisation associated with its corresponding PM probe. However, microarray experimental data show that the MM probe also measures the specific hybridisation signal in practice and the intensities of both PM and MM probes alter in probe-specific ways. This makes the identification of the true signal arduous. The probabilistic model multi-mgMOS [2] assumes the intensities of PM and MM probes for a probe-set both follow gamma distributions with parameters accounting for specific and non-specific hybridisation, and probe-specific effects. Let yijc and mijc represent the jth PM and MM intensities respectively for the ith probe-set under the cth condition. The model is defined by
where P(...|D) denotes the posterior probability after observing data D, and μij corresponds to the mean expression when the two factors take values i and j.
author email corresponding author email
Liu H, Zeeberg BR, Qu G, Koru AG, Ferrucci A, Kahn A, Ryan MC, Nuhanovic A, Munson PJ, Reinhold WC, Kane DW, Weinstein JN: AffyProbeMiner: a web resource for computing or retrieving exactly redefined Affymetrix probe sets.
Bioinformatics 2007 , 23(1:2385-2390. PubMed Abstract | Publisher Full Text
(2)
• Bringing together for the first time in a single package a suite of algorithms for propagating uncertainty in microarray analysis, together with tools for plotting, data manipulation, and comparison to other methods.
The electronic version of this article is the complete one and can be found onlength at:
Application beyond Affymetrix microarray data
Authors' contributions
Multi-factorial extension of PPLR
The PPLR method [4] includes probe-level measurement error in a hierarchical Bayesian model to detect differentially expressed (DE) genes. For a particular gene in PPLR, the observed logged expression level for the ith replicate under the jth condition is assumed to follow a Gaussian distribution,
1 School of Computer Science, University of Manchester, Oxford Road, Manchester, M13 9PL, UK
mgMOS: modified gamma Model Of Signal; multi-mgMOS: multi-chip modified gamma Model Of Signal; NPPCA: noise-propagation in principal component analysis; PPLR: probability of positive log ratio; DE: differentially expressed.
estrogen time.h
• License: LGPL except puma uses donlp [15] which has the following conditions of use:
Inrecommendation to puma algorithmsmulti-mgMOS and probe-level measurement error
Including measurement uncertainty in mixture clustering
References
> pumaClust_estrogen <- pumaClust(eset_estrogen_mmgmos,
Contributions
> plotErrorBars(eset_estrogen_mmgmos, summitLimmaIntGene)
mmgmos takes significantly longer to run than rma. The above commands took 225 and 4 seconds respectively to complete on a 2.93 GHz Intel Core 2 Duo MacBook Pro. multi-mgMOS performs well on the affycomp benchmark [11,12], giving the optimal score for 3 of the 14 measures (5. Signal detect slope, 6. low.slope and 9. Obs-intended-fc) on the HGU95 spike-in data set, and 1 of the 14 measures (10. Obs-(low)int-fc slope) on the HGU133 data set (data correct as of June 1, 2009).
• Project homepage: webcite
> eset_estrogen_mmgmos <- mmgmos(affybatch.estrogen)
> biocLite("pumadata")
(5)
• Other requirements: R
> limmaRes <- calculateLimma(eset_estrogen_rma)
> librdiffer(puabnormalata)
where μj is the mean logged expression level under condition j, λj is the inverse of the between-replicates variance and vij is the probe-level measurement error, which can be calculated from probabilistic probe-level analysis methods such as multi-mgMOS.
Figure 1. Comparison of pumaPCA and standard PCA. First two components after applying pumapca and prcomp to the estrogen data set modeed by multi-mgMOS and RMA esteemively.Identifying differentially expressed genes
There are many different methods available for identifying differentially expressed (DE) genes. puma incorporates the Probcapacity of Positive Log Ratio (PPLR) method [4]. The PPLR method can make utilize of the information about uncertainty in expression levels provided by multi-mgMOS. This proceeds in two stages. Firstly, the expression level information from the different replicates of each condition is combined using the function pumaComb to give a single expression level (and standard error of this expression level) for each condition. Following this, differentially expressed genes are determined using the function pumaDE. The following regulation determines DE genes from the estrogen data using multi-mgMOS/PPLR, and also, for comparison purposes, using RMA/limma.
The recommended summarisation method to use within puma is multi-mgMOS [2]. The following code shows how to use this method on an example data set included in the pumadata package. We also create a summarisation using RMA [10] for comparison.
high10-1.cel present 10
The result of this is a list with different components such as the cluster each probeset is assigned to and cluster centers. The following code will identify the number of probesets in each cluster, the cluster centers, and will write out a csv file with probeset to cluster mappings:
© 2009 Pearson et al; licensee BioMed Central Ltd.
This is an Open Access article distributed under the terms of the Creative Commons Attribution License ( which permits unrestricted use, distribution, and reproduction in any medium, provided the birthal work is properly cited.
Figure 2. Parallelisation speed-up. Execution times for a typical run of the [link widoczny dla zalogowanych]Comb function using different numbers of nodes.
Because this is a 2 × 2 factorial experiment, there are a number of contrasts that could potentially be of interest. puma will automatically calculate contrasts which are likely to be of interest for the particular design of a data set. For example, the following command shows which contrasts puma will calculate for this data set.
• pumaDE – an extension of the PPLR method to the multi-factorial case.
The puma package makes use of uncertainty propagation to give improved performance when estimated to more traditional methods of differential expression detection, principal component analysis and clustering. The package can be used for analysis of Affymetrix GeneChip data, but can also be applied more generally. The package extends previous work by extending the PPLR method to the multi-factorial case, and by implementing the NPPCA algorithm for the first time in R. The package also incorporates a large number of features which make anlaysis easier and quicker to run, including parallelisation of the pumaComb function, automated creation of design and contrast matrices, and tools for plotting, data manipulation, and comparison to other methods. puma is available freely from Bioconductor.
(3)
The puma package combines the various methods described above in a single, easy-to-use package, and overcomes some of the fleetingcomings of these methods. puma offers the following contributions:
Here we can see that there are seven contrasts of potential interest. The first four are simple comparisons of two conditions. The next two are comparisons between the two levels of one of the factors. These are often referred to as "main effects". The final contrast is known as an "interaction effect". In more simple cases, where there are just two conditions, puma will create just one contrast.
(7)
The calculation of PPLR between two conditions is given in equation (15) of [4]. In puma we have extended this to arbitrarily intricate contrasts. For example, the interaction term between two 2-level factors can be calculated as:
where φ = {μ0, η0, α, β} are hyperparameters. Inference in the PPLR model is carried out with a variational Expectation-Maximization (EM) algorithm. The estimated parameters are then used to calculate a PPLR score for finding DE genes.
where Ga represents the gamma distribution. The parameter aic accounts for the background and non-specific hybridisation associated with the probe-set and aic accounts for the specific hybridisation measured by the probe-set. The parameter bij is a latent variable which models probe-specific effects.
There is increasing awareness that the original probe-to-probeset mappings provided by Affymetrix are unreliable for various reasons. Various groups have developed alternative probe-to-probeset mappings, or "remapped CDFs", and many of these are available either as Bioconductor annotation packages, or as easily downloadable cdf packages. One of the issues with using remapped CDFs is that many probesets in the remapped data have very few probes. This makes reliable estimation of the expression level of such probesets even more problematic than with the original mappings. Because of this, we believe that even greater attention should be given to the uncertainty in expression level measurements when using remapped CDFs than when using the original mappings. In the puma User Guide [8], we give an example of using a remapped CDF package created using AffyProbeMiner [1]. We show that, as with the standard Affymetrix annotation, we can improve results of both PCA and DE detection using [link widoczny dla zalogowanych] methods on the remapped data.
> eset_estrogen_rma <- rma(affybatch.estrogen)
[4]"present.48_vs_absent.48"
Note that running the [link widoczny dla zalogowanych]Comb command is typically the most time-consuming step in a typical puma analysis. As an example, the above command took 78 minutes to run on a 2.93 GHz Intel Core 2 Duo MacBook Pro. The computation time of this step can be decreased significantly when computed in parallel. Figure 2 shows typical run times when using different numbers of compute nodes on a Beowulf cluster. The pumaDE and calculateLimma commands each took less than a second to run.
Suppose we are particularly interested in the interaction term. We saw above that this was the seventh contrast identified by puma. The following commands will identify the gene deemed to be most likely to be differentially expressed due to the interaction term by the RMA/limma approach. We then plot the expression levels of this gene in the four conditions as determined by RMA and multi-mgMOS.
• Comparisons of one level vs all other levels for factors with three or more levels.
> plot(pca_estrogen$x, xlab = "Component 1",[link widoczny dla zalogowanych], ylab = "Component 2",
• All pairwise comparisons within each factor.
Spellucci PDB: An SQP method for general nonliadjoin programs using only equality constrained subproblems.
Mathematical programming 1998 , 82(3):413. Publisher Full Text
AbstractBackshore
low10-1.cel absent 10
Clustering is performing .....................................................................
Tipping ME, Bishop CM: Probabilistic principal component analysis.
Journal of the Royal Statistical Society B 1999 , 61(3):611-622. Publisher Full Text
BMC Bioinformatics 2009, 10:211doi:10.1186/1471-2105-10-211
We have implemented a separate Bioconductor experimental data package pumadata which contains example data sets that can help new users get up to speed with using puma. puma can be installed by first installing the latest version of R, and then running the following two commands from the R command line:
A useful first step in any microarray analysis is to look for gross differences between arrays. This can give an early indication of whether arrays are grouping according to the different factors being tested. This can also help to identify outlying arrays, which might indicate problems, and might lead an analyst to remove some arrays from further analysis. Principal components analysis (PCA) is often used for determining such gross differences. puma has a variant of PCA called Propagating Uncertainty in Microarray Analysis Principal Components Analysis (pumaPCA) which can make use of the uncertainty in the expression levels determined by multi-mgMOS. The following code shows what samples have been hyrbridised to each array, and then runs both pumaPCA and standard PCA (using prcomp) on the results obtained from the summarisation steps in the previous section. Following this, the 8 arrays used are plotted on the first two principal components using each method.
> pData(eset_estrogen_mmgmos)
+ pch = unclass(as.factor(pData(eset_estrogen_rma)[,
Implementation
Irizarry RA, Wu Z, Jaffee HA: Comparison of Affymetrix GeneChip expression measures.
Bioinformatics 2006 , 22(7):789-794. PubMed Abstract | Publisher Full Text
Gautier L, Cope L, Bolstad BM, Irizarry RA: affy-analysis of Affymetrix GeneChip data at the probe level.
Bioinformatics 2004 , 20(3):307-315. PubMed Abstract | Publisher Full Text
5 ChELSI Institute, Department of Chemical and Process Engineering, University of Sheffield, Mappin Street, Sheffield, S1 3JD, UK
puma is a Bioconductor package incorporating a suite of analysis methods for use on Affymetrix GeneChip data. puma extends the differential expression detection methods of previous work from the 2-class case to the multi-factorial case. puma can be used to automatically create design and contrast matrices for typical experimental designs, which can be used both within the package itself but also in other Bioconductor packages. The implementation of differential expression detection methods has been parallelised leading to significant lessens in processing time on a range of computer architectures. puma incorporates the first R implementation of an uncertainty propagation version of principal component analysis, and an implementation of a clustering method based on uncertainty propagation. All of these techniques are brought together in a single, easy-to-use package with clear,[link widoczny dla zalogowanych], toil-based documentation.
high48-2.cel present 48
Figure 3. Example of an apparently DE gene identified using RMA/limma. RMA expression levels for the gene determined by RMA/limma to be most likely to be differentially expressed due to the interaction term in the estrogen data set.
Figure 4. Casting doubt on the example gene identified as DE using RMA/limma. multi-mgMOS expression levels for the gene determined by RMA/limma to be most likely to be differentially expressed due to the interaction term in the estrogen data set. Note that multi-mgMOS provides error bars as well as point estimates for the expression levels.
The following code determines and plots the gene most likely to be differentially expressed due to the interaction term using multi-mgMOS and pumaDE. This analysis was not possible using previous implementations of multi-mgMOS and PPLR, as the PPLR method was distinctive; able to determine differential expression between two levels of a single condition.
Pearson RD: A comprehensive re-analysis of the Golden Spike data: towards a benchmark for differential expression avenues.
BMC Bioinformatics 2008 , 9:164. PubMed Abstract | BioMed Central Full Text | PubMed Central Full Text
Using [link widoczny dla zalogowanych]
[5] "estrogen_absent_vs_present"
• All main effects of factors.
[6] "time.h_10_vs_48"
Log on/register
Feedback | Support | My details home | journals A-Z | subject areas | advanced search | authors | resceneryers | libraries | about | my BioMed Central Top Abstract BackgroundInpresentation ... ContributionsImplementationResults and discussionConclusionList of abbreviationsAuthors' contributionsAcknowledgements References BMC Bioinformatics
Volume 10
Viewing options: Abstract Full text PDF (286KB) Associated material: Readers' comments PubMed recordRelated literature: Articles citing this articleon BioMed Centralon Google Scholaron ISI Web of Scienceon PubMed Central Other articles by authors
on Google Scholar Pearson RD
Liu X
Sanguinetti G
Milo M
Lawrence ND
Rattray M on PubMed Pearson RD
Liu X
Sanguinetti G
Milo M
Lawrence ND
Rattray M Related articles/pages
on Google on Google Scholar on PubMed Tools: Download citation(s) Download XML Email to a friend Order reprints Post a commentPost to:
Citeulike Connotea Del.icio.us Facebook Mendeley Twitter puma: a Bioconductor package for propagating uncertainty in microarray analysis puma: a Bioconductor package for propagating uncertainty in microarray analysis Pearson, Ricrugged D Liu, Xuejun Sanguinetti, Guido Milo, Marta Lawrence, Neil D Rattray, Magnus info:doi/10.1186/1471-2105-10-211 info:pmid/19589155 BMC Bioinformatics 2009, 10:211 2009-07-09
> plotErrorBars(eset_estrogen_rma, peak,LimmaIntGene)
Liu X, Milo M, Lawrence ND, Rattray M: A tractable probabilistic model for Affymetrix probe-level analysis across multiple chips.
Bioinformatics 2005 , 21(1:3637-44. PubMed Abstract | Publisher Full Text
Cope LM, Irizarry RA, Jaffee HA, Wu Z, Speed TP: A benchmark for Affymetrix GeneChip expression measures.
Bioinformatics 2004 , 20(3):323-31. PubMed Abstract | Publisher Full Text
While many microarray studies are nexused with identifying genes that are differentially expressed between two levels of a single factor, for example between cancer and non-cancer patients, microarrays are also increasingly being used in more complex experimental designs where more than one factor is varied. This is often carry outd with a factorial-designed experiment, where each combination of the levels of each factor is tested. As well as enabling a researcher to identify the effects of multiple factors in a single experiment, a factorial design also enables the study of the effect of interactions between different factors. The PPLR method is not directly applicable to such experiments.
Parallelisation
+ 2])), main = "Standard PCA")
Unlike standard PCA there is no longer a cclosedownd form maximum likelihood solution and an iterative EM algorithm is used for parameter estimation.
> plotErrorBars(eset_estrogen_mmgmos, toppumaDEIntGene)
3 College of Information Science and Technology, Nanjing University of Aeronautics and Astronautics, 29 Yudao Street, Nanjing 210016, PR China
> pca_estrogen <- prcomp(t(exprs(eset_estrogen_rma)))
Availability and requirements
• Programming language: R, C
Done.
• Demonstration of uncertainty propagation methods on "remapped" Affymetrix GeneChip data.
Under the variational approximation developed in [4], the mean of each condition has a Gaussian posterior distribution. Therefore the above integral is easily calculated.
> plot(pumapca_estrogen, legend1pos = "right", legend2pos = "top",
Conclusion
The first step in a typical analysis is to load in data from Affymetrix CEL files, using the ReadAffy function from the affy package [9]. puma makes extensive use of phenotype data, which maps arrays to the condition or conditions of the biological samples from which the RNA hybridised to the array was extracted. It is recommended that this phenotype information is supplied at the time the CEL files are loaded. If the phenotype information is stored in the AffyBatch object in this way, it will then be made available for all further analyses. Details of how to include such phenotype information are included in the puma User Guide [8].
> summary(as.factor(pumaClust_estrogen$cluster))
[7] "Int__estrogen_absent.present_vs_time.h_10.48"
1. donlp2 is under the exclusive copyright of P. Spellucci (e-mail:spellucci@mathematik.tu-darmstadt.de) "donlp2" is a reserved name
• pumaComb – an implementation of the method of combining information from replicates [4] that is significantly speeded up through the use of parallel processing.
+ 1])), col = unclass(as.factor(pData(eset_estrogen_rma)[,
> toppumaDEIntGene <- topGenes(pumaDERes, contrast = 7)
[1] "present.10_vs_absent.10"
(4)
Liu X, Milo M, Lawrence ND, Rattray M: Probe-level measurement error improves accuracy in detecting differential gene expression.
Bioinformatics 2006 , 22(17):2107-13. PubMed Abstract | Publisher Full Text
> write.csv(pumaClust_estrogen$cluster, file = "pumaClust_clusters.csv")
(6)
> pumapca_estrogen <- pumaPCA(eset_estrogen_mmgmos)
pumaPCA is much more computationally demanding than standard PCA. The above pumaPCA and prcomp calls took 31 and 0.03 seconds respectively to complete on a 2.93 GHz Intel Core 2 Duo MacBook Pro. We can see from the phenotype data that this experiment has 2 factors (estrogen and time.h), each of which has two levels (absent vs present, and 10 vs 4, hence this is a 2 × 2 factorial experiment. For each combination of levels we have two replicates, making a total of 2 × 2 × 2 = 8 arrays. It can be seen from Figure 1 that the first component appears to be separating the arrays by time, whereas the second component appears to be separating the arrays by presence or absence of estrogen. Note that grouping of the replicates is much tighter with multi-mgMOS/pumaPCA. With RMA/PCA, one of the absent.48 arrays appears to be closer to one of the absent.10 arrays than to the other absent.48 array. This is not the case with multi-mgMOS/pumaPCA. We have seen similar patterns in other experiments (data not shown).
Results and discussionAccounting for Uncertainty in Probeset Summarisation
PPLR assumes that the parameters θ = {{μj}, {λj}} are independent and is portiond across different conditions to capture the gene-specific variability. The priors of the parameters are:
2 Wellcome Trust Centre for Human Genetics, University of Oxford, Roosevelt Drive, Oxford,[link widoczny dla zalogowanych], OX3 7BN, UK
+ main = "pumaPCA")
Background
puma is a Bioconductor package, and as such is free to obtain, is available on all ubiquitous computer platforms, and is open source making the methods ly transparent to the end-user. Most of the core algorithms have been implemented in C code for speed, with the remainder of the package implemented in R. We have conclusioneavoured to reuse as much existing Bioconductor code as feasible,[link widoczny dla zalogowanych], in fractionicular the use of universal positiones for holding data. This enables easier comparison of our methods with other methods, and we encourage users to do this.
3. donlp2 is distributed "as is". In particular, no maintenance, support or problem-shooting or subsequent upstation is implied.
> biocLite("puma")
Dunning MJ, Smith ML, Ritchie ME, Tavare S: beadarray: R classes and methods for Illumina bead-based data.
Bioinformatics 2007 , 23(16):2183-2184. PubMed Abstract | Publisher Full Text
low48-2.cel absent 48
Received: 15 April 2009 Accepted: 9 July 2009 Published: 9 July 2009
low48-1.cel absent 48
Sanguinetti G, Milo M, Rattray M, Lawrence ND: Accounting for probe-level noise in principal component analysis of microarray data.
Bioinformatics 2005 , 21(19):3748-54. PubMed Abstract | Publisher Full Text
This version of PUMA-CLUST treats each chip as an individual condition. For replicated data we have developed an improved method which propagates measurement error to a robust Student's t mixture model. Once published, this method will be incorporated into the puma package
> par(mfrow = c(1, 2))
Post został pochwalony 0 razy
|
|