data_analysis

Differences

This shows you the differences between two versions of the page.

Link to this comparison view

Next revision
Previous revision
data_analysis [2021/03/14 08:40]
admin created
data_analysis [2021/05/31 15:43] (current)
admin
Line 1: Line 1:
- +Return to [[start|start page]]
-This links to [[flow_chart#data_preprocessing_/_error_estimation|this Section]].+
  
 <grid> <grid>
-<col xs="6" lg="4">+<col xs="6" sm="6" lg="8">
 <WRAP cblock> <WRAP cblock>
 <markdown> <markdown>
-##   1. Frameworks / Toolboxes 
  
-### 1. D2D+## 1. GSRI
  
-####   1. Short description +### 1. Short description 
- * Framework for modelling dynamical systems+  1. An approach for “gene set analysis”, i.e. for assessing whether a group of functionally related features (genes, RNAs, proteins or …) are regulated. 
 +  2. The GSRI estimates the fraction of significantly regulated features. 
 +  3. For estimation, the empirical cumulative density function (ecdf) of the p-values is analyzed. An iterative estimation procedure is used to unravel the difference to a uniform distribution of p-values (which corresponds to a diagonal line for the ecdf). It also enables calculation of standard errors for the fraction and significance statements. 
 +  4. In contrast to other similar approaches, no reference gene set which is NOT regulated (e.g. “all genes”) is required. 
 +  5. The most prominent similar approach is GSEA (gene set enrichment analysis)
  
-###2. Applicability/restrictions/pitfalls +### 1.2. Applicability/restrictions/pitfalls 
-  * Good for modelling medium sized systems+  1. The approach is applied several times in application project. It works
-  * Compilation of models with many conditions can take a long time.+  2. Drawback: Collaborators weakly tend to more prominent approaches.
  
-###3 Code availability and implementations +### 1.3Code availability 
-* D2D: all+  1. R-package “les” on Bioconductor
  
-###4. Other related methods/points +### 1.4. Publications from the Timmer group 
-* -+  1. https://doi.org/10.1089/cmb.2008.0226
  
-###5. Publications from the Timmer group +### 1.5. Side remark 
-* Raue et al(2015) Data2Dynamics: a modeling environment tailored to parameter estimation in dynamical +  1Weighting of the individual p-values leads to LES 
-systems+
  
-#### 6. Publications from external groups +## 2. LES 
-* https://github.com/Data2Dynamics/d2d/wiki/CitingProjects+### 1. Short description 
 +  1. Local estimate of the fraction of significant p-values 
 +  2. The approach has been developed for tiling arrays. 
 +  3. The approach can be applied if p-values from statistical tests are available in a spatial order (e.g. along the genome) 
 +  4. The GSRI estimates the fraction of significantly regulated features. 
 +  5. A smoothing window is applied in combination (similar to GSRI). 
 +  6. It enables significance statements whether at a certain position a significant fraction of p-values deviate from the uniform distribution. 
 +  7. The outcome can be used to rank genomic regions, i.e. for finding regions of interest. 
 +  8. In contrast to other similar approaches, no reference gene set which is NOT regulated (e.g. “all genes”) is required. 
 +  9The most prominent similar approach is GSEA (gene set enrichment analysis)
  
-### 2. dMod+### 3. Applicability/restrictions/pitfalls 
 +  1. The R-package was implemented by Julian Gehring. Is was one of the most experience R programmer in our group and later become group member in Wolfgang Huber’s lab (a major Bioconductor group). He utilized Bioconductor classes. 
 +  2. There were no other projects with similar data, i.e. where the approach could be applied.
  
-### 3AMICI/ PESTO / pyPESTO / MEMOIR+### 4Code availability 
 +  1. R-package “les” on Bioconductor
  
-####         1Short description +### 5Publications from the Timmer group 
-  * Modeling framework(s) of the Hasenauer Group in Munich / Bonn +  1. Julian Gehring’Masters Thesis
-  * More flexible (to new approaches) because of modularized design +
-  * Similar to D2D, but different ;) +
-  * AMICI: Advanced Multilanguage Interface to CVODES and IDAS +
-  * PESTO: Parameter EStimation TOolbox +
-  * MEMOIR: MATLAB toolbox for Mixed Effect Model InfeRence+
  
-####         2Applicability / restrictions / pitfalls +## 3. TSSi 
-  * All Hass et albenchmark paper models are also available +### 1Short description 
-  * AMICI / PESTO / MEMOIR are written for Matlab, however the Hasenauer group decided to not not further use matlab, if possible +  1Transcription Start Site Identification (TSSi) based on sequencing reads 
-  * pyPESTO is the python version of PESTO (PESTO will be discontinued)+  2. The data did not uniquely indicate TSSs.  
 +  3. The approach has been applied for prediction TSS for the physcomitrella patens genome. The results were available in the standard genome browser for this organism.
  
-####         3Code availability and implementations +### 2Applicability/restrictions/pitfalls 
-  * AMICI: https://github.com/ICB-DCM/AMICI +  1I guess that similar data is not produced any moreTherefore, the approach might be obsolete.
-  * AMICI-Doku: http://icb-dcm.github.io/AMICI/ +
-  * PESTO: https://github.com/ICB-DCM/PESTO +
-  * MEMOIR: https://github.com/ICB-DCM/MEMOIR +
-  * pyPESTO: https://github.com/ICB-DCM/pyPESTO +
-  * pyPESTO-Doku: https://pypesto.readthedocs.io/en/latest/install.html +
-                                 +
-####         4. Publications from external groups +
-  * AMICI: Fröhlich et al. Bioinformatics (2016) / Fröhlich et al. PLOS Comp Biol (2017) +
-  * PESTO: Stapor et al. Bioinformatics (2017) +
-  * MEMOIR: Fröhlich et alBioinformatics (2018)+
  
 +### 3. Availability
 +  1. R-package TSSi
  
-###      4. IQRtools+### 4. Publication from the Timmer group 
 +  1. https://doi.org/10.1093/bioinformatics/bts189
  
-##   2. Generalization/Benchmarking 
  
-###      1. SBML models+## 4. Optimal Transformations 
 +### 1. Short description 
 +  1. The Mean Optimal Transformation Approach (MOTA) was suggested for investigating non-identifiablities.  
 +  2. Based on alternating conditional expectation (ACE) algorithm 
 +  3. Non-parametric method based on kernel estimation to unravel arbitrary dependencies in data 
 +  4. Works also for relations, e.g. a circle 
  
-####         1Short description +### 2Applicability/restrictions/pitfalls 
-  * Representation of biochemical models in XML data format +  1. Since based on kernel estimation restricted to low dimensional problems
-  * In particular, the Benchmark collection and models from the Biomodels database are in SBML format+
  
-####         2Applicability/restrictions/pitfalls +### 3Code availability 
-  * Import and Export works for most Biomodels +  1. R-package MOTA (not maintained any more, see CRAN archive) 
-  * Events, negative fluxes or not-specified fields can throw errors +  2. ACE is available in as R-package “acepack” 
-  * tend should be specified beforehand+  3. Matlab code for ACE is available internally (ask Clemens)
  
-####        3Code availability and implementations +### 4Other related methods 
-  * D2D: arImportSBML, arExportSBML +  1. ACE
-  * dmod: not implemented+
  
-####        4Other related methods/points +### 5Publications from the Timmer group 
-  * SBML data format, Benchmark models+  1. Hengl S et al. Data-based identifiability analysis of nonlinear dynamical models (2007)
  
-####        5Publications from external groups +### 6Publication from external groups 
-  * Biomodels: https://www.ebi.ac.uk/biomodels-main/+  1Breiman & FriedmanEstimating optimal transformations for multiple regression and correlation(1985)
  
-###      2PEtab data format+## 5Error Models
  
-####         1. Short description +## 6. Retarded Transient Function 
-  * Specification of a standard for formulating a parameter estimation problem of an ODE model +### 1. Under development 
-  * Goal: Import & export in all ODE optimization software should be possibleallowing for easy sharing/publishing between tools +### 2. Short description 
-  * Consists of SBML model and three .tsv-files that specify experimental data, measurement conditions and parameter settings+  1. An explicit function which has very similar shape as ODE solutions of signalling pathways 
 +  2. If small amounts of data (observables) are available, the approach might serve as an alternative to traditional ODE modelling. 
 +  3. The approach provides self-explained parameters (amplitudesresponse times, time-scales) 
 +  4It can be directly fit to data in order to have an explicit function describing the time dependency (like a smoothing spline) 
 +  5. It can be fit to ODEs in order to have an approximation of the dynamics as explicit function (e.g. for multiscale models)
  
-####         2Applicability/restrictions/pitfalls +### 3Availability 
-  * Multiple special cases like events, multiple models, and complex parameter transformations might not be captured by the standard+  1D2D is used for fitting 
-  * As of 2019 still under construction+  2See: D2D Example folder (ToyModels/TransientFunction)
  
-####         3Code availability and implementations +### 4Applicability 
-  * Standard is defined in this github  +  1. Fitting is very robust 
-  * D2D: arImportSBML, arExportSBMLarExportBenchmark +  2. For datathe outcome is great in 90% of cases 
-  * dmod: not implemented(But there is a wrapper for pypestowhich might be adaptable for dmod )+  3For approximating ODEsthe performance depends on the model. The accuracy is better than uncertainties of data.
  
-####         4Other related methods/points +### 5Publication 
-  * SBML models, benchmark models+  1. Submitted 
 +</markdown>
  
-###      3. Benchmark models+</WRAP>
  
-####         1. Short description +</col>
-  * Collection of ODE models with experimental data +
-  * Mainly models from Timmer and Hasenauer group +
-  * To use for evaluation of methodologies and algorithms +
-  +
-####         2. Applicability/restrictions/pitfalls +
-  * Models were made available for D2D in the publication (see below) using a Setup.m file. +
-  * PEtab (see above) was developed afterwards. +
-  * Some models take a lot of time to compile / need some tweaking to compile on some machines +
-  * Additional models would be desirable, Hasenauer’s group is supporting efforts in this direction+
  
-####         3. Code availability and implementations 
-  * D2D: arImportSBML, arExportSBML, arExportBenchmark 
-  * dmod: not implemented. (But there is a wrapper for pypesto, which might be adaptable for dmod ) 
-  
-####         4. Publications from the Timmer group 
-  * Hass et al – Benchmark Problems for Dynamic Modeling of Intracellular Processes 
-  * Models: https://github.com/LoosC/Benchmark-Models 
-   
-###      4. Design of Benchmark studies 
  
-##   3. Steady States+<col xs="6" sm="6" lg="4"> 
 +  - [[#gsri|GSRI]] \\ \\  
 +  - [[#les|LES]] \\ \\   
 +  - [[#tssi|TSSi]] \\ \\   
 +  - [[#optimal_transformations|Optimal Transformations]] \\ \\    
 +  - [[#error_models|Error Models]] \\ \\    
 +  - [[#retarded_transient_function|Retarded Transient Function]] \\ \\    
 +</col>
  
-###      1. Presimulation 
- 
-####         1. Short description 
-  * When analytical expressions are not available steady states can be determined by presimulation. 
-  * Simulate the model for a long time. 
-  * Very robust 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Equilibration by simulation is not always possible (limit cycles, unstable systems etc). In such cases one can use arPlotEquilibration to debug the situation. 
-  * It can be slower than the alternative. 
-  * Very long equilibration times can lead to loss of conserved moieties in the model as error accumulates. 
-  * For models with no conserved moieties, steady state sensitivities can be computed without simulating the sensitivity equations (D2D: see arReduce.m). 
-  *  
-  * Compilation of models with many conditions can take a long time. 
- 
-####         3. Code availability and implementations 
-  * D2D: arSteadyState.m / arPrintSteadyState.m / arPlotEquilibration.m 
- 
-####         4. Other related methods/points 
-  * Steady states by constraints. See also the D2D documentation 
- 
-####         5. Publications from the Timmer group 
-  * - 
- 
-####         6. Publications from external groups 
-  * Fiedler et al. 2016 - Tailored parameter optimization methods for ordinary differential equation models with steady-state constraints 
- 
-### 2. Analytical 
- 
-### 3. Numerical 
- 
-### 4. Implicit 
- 
-####         1. Short description 
-  * Determine steady states by prestimulation. 
-  * Can be orders of magnitude faster for big steady state systems (200x speedup in glycolysis). 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Models without conserved moieties. 
-  * Model may contain *no* conserved moieties, or this method produces invalid sensitivities. 
-  * Note that new conserved moieties can arise from setting parameters to zero in such a way that new conserved moieties are created at run time. 
-          
-####         3. Code availability and implementations 
- 
-  * D2D: arReduce.m / arSteadyState.m / arFastSensis.m 
-          
-####         4. Other related methods/points 
-  * - 
-          
-####         5. Publications from the Timmer group 
-  * - 
-          
-####         6. Publications from external groups 
-  * - 
- 
-##   4. Input Estimation 
- 
-###      1. Parametric (Schelker) 
- 
-####         1. Short description 
-  * Inputs are described by smoothing splines. 
-  * The spline parameters are estimated jointly with all other model parameters 
-  * Joint uncertainty analysis is then straight forward (e.g. via likelihood profiles which takes information from all data points and account for uncertainties of the input) 
-  * In order to ensure positivity of the spline, the log-transformation is exploited 
-          
-####         2. Availability 
-  * The approach is implemented in D2D and is exploited by default if an input has parameters. 
- 
-####         3. Applicability 
-  * It is tested in many projects. It works. 
-  * Drawing spline parameter might lead to ODE integration problems because exponentiation steps (unlog of parameters, unlog of the spline) 
-          
-####         4. Publication 
-  * doi.org/10.1093/bioinformatics/bts393 
-       
-###      2. Non-Parametric (Kaschek) 
- 
-##   5. Experimental Design 
-       
-###      1. For parameter estimation (Steiert 2012) 
- 
-####         1. Evaluation of predictions for all parameter vectors obtained during profile likelihood calculation 
-          
-####         2. The DREAM6 approach 
- 
-####         3. Implemented in D2D as arPLETrajectories 
- 
-###      2. For parameter estimation and model discrimination (Kreutz 2009) 
- 
-####         1. The Monte-Carlo approach (for model discrimination): 
-  * Drawing the correct model according to available prior knowledge 
-  * Drawing true parameters according to available prior knowledge 
-  * Drawing data for the design candidates 
-  * For each design and data set: Fit both models, apply the likelihood ratio test and evaluate the result 
-  
-####         2. The corresponding approach can be used for parameter estimation. Parameter information has to be evaluated instead of the likelihood ratio test. In the original publication, the metrics based on the Fisher Information matrix were discussed. Profile likelihood-based approaches can be used instead. 
-          
-####         3. Publication 
- * https://doi.org/10.1111/j.1742-4658.2008.06843.x 
- 
-###    3. 2D profiles 
- 
-#### 1. Short description 
-  * For an experimental condition of interest, generate a profile which varies parameter of interest and validation data point simultaneously 
-  * Predict the information gain (profile width) for a measurement for this condition 
-  * Work in progress, coming soon 
- 
-###      4. Profile likelihood (Raue 2011) 
- 
-##   6. Integration Methods 
- 
-###      1. Multiple Shooting 
- 
-####         1. Short description 
-  * Initial value approach fails for periodic or chaotic processes 
-  * Likelihood has huge amount of local optima 
-  * Idea:  
-    * Divide time axis in many segments 
-    * Fit simultaneously in all segments 
-    * Consider continuity constraint between segment in linearised fashion 
-    * Very powerful method 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Applicable only to absolute deterministic systems 
-  * Stochasticity in oscillatory or chaotic processes does not allow for a deterministic description 
- 
-####         3. Code availability and implementations 
-  * http://jeti.uni-freiburg.de/papers/diffit.zip 
-          
-####         4. Other related method 
-  * No 
- 
-####         5. Publication from the Timmer group 
-  * Peifer M., Timmer J.  Parameter estimation in ordinary differential equations for biochemical processes using the method of multiple shooting. (2007) 
- 
-####         6. Publications from external groups 
-  * Bock - Numerical treatment of inverse problems in chemical reaction kinetics (1981) 
-  * Bock - Recent advances in parameter identification techniques for ordinary differential equations (1983) 
- 
- 
- 
- 
-##   7. Optimization/Improving your waterfall plot 
- 
-###      1. Optimerger / Optimal paths between parameter estimates in ODE models 
- 
-####         1. Short description 
-  * Method for finding optimal paths between points in the parameter space 
-  * Applies Nudged Elastic Band (NEB) method from molecular dynamics community (smooth transition paths in (free) energy landscapes) 
-  * Allows to check if two points form e.g. a waterfall plot are connected, i.e. from the same convergence region / belong to the same optimum and thus allows for merging fits in the waterfall plot 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Could help to improve ‘slippery-stair’-Waterfall plots by revealing the local optima structure or indicating a suboptimal optimizer setup 
-  * Computation of the optimal bands is computationally demanding since model equations and parameters are multiplied by the number of nodes of the band 
-  * Works for small models (Swameye, Boehm) 
-          
-####         3. Code availability and implementations 
-  * Implemented in D2D (folder NEB, example in Examples/NEB/Swameye) 
-          
-####         4. Other related methods/points 
-  * Idea similar to Profile Likelihood 
-  * Sample size calculation for waterfall plot / LHS-Fit 
- 
-####         5. Publications from the Timmer group 
-  * UNPUBLISHED/Submitted: Tönsing et al., Frontiers in Physics (2019) 
-          
-####         6. Publications from external groups 
-  * Basics of NEB path finding: https://theory.cm.utexas.edu/henkelman/pubs/jonsson98_385.pdf 
- 
- 
-###      2. Different optimizers (optimization approaches) 
- 
-####         1. Short description 
-  * Different methods available to (locally) minimize objective function (least-squares/likelihood) 
-  * Deterministic methods include  
-    * Levenberg-Marquardt 
-    * Trust-region optimization 
-    * Line-Search algorithms 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Different algorithms have been used in practice. Often, similar algorithms exist in many implementations.  
- 
-####         3. Code availability and implementations 
-  * Many different optimizers implemented in d2d. See ar.config.optimizers for list and set with ar.config.optim. 
- 
-####         4. Other related methods/points 
-  * Multi Start optimization 
-  * Bayesian sampling (MCMC) as alternative to local optimization 
- 
-####         5. Publications from the Timmer group 
-  * Raue A., et al. Lessons Learned from Quantitative Dynamical Modeling in Systems Biology. PLOS ONE, 8(9), e74335, 2013. 
- 
-####         6. Publications from external groups 
-  * http://www2.imm.dtu.dk/pubdb/views/edoc_download.php/3215/pdf/imm3215.pdf (METHODS FOR NON-LINEAR LEAST SQUARES PROBLEMS, Madsen, Nielsen, Tingleff 2014) 
-       
-###      3. Tolerances 
- 
-###      4. Lessons learned (waterfall plot, FD vs. Sensi, lsqnonlin vs stochastic optim.) 
- 
-###      5. Lessons learned (reparameterization) 
- 
-####         1. Short description 
-  * Reparametrization of ODE model yields a different geometry in the optimization problem and might be beneficial for optimization 
-  * This is especially the case when multiple parameters have identical physical units after reparametrization 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * For independent parameter bounds, reparametrization results in a different search space 
-  * Master thesis of L. Refisch (2017) showed that the influence of a different parameter search space is as big as the changed geometry for the problem. 
-  * Whether is improves optimization behavior is mostly problem-specific  
- 
-####         3. Other related methods/points 
-  * Symmetry detection tool of B.Merkt can be used to identify physical units of parameters. 
-  * Optimization & parameter bounds 
- 
-####         4. Publications from the Timmer group 
-  * Raue A., et al. Lessons Learned from Quantitative Dynamical Modeling in Systems Biology. PLOS ONE, 8(9), e74335, 2013. 
- 
-###      6. Optimization & parameter bounds 
- 
-####         1. Short description 
-  * Parameter bounds specify the search space in which optima of the likelihood are searched 
-  * Ideally, you would analyze the likelihood only in proximity to the global optimum. Its position is mostly unknown, though. Therefore, tradeoff between inclusion of global optimum and huge search space. 
-  * As multiple orders of magnitude are usually spanned in biological contexts, a transformation of parameters to log-space is the default. This improves optimization performance 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * A huge search space has multiple possible drawbacks: Many local optima, infeasibility of model integration, long optimization times for areas far away from optimum 
-  * On the other hand: Not including the point in parameter space that describes the data best is a worst-case-scenario! 
-  * In dmod no are hard bounds are specified, but a prior for sampling starting points in the search space is given[a] 
-          
-####         3. Implementations 
-  * D2D: ar.lb / ar.ub 
-  * dmod: …. 
-          
-####         4. Other related methods/points 
-  * Optimerger 
-  * Reparametrization 
-  * Optimization & parameter bounds 
- 
-####         5. Publications from the Timmer group 
-  * Benefit of log-transformation: C. Kreutz: New Concepts for Evaluating the Performance of Computational Methods, IFAC-PapersOnLine (2016) 49(26): 63-70. 
-    
-##   8. Parameter Estimation 
- 
-###      1. Multi Start Optimization (& sample size calc) + LHS vs random sampling 
-  * This is somewhat connected to the above points. Maybe improve structure here? 
-       
-###      2. MCMC 
-          
-####         1. Short description 
-  * Parameter estimation by sampling from posterior 
-  * Uncertainty analysis included in sampling 
-  * Sampling from posterior, i.e. likelihood times prior 
-          
-####         2. Applicability/restrictions/pitfalls 
-  * Non-identifiabilties lead to problems (posterior not proper) 
-  * Slow compared to multistart deterministic parameter estimation - however includes uncertainty analysis 
-  * Prior has to be defined - uninformative prior usually impossible 
-          
-####         3. Code availability and implementations 
-  * D2D: arMC3, arPlotMarginalized, arPlotCorrelations (in subfolder arFramework3/MCMC) 
-  * dmod: not implemented 
-          
-####         4. Other related methods/points 
-  * MCMC vs. profiles (Uncertainty Analysis) 
-  * Multistart optimization 
-          
-####         5. Publications from the Timmer group 
-  * Joep Vanlier’s PhD thesis 
-  * Raue et. al. - Joining forces of Bayesian and frequentist methodology (2013) 
-  * Wieland - Bayesian parameter estimation in systems biology: Markov chain Monte Carlo sampling of biochemical networks - (2018 master thesis) 
-         
-####         6. Publications from external groups 
-  * Ballnus et. al. - Comprehensive benchmarking of Markov chain Monte Carlo methods for dynamical systems (2017) 
-   
-##   9. Identifiability Analysis / Uncertainty Analysis 
-   
-###      1. MOTA 
- 
-####         1. See “Optimal transformations” 
- 
-###      2. PL - Raue 2009 
- 
-###      3. PL - optimization/integration 
- 
-###      4. Identifiability test (Kreutz 2018) 
- 
-###      5. Sloppiness 
- 
-####         1. Short description 
-  * Sloppiness describes the (unexpected) large spread of eigenvalues of the hessian matrix and originates from structures in the sensitivity matrix, due to the model topology and the choice of data points 
-  * Sloppiness is not correlated to identifiability 
-  * Gutenkunst et al. 2007 has been intensively cited in approx. 50% of the cases used as an excuse for bad parameter estimation 
-   
-####         2. Applicability/restrictions/pitfalls 
-  * only local quadratic approximation  
-  * Very fast: only one eigenvalue calculation 
-  * But: Overestimates uncertainty - Profile likelihood is more precise 
-  * Not a good measure for identifiability -> use Profile Likelihood or ITRP 
-          
-####        3. Code availability and implementations 
-  * D2D: arPlotSloppiness 
-          
-####         4.  Other related methods/points 
-  * Profile Likelihood, Experimental Design 
- 
-####         5.  Publications from the Timmer group 
-  * Tönsing et al., Cause and cure of sloppiness in ODE models, PRE (2014) 
-  * (Hass Benchmark Paper) 
-          
-####         6. Publications from external groups 
-  * “Initial” Paper: Gutenkunst et al., Universally Sloppy Parameter Sensitivities in Systems Biology Models, PLOS Comp Biol, (2007)  
-  * Sloppiness vs. Identifiability: Chis et al., On the relationship between sloppiness and identifiability, Mathematical Biosciences (2016) 
- 
-###      6. MCMC vs. profiles 
- 
-####         1. Short description 
-  * Comparison of uncertainty analysis between profile posterior (similar to profile likelihood for posterior) and MCMC marginalization 
-  * Results: profile posterior similar to MCMC marginalization if no non-identifiabilities exist 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Non-identifiabilities make posterior improper → sampling impossible 
-  * Assumes quadratic form of posterior 
-  * Prior necessary for posterior 
-          
-####         3. Code availability and implementations 
-  * D2D: arMC3, arPlotMCMCProfile, arPlotPLEComparisonToMCMC, arPlotMarginalized 
-  * dmod: not implemented 
-          
-####         4. Other related methods/points 
-  * MCMC (Parameter estimation) 
-  * Profile likelihood 
-          
-####         5. Publications from the Timmer group 
-  * Raue et. al. - Joining forces of Bayesian and frequentist methodology (2013) 
-  * Wieland - Bayesian parameter estimation in systems biology: Markov chain Monte Carlo sampling of biochemical networks - (2018 master thesis) 
-          
-####         6. Publications from external groups 
-  * - 
- 
-###             1. Prediction bands 
-       
-###     2. Lie group Symmetries (Merkt et. al.) 
- 
- 
-##   10. Model Reduction 
-       
-###      1. Profile likelihood - basic examples (Maiwald 2016) 
- 
-###      2. Stoichiometry-based model reduction 
- 
-####         1. Short description 
-  * Reduce conserved moieties (sums of species that stay constant over time) from the model. 
-  * Left null space of the stoichiometric matrix gives the conserved moieties. These can be reduced by iteratively expressing one species into the others by solving for that species using these conservation laws. 
-  * Reduces the number of states and preserves pools by reformulating the model. 
-  * Allows the use of steady state sensitivity evaluation by implicit function theorem. 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Currently does not detect conserved moieties that arise from specific parameter choices (setting a sink to zero for instance). 
-          
-####         3. Code availability and implementations 
-  * D2D: arConservedPools.m / arReduce.m (currently only officially supports simple conserved moieties with no sharing of species between conserved moieties) 
- 
-####         4. Other related methods/points 
-  * - 
- 
-####         5. Publications from the Timmer group 
-  * - 
-       
-###      1. Quasi steady states 
- 
-###      2. Flux analysis 
- 
-####         1. Short description 
-  * Model reduction based on negligible reaction fluxes 
-  * If no or only a negligible flux is going through a certain reaction, this reaction won’t be used by the model will be removed 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * No additional computation time needed 
-  * Only applicable for the removal of reactions, parameter dependencies cannot be visualized 
- 
-####         3. Code availability and implementations 
-  * Implemented in dMod: getFluxes(), plotFluxes() 
-  * Implemented in D2D: select “PlotV” in arPlotter, arPlotV 
- 
-####         4. Other related methods/points 
-  * Profile likelihood 
- 
-####         5. Publications from the Timmer group 
-  * Maiwald et al. Driving the model to its limit: profile likelihood based model reduction. PLoS ONE (2016) 
-  * Oppelt et al. Model-based identification of TNFa-induced IKKb- and IkBa-mediated regulation of NFkB signal transduction as a tool to quantify the impact of Drug-Induced Liver Injury compounds. NPG Systems Biology and Application (2018) 
- 
- 
-##   11. Constraint based optimization 
- 
-###      1. L1/L0.8/L2 
- 
-##   12. Modeling Technique 
- 
-###      1. Quasi-Random effects 
- 
-###      2. NLME 
- 
-###      3. Events(here:d2d, implementation in dmod?) 
- 
-####         1. Short description 
-  * D2d-way to implement sudden/discontinuous changes of states or inputs 
-  * ODE solver integrates up to time point of event, then states are reinitialized by an affine transformation 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Use steady state found via pre-equilibration  
-  * Applied for reinitialization of integrator at step functions in inputs 
-  * No recompiling necessary after adding event 
-  * Event functionality distributed among different functions 
- 
-####         3. D2d-functions related to event system 
-  * arAddEvent adds custom event 
-  * arSteadyState invokes arAddEvent to set initial condition to steady state arFindInputs creates events according to step functions from input 
-  * arLink adds/initializes events 
-  * arClearEvents 
- 
-####          4. Documentation 
-  * D2d wiki entry: https://github.com/Data2Dynamics/d2d/wiki/Advanced%20events%20and%20pre-equilibration 
-  * Toy model example: https://github.com/Data2Dynamics/d2d/tree/master/arFramework3/Examples/ToyModels/Advanced_Events 
- 
-###      4. Moment-ODEs 
- 
-##   13. Data preprocessing / Error estimation 
- 
-###      1. Error models 
- 
-###      2. blotIt 
- 
-####         1. Short description 
-  * Blotit is used to bring data measurements that are on different scales, e.g. due to the use of several western blot gels, to a common scale. 
-  * Determines the scaling parameter between different data realisations and scales the data. 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Usage restricted to data realisation with overlap  
- 
-####         3. Code availability and implementations 
-  * R package "blotIt2" 
-  * Function: alignME() 
- 
-####         4. Publications from the Timmer group 
-  * Implemented by Daniel Kaschek, Publication coming soon 
- 
- 
-##   14. Model Prediction 
- 
-###      1. Validation profiles 
- 
-####         1. Short description 
-  * Generate asymptotic confidence intervals for measurements on a specified experimental condition, which comprises error in the prediction as well as error in the measurement 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Applicable in most of the parametric models analysed based on the likelihood 
-  * Interpretation calls for special care, confidence intervals are only valid for a single measurement 
- 
-####         3. Code availability and implementations 
-  * d2d : Work in progress 
-  * dmod: ? 
- 
-####         4. Other related methods/points 
-  * Extension of the prediction profile method 
-  * Important in the 2D-Profile setting 
- 
-####         5. Publications from the Timmer group 
-  * Kreutz et al. - Likelihood based observability analysis and confidence intervals for predictions of dynamic models (2012) 
- 
-###      2. Prediction profiles 
- 
-####         1. Short description 
-  * Analogously to the profile likelihood method, prediction profiles are profiles for the model prediction 
- 
-####         2. Applicability/restrictions/pitfalls 
-  * Generally more complicated than a parameter profile, because the optimization constraint is nonlinear. But there is a relation to the validation profile from which it can be calculated 
-  * Interpret it in the same way as parameter profiles 
- 
-####         3. Code availability and implementations 
-  * d2d: ? 
-  * dmod:? 
- 
-####         4. Other related methods/points 
-  * Profile Likelihood 
-  * Validation Profiles 
-  * Prediction bands 
- 
-####         5. Publications from the Timmer group 
-  * Kreutz et al. - Likelihood based observability analysis and confidence intervals for predictions of dynamic models (2012) 
-  * Kreutz et al. - Profile likelihood in systems biology (2013) 
- 
-##   15. ODE Motifs 
- 
-###      1. Linear-Chain trick 
- 
-####         1. Short description 
-  * Technique to model time delays with ordinary differential equations 
-  * Number of linear chain states determines shape of output signal 
-  * Optimal/smallest possible number of states can be inferred by identifiability analysis of an auxiliary parameter 
- 
-####         2. Applicability 
-  * Time delays in reaction networks, e.g. transcription, translation, etc (see Swameye or Bachmann model) 
- 
-####         3. Code availability 
-  * Method not implemented in an automated fashion, but example is available in d2d 
- 
-####         4. Publications 
-  * Modeling time delays (“Linear chain trick”):  https://doi.org/10.1002/bit.260180604 
-  * Optimal chain length: https://doi.org/10.1093/bioinformatics/btz838 
- 
- 
-##   16. Single-Cells 
- 
-</markdown> 
- 
-</WRAP> 
- 
-</col> 
-<col xs="12" sm="6" lg="8"> 
  
 <html> <html>
  • data_analysis.1615707633.txt.gz
  • Last modified: 2021/03/14 08:40
  • by admin