SlideShare ist ein Scribd-Unternehmen logo
1 von 101
Downloaden Sie, um offline zu lesen
Free software and 
biomedical research
       Alberto Labarga
alberto.labarga@scientifik.info
When Craig Venter
was asked, “What
makes you think you
can do a better job
with life and genetics
than God?”, he 
answered…
we have computers
and software too
¡free software!
biology is a data intensive science
Scientific
information
available in 2010 
will double every
72 hours
data mining
my data is mine!
and your data is mine, 
        too!
open source
open data
open access
open science
Sequence (DNA/RNA)
Comparative genomics                                                                     & phylogeny


                                                                                              Protein sequence analysis &
      Regulation of gene                                                                               evolution
   expression; transcription 
     factors & micro RNAs

                                                                                                       Protein structure & function: 
                                                                                                      computational crystallography
                     Protein families, 
                    motifs and domains

                                                                                                                Chemical biology

            Protein interactions & complexes: modelling and prediction




                                                                  Pathway analysis

     Data integration & literature mining




                                                                                 Image analysis                             Systems 
                                                                                                                            modelling
The first Atlas of Protein Sequence and Structure, presented information 
about 65 proteins. 
In 1981 the EMBL Nucleotide Sequence Data Library is created. 
Version 2 was composed of 811 secuences, around 1 million
bases introduced by hand.
Smith TF, Waterman MS (1981). quot;Identification of common 
molecular subsequences.quot;. J Mol Biol. 147 (1): 195‐7.
S.F. Altschul, et al. (1990), quot;Basic Local Alignment Search Tool,quot; J. 
Molec. Biol., 215(3): 403‐10, 1990. 15,306 citations
J. Thompson, T. Gibson, D. Higgins (1994), CLUSTAL W: improving 
the sensitivity of progressive multiple sequence alignment. Nuc. 
Acids. Res. 22, 4673 ‐ 4680
In 1995 the European bioinformatics institute is created.
http://emboss.sourceforge.net/


EMBOSS (The European Molecular Biology Open Software Suite) 
is a free Open Source software analysis package that provides a 
comprehensive set of sequence analysis package specially 
developed for the needs of the molecular biology user 
community. 
First requirements based on a list of long‐standing problems in 
existing commercial software (GCG), and the need for public 
source code
Within EMBOSS you will find around 200 programs (applications).
Current version is 6.0.1 
Main Programs in EMBOSS
Retrieve sequences from database
Sequence alignment
Nucleic gene finding and translation
Protein secondary structure prediction
Rapid database searching with sequence patterns
Protein motif identification, including domain analysis
Nucleotide sequence pattern analysis, for example to 
identify CpG islands or repeats.
Codon usage analysis for small genomes
Rapid identification of sequence patterns in large scale 
sequence sets
Presentation tools for publication
2        open‐bio.org
• The Open Bioinformatics Foundation is a non profit, 
  volunteer run organization focused on supporting 
  open source programming in bioinformatics. 
• Its main activities are:
   – Underwriting and supporting the BOSC conferences
   – Organizing and supporting developer‐centric quot;hackathonquot; 
     events (Bio*)
O’Reilly Books and Conferences
http://www.ensembl.org
30
http://www.uniprot.org
Generic Model Organism Database project
 http://gmod.org
DAS Concept
    Annotation server A Annotation server B Annotation server C




                              Client                  Reference server
http://www.biodas.org
DAS Server
• DAS request to retrieve features on a segment:
• http://das.ensembl.org/das/ens_36_omim_genes/features?s
  egment=1:1,1000000
• Result:
Das viewer
http://www.ebi.ac.uk/dasty/
Illumina / Solexa
                                        Genetic Analyzer


Applied Biosystems   Roche / 454                            Applied Biosystems
                     Genome Sequencer                       SOLiD
ABI 3730XL




                                        3000 Mb/run
                     100 Mb/run
1 Mb/day
Sequencing  Fragment assembly problem  The Shortest 
Superstring Problem Velvet (Zerbino, 2008) 




Sequence comparison  pairwise and multiple sequence 
alignments  dynamic algorithm, heuristic methods PSI‐ BLAST 
(Altschul et. al., 1997) (SSAHA, 2001) (MUMmerGPU, 2008) 




Gene finding  Hidden Markov Models, pattern recognition 
methods  GenScan (Burge & Karlin, 1997)
Genomes
        Nucleotides
           Proteins
         Structures
    Other molecules
        Interactions
       Experiments
          Literature
         Ontologies




http://www.ebi.ac.uk/Databases/
Curso práctico de base de datos e 
integración de información biológica
Challenges of Data Integration
• Different types of data (sequence, function, literature etc.)

• Different data formats (FASTA, EMBL, Genbank, tab 
  delimited etc.)

• Different storage formats (ASCII flatfile, XML, RDBMS)

• No standard formats for common fields (citations, 
  descriptions, dates etc.)

• Volume and size of data
BioMart is a simple and robust data integration system for large
scale data querying, providing researchers with fast and flexible
access to biological databases




http://www.biomart.org/
Web Services




           http://www.ebi.ac.uk/Tools/
Challenges when using tools in unison
• Manually transfer data from one application to 
  another

• Understand disparate data formats

• Convert file formats where appropriate

• Manage and understand disparate application 
  environments e.g. web browser, desktop 
  application
submission

                                curation

ws   ws   ws         ws   ws




          dataflow             workflow
RESTful web services

                                    GET, POST




                                       HTML,XML,PNG

  REST: REpresentational State Transfer

http://www.ebi.ac.uk/Tools/webservices/rest/dbfetch/uniprot/slpi_human
Any web page is a web service
http://www.ebi.ac.uk/cgi-bin/dbfetch?db=uniprot&id=alk1_human&style=html&format=default
Friendly URL and XML documents
    http://www.ebi.ac.uk/Tools/webservices/rest/dbfetch/uniprot/slpi_human
•
    http://www.ebi.ac.uk/Tools/webservices/rest/dbfecth/uniprot/slpi_human/xml
•
    http://www.ebi.ac.uk/Tools/webservices/rest/dbfetch/uniprot/slpi_human/fasta
•
Biomart query

<Query virtualSchemaName=quot;central_server_1quot;>
  <Dataset name=quot;hsapiens_gene_ensemblquot; >
         <Attribute name=quot;ensembl_gene_idquot;/>
         <Attribute name=quot;ensembl_transcript_idquot;/>
         <Filter name=quot;chromosome_namequot; value=quot;1quot;/>
         <Filter name=quot;band_endquot; value=”p36.33quot;/>
         <Filter name=quot;band_startquot; value=”q44quot;/>
   </Dataset>
   <Dataset name=quot;msdquot;>
         <Attribute name=quot;pdb_idquot;/>
         <Attribute name=”experiment_typequot;/>
         <Filter name=quot;experiment_typequot; value=”NMRquot;/>
   </Dataset>
</Query>
SOAP services




SOAP: Simple Object Access Protocol
   fetchData(uniprot,wap_rat,default,xml)
wsdbfetch



      fetchData (db, id, format, style)
   entry
Perl client
use SOAP::Lite;

my $WSDL='http://www.ebi.ac.uk/Tools/webservices/wsdl/WSDbfetch.wsdl';
my $soap = SOAP::Lite->service($WSDL);

# fetchData dbName:id <format> <style>

my $result = $soap->fetchData(‘uniprot’, ‘default’, ‘raw’);
die $soap->call->faultstring if $soap->call->fault;

foreach my $i (@$result) { print quot;$inquot;; }
EBI web services (analysis tools)
                  run(params, data)
              jobid

                  checkStatus (jobid)
               status

                  getResults (jobid)
               results available

                  poll (jobid, type)
               result file
Perl client
use SOAP::Lite;

my $WSDL = 'http://www.ebi.ac.uk/Tools/webservices/wsdl/WSFasta.wsdl';
my $fasta_client = SOAP::Lite->service($WSDL);

my %params=();
$params{'program'}='fasta3';
$params{'database'}='uniprot';
$params{'email'}='your@email.com';
$params{‘async'}= 1;

$data={type=>quot;sequencequot;,
       content=>quot;MRCSISLVLGLLALEVALARNLQEHVFNSVQSMCSDDSFSEDTECIquot;};
# $data={type=>quot;sequencequot;,
#        content=>“uniprot:slpi_humanquot;};

my $jobid = $fasta_client >runFasta(
                   SOAP::Data->name('params')->type(map=>%params),
                   SOAP::Data->name( content => [$data]));

print $fasta_client->poll($jobid);
Perl client (cont.)
# set a loop for checking job submission status
# RUNNING, NOT_FOUND, ERROR, DONE

my $status = $fasta_client ->checkStatus($jobid);
while (status eq quot;RUNNINGquot;) {
 sleep 10; $status = $fasta_client->checkStatus($jobid);
}

# when job is done, poll for the results

my $result = $fasta_client ->poll($jobid) if ($status eq quot;DONEquot;) ;

print $result;
http://taverna.sourceforge.net/
http://www.myexperiment.org/users/471
high throughput genomics
data management
http://base.thep.lu.se/




https://carmaweb.genome.tugraz.at/
Why must support standards?
• Unambiguous representation, description 
  and communication
  – Final results and metadata
• Interoperability 
  – Data management and analysis 
• Integration of OMICS           system biology
What to standarize?
• CONTENT: Minimal/Core Information to be 
  reported ‐> MIBBI (http://www.mibbi.org)
• SEMANTIC: Terminology Used ‐> 
  Ontologies, OBI (http://obi‐ontology.org)
• SYNTAX: Data Model, Data Exchange ‐
  >Fuge (http://fuge.sourceforge.net/) ISA‐
  TAB, MAGE‐TAB, PRIDE
MIBBI: Standard Content




Promoting Coherent Minimum Reporting Requirements for Biological and 
Biomedical Investigations: The MIBBI Project, Taylor et Al, Nature Biotechnology
data analysis
Biological question

Microarray
                             Experimental design


                           Microarray experiment


                                Image analysis


                          Expression quantification       Pre‐processing

                                                                           A
                                Normalization                              n
RT‐PCR                                                                     a
                                                                           l
                          Testing
             Estimation                                  Prediction
                                            Clustering
                                                                           y
                                                                           s
                             Biological verification                       i
                               and interpretation                          s
r‐project.org
    R is an open source implementation of the S Language 
•
    Many statistical and machine learning algorithms
•
    Good visualization capabilities
•
    Possible to write scripts that can be reused
•
    Sophisticated package creation and distribution system
•
    Supports many data technologies: XML, DBI, SOAP
•
    Interacts with other languages: C; Perl; Python; Java
•
    R is largely platform independent: Unix; Windows; OSX
•
    R has an active user community 
•


                           cran.r‐project.org
BioConductor
• Access wide range of powerful statistical and graphical tools
• Facilitate the integration of biological metadata in the analysis of 
  experimental data
• Allow the rapid development of extensible, scalable, and 
  interoperable software; 
• Promote high‐quality documentation and reproducible research.
• Provide training in computational and statistical methods for the 
  analysis of genomic data. 


                              http://www.bioconductor.org/
Bioconductor Packages/libraries
Two releases each year that follow the biannual releases of R 
294 software packages
490 Metadata packages
>700 citations
         No. software packages




         Release        1.1        1.2          1.3        1.4       1.5          1.6        1.7         1.8        1.9       2.0      2.1          2.2       2.3 ‐> 294  packages
Bioconductor for Microarray Analysis

    Quickly becoming the accepted approach
•
    Open source
•
    Flexible
•
    (fairly) simple to use ‐ intuitive
•
    Wide applications – many packages
•
affy package
Pre-processing oligonucleotide chip data:
• diagnostic plots,
• background correction,
• probe-level normalization,
• computation of expression measures.




                                                        plotAffyRNADeg




                                     barplot.ProbeSet




                                image
                                                          plotDensity
mva package




              heatmap
proteomics
http://www.agml.org/
Trans‐Proteomic Pipeline (TPP) is a collection of integrated tools for MS/MS proteomics




 http://tools.proteomecenter.org
 http://proteowizard.sourceforge.net
 http://www.thegpm.org/TANDEM
Bioclipse
Editor




                                      View


View




Console
                                  Properties

                      http://www.bioclipse.net/
Work with spectra: Spectrum plugin
Work with sequences: BioJava plugin
CMLRSS plugin: Chemistry on the web
cytoscape




            http://www.cytoscape.org
pyMol




        http://www.pymol.org
image processing
Open Microscopy Environment
• OME is a multi‐site collaborative effort among academic 
  laboratories and a number of commercial entities that 
  produces open tools to support data management for 
  biological light microscopy.
• The original OME server is an application written in Perl 
  running under Apache. It is accessed using a Web User 
  Interface, via a Java API, or using a plugin for ImageJ.
• The server can support images in a wide range of file 
  formats. This model is also extendable allowing custom 
  data to be stored in the server.
• It supports multiple users and provides appropriate 
  security for private research and collaboration.


                   http://openmicroscopy.org
OMERO
OMERO
beyond software
At $150,000, the Polonator is the cheapest
instrument on the market, says Harvard 
University's George Church, whose lab
developed the technology in conjunction
with Dover Systems, Plus, the tool uses five‐
fold less reagents than other platforms, and 
is the smallest instrument available. 

http://www.polonator.org/
http://www.igem.org
http://www.bioparts.org/
where is the stuff
http://bioinformatics.oxfordjournals.org
http://nar.oxfordjournals.org
http://www.biomedcentral.com/bmcbioinformatics/
http://genomebiology.com/software/
the future
[Phil Bourne]

                Growth of open access scientists
                    digital natives, always online, hybrids
                              catalysts for change
• Making scientific research “re‐useful” — We help 
  people and organizations open and mark their research 
  and data for reuse. 
• Enabling “one‐click” access to research materials —
  We help streamline the materials‐transfer process so 
  researchers can easily replicate, verify and extend 
  research. 
• Integrating fragmented information sources — We 
  help researchers find, analyze and use data from 
  disparate sources by marking and integrating the 
  information with a common, computer‐readable 
  language. 
Free software and bioinformatics

Weitere ähnliche Inhalte

Ähnlich wie Free software and bioinformatics

Biomart Update
Biomart UpdateBiomart Update
Biomart Updatebosc
 
Thesis def
Thesis defThesis def
Thesis defJay Vyas
 
Cool Informatics Tools and Services for Biomedical Research
Cool Informatics Tools and Services for Biomedical ResearchCool Informatics Tools and Services for Biomedical Research
Cool Informatics Tools and Services for Biomedical ResearchDavid Ruau
 
Final Acb All Hands 26 11 07.Key
Final Acb All Hands 26 11 07.KeyFinal Acb All Hands 26 11 07.Key
Final Acb All Hands 26 11 07.Keyguest3d0531
 
Using ontologies to do integrative systems biology
Using ontologies to do integrative systems biologyUsing ontologies to do integrative systems biology
Using ontologies to do integrative systems biologyChris Evelo
 
Bioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahuBioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahuKAUSHAL SAHU
 
Bioinformatics MiRON
Bioinformatics MiRONBioinformatics MiRON
Bioinformatics MiRONPrabin Shakya
 
Haider Embrace Bosc2008
Haider Embrace Bosc2008Haider Embrace Bosc2008
Haider Embrace Bosc2008bosc_2008
 
BITS: Basics of sequence analysis
BITS: Basics of sequence analysisBITS: Basics of sequence analysis
BITS: Basics of sequence analysisBITS
 
Genome visualization challenges
Genome visualization challengesGenome visualization challenges
Genome visualization challengesAlberto Labarga
 
Homology modeling
Homology modelingHomology modeling
Homology modelingAjay Murali
 
SooryaKiran Bioinformatics
SooryaKiran BioinformaticsSooryaKiran Bioinformatics
SooryaKiran Bioinformaticscontactsoorya
 
2013 nas-ehs-data-integration-dc
2013 nas-ehs-data-integration-dc2013 nas-ehs-data-integration-dc
2013 nas-ehs-data-integration-dcc.titus.brown
 

Ähnlich wie Free software and bioinformatics (20)

2012 03 01_bioinformatics_ii_les1
2012 03 01_bioinformatics_ii_les12012 03 01_bioinformatics_ii_les1
2012 03 01_bioinformatics_ii_les1
 
Biomart Update
Biomart UpdateBiomart Update
Biomart Update
 
Thesis def
Thesis defThesis def
Thesis def
 
My Project
My ProjectMy Project
My Project
 
Cool Informatics Tools and Services for Biomedical Research
Cool Informatics Tools and Services for Biomedical ResearchCool Informatics Tools and Services for Biomedical Research
Cool Informatics Tools and Services for Biomedical Research
 
Semantic (Web) Technologies for Translational Research in Life Sciences
Semantic (Web) Technologies for Translational Research in Life SciencesSemantic (Web) Technologies for Translational Research in Life Sciences
Semantic (Web) Technologies for Translational Research in Life Sciences
 
Final Acb All Hands 26 11 07.Key
Final Acb All Hands 26 11 07.KeyFinal Acb All Hands 26 11 07.Key
Final Acb All Hands 26 11 07.Key
 
Using ontologies to do integrative systems biology
Using ontologies to do integrative systems biologyUsing ontologies to do integrative systems biology
Using ontologies to do integrative systems biology
 
Bioinformatics
BioinformaticsBioinformatics
Bioinformatics
 
Bioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahuBioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahu
 
Bioinformatics MiRON
Bioinformatics MiRONBioinformatics MiRON
Bioinformatics MiRON
 
Haider Embrace Bosc2008
Haider Embrace Bosc2008Haider Embrace Bosc2008
Haider Embrace Bosc2008
 
bioinformatic.pptx
bioinformatic.pptxbioinformatic.pptx
bioinformatic.pptx
 
Bioinformatics
BioinformaticsBioinformatics
Bioinformatics
 
BITS: Basics of sequence analysis
BITS: Basics of sequence analysisBITS: Basics of sequence analysis
BITS: Basics of sequence analysis
 
Genome visualization challenges
Genome visualization challengesGenome visualization challenges
Genome visualization challenges
 
Homology modeling
Homology modelingHomology modeling
Homology modeling
 
SooryaKiran Bioinformatics
SooryaKiran BioinformaticsSooryaKiran Bioinformatics
SooryaKiran Bioinformatics
 
Folker Meyer: Metagenomic Data Annotation
Folker Meyer: Metagenomic Data AnnotationFolker Meyer: Metagenomic Data Annotation
Folker Meyer: Metagenomic Data Annotation
 
2013 nas-ehs-data-integration-dc
2013 nas-ehs-data-integration-dc2013 nas-ehs-data-integration-dc
2013 nas-ehs-data-integration-dc
 

Mehr von Alberto Labarga

El Salto Communities - EditorsLab 2017
El Salto Communities - EditorsLab 2017El Salto Communities - EditorsLab 2017
El Salto Communities - EditorsLab 2017Alberto Labarga
 
Shokesu - Premio Nobel de Literatura a Bob Dylan
Shokesu - Premio Nobel de Literatura a Bob DylanShokesu - Premio Nobel de Literatura a Bob Dylan
Shokesu - Premio Nobel de Literatura a Bob DylanAlberto Labarga
 
SocialLearning: descubriendo contenidos educativos de manera colaborativa
SocialLearning: descubriendo contenidos educativos de manera colaborativaSocialLearning: descubriendo contenidos educativos de manera colaborativa
SocialLearning: descubriendo contenidos educativos de manera colaborativaAlberto Labarga
 
Hacksanfermin 2015 :: Dropcoin Street
Hacksanfermin 2015 :: Dropcoin StreetHacksanfermin 2015 :: Dropcoin Street
Hacksanfermin 2015 :: Dropcoin StreetAlberto Labarga
 
hacksanfermin 2015 :: Parking inteligente
hacksanfermin 2015 :: Parking inteligentehacksanfermin 2015 :: Parking inteligente
hacksanfermin 2015 :: Parking inteligenteAlberto Labarga
 
Vidas Contadas :: Visualizar 2015
Vidas Contadas :: Visualizar 2015Vidas Contadas :: Visualizar 2015
Vidas Contadas :: Visualizar 2015Alberto Labarga
 
Periodismo de datos y visualización de datos abiertos #siglibre9
Periodismo de datos y visualización de datos abiertos #siglibre9Periodismo de datos y visualización de datos abiertos #siglibre9
Periodismo de datos y visualización de datos abiertos #siglibre9Alberto Labarga
 
Arduino: Control de motores
Arduino: Control de motoresArduino: Control de motores
Arduino: Control de motoresAlberto Labarga
 
Entrada/salida analógica con Arduino
Entrada/salida analógica con ArduinoEntrada/salida analógica con Arduino
Entrada/salida analógica con ArduinoAlberto Labarga
 
Práctica con Arduino: Simon Dice
Práctica con Arduino: Simon DicePráctica con Arduino: Simon Dice
Práctica con Arduino: Simon DiceAlberto Labarga
 
Entrada/Salida digital con Arduino
Entrada/Salida digital con ArduinoEntrada/Salida digital con Arduino
Entrada/Salida digital con ArduinoAlberto Labarga
 
Presentación Laboratorio de Fabricación Digital UPNA 2014
Presentación Laboratorio de Fabricación Digital UPNA 2014Presentación Laboratorio de Fabricación Digital UPNA 2014
Presentación Laboratorio de Fabricación Digital UPNA 2014Alberto Labarga
 
Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014
Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014
Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014Alberto Labarga
 
Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...
Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...
Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...Alberto Labarga
 
Introducción a la impresión 3D
Introducción a la impresión 3DIntroducción a la impresión 3D
Introducción a la impresión 3DAlberto Labarga
 
La vida y trabajo de Shinichi Suzuki
La vida y trabajo de Shinichi SuzukiLa vida y trabajo de Shinichi Suzuki
La vida y trabajo de Shinichi SuzukiAlberto Labarga
 

Mehr von Alberto Labarga (20)

El Salto Communities - EditorsLab 2017
El Salto Communities - EditorsLab 2017El Salto Communities - EditorsLab 2017
El Salto Communities - EditorsLab 2017
 
Shokesu - Premio Nobel de Literatura a Bob Dylan
Shokesu - Premio Nobel de Literatura a Bob DylanShokesu - Premio Nobel de Literatura a Bob Dylan
Shokesu - Premio Nobel de Literatura a Bob Dylan
 
SocialLearning: descubriendo contenidos educativos de manera colaborativa
SocialLearning: descubriendo contenidos educativos de manera colaborativaSocialLearning: descubriendo contenidos educativos de manera colaborativa
SocialLearning: descubriendo contenidos educativos de manera colaborativa
 
Hacksanfermin 2015 :: Dropcoin Street
Hacksanfermin 2015 :: Dropcoin StreetHacksanfermin 2015 :: Dropcoin Street
Hacksanfermin 2015 :: Dropcoin Street
 
hacksanfermin 2015 :: Parking inteligente
hacksanfermin 2015 :: Parking inteligentehacksanfermin 2015 :: Parking inteligente
hacksanfermin 2015 :: Parking inteligente
 
jpd5 big data
jpd5 big datajpd5 big data
jpd5 big data
 
Vidas Contadas :: Visualizar 2015
Vidas Contadas :: Visualizar 2015Vidas Contadas :: Visualizar 2015
Vidas Contadas :: Visualizar 2015
 
Periodismo de datos y visualización de datos abiertos #siglibre9
Periodismo de datos y visualización de datos abiertos #siglibre9Periodismo de datos y visualización de datos abiertos #siglibre9
Periodismo de datos y visualización de datos abiertos #siglibre9
 
myHealthHackmedicine
myHealthHackmedicinemyHealthHackmedicine
myHealthHackmedicine
 
Big Data y Salud
Big Data y SaludBig Data y Salud
Big Data y Salud
 
Arduino: Control de motores
Arduino: Control de motoresArduino: Control de motores
Arduino: Control de motores
 
Entrada/salida analógica con Arduino
Entrada/salida analógica con ArduinoEntrada/salida analógica con Arduino
Entrada/salida analógica con Arduino
 
Práctica con Arduino: Simon Dice
Práctica con Arduino: Simon DicePráctica con Arduino: Simon Dice
Práctica con Arduino: Simon Dice
 
Entrada/Salida digital con Arduino
Entrada/Salida digital con ArduinoEntrada/Salida digital con Arduino
Entrada/Salida digital con Arduino
 
Presentación Laboratorio de Fabricación Digital UPNA 2014
Presentación Laboratorio de Fabricación Digital UPNA 2014Presentación Laboratorio de Fabricación Digital UPNA 2014
Presentación Laboratorio de Fabricación Digital UPNA 2014
 
Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014
Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014
Conceptos de electrónica - Laboratorio de Fabricación Digital UPNA 2014
 
Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...
Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...
Introducción a la plataforma Arduino - Laboratorio de Fabricación Digital UPN...
 
Introducción a la impresión 3D
Introducción a la impresión 3DIntroducción a la impresión 3D
Introducción a la impresión 3D
 
Vidas Contadas
Vidas ContadasVidas Contadas
Vidas Contadas
 
La vida y trabajo de Shinichi Suzuki
La vida y trabajo de Shinichi SuzukiLa vida y trabajo de Shinichi Suzuki
La vida y trabajo de Shinichi Suzuki
 

Kürzlich hochgeladen

What is DBT - The Ultimate Data Build Tool.pdf
What is DBT - The Ultimate Data Build Tool.pdfWhat is DBT - The Ultimate Data Build Tool.pdf
What is DBT - The Ultimate Data Build Tool.pdfMounikaPolabathina
 
TrustArc Webinar - How to Build Consumer Trust Through Data Privacy
TrustArc Webinar - How to Build Consumer Trust Through Data PrivacyTrustArc Webinar - How to Build Consumer Trust Through Data Privacy
TrustArc Webinar - How to Build Consumer Trust Through Data PrivacyTrustArc
 
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024BookNet Canada
 
Take control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test SuiteTake control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test SuiteDianaGray10
 
The Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptx
The Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptxThe Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptx
The Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptxLoriGlavin3
 
SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024Lorenzo Miniero
 
DevEX - reference for building teams, processes, and platforms
DevEX - reference for building teams, processes, and platformsDevEX - reference for building teams, processes, and platforms
DevEX - reference for building teams, processes, and platformsSergiu Bodiu
 
WordPress Websites for Engineers: Elevate Your Brand
WordPress Websites for Engineers: Elevate Your BrandWordPress Websites for Engineers: Elevate Your Brand
WordPress Websites for Engineers: Elevate Your Brandgvaughan
 
Advanced Computer Architecture – An Introduction
Advanced Computer Architecture – An IntroductionAdvanced Computer Architecture – An Introduction
Advanced Computer Architecture – An IntroductionDilum Bandara
 
Dev Dives: Streamline document processing with UiPath Studio Web
Dev Dives: Streamline document processing with UiPath Studio WebDev Dives: Streamline document processing with UiPath Studio Web
Dev Dives: Streamline document processing with UiPath Studio WebUiPathCommunity
 
How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.Curtis Poe
 
Developer Data Modeling Mistakes: From Postgres to NoSQL
Developer Data Modeling Mistakes: From Postgres to NoSQLDeveloper Data Modeling Mistakes: From Postgres to NoSQL
Developer Data Modeling Mistakes: From Postgres to NoSQLScyllaDB
 
Streamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project SetupStreamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project SetupFlorian Wilhelm
 
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024BookNet Canada
 
Merck Moving Beyond Passwords: FIDO Paris Seminar.pptx
Merck Moving Beyond Passwords: FIDO Paris Seminar.pptxMerck Moving Beyond Passwords: FIDO Paris Seminar.pptx
Merck Moving Beyond Passwords: FIDO Paris Seminar.pptxLoriGlavin3
 
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdfHyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdfPrecisely
 
The Ultimate Guide to Choosing WordPress Pros and Cons
The Ultimate Guide to Choosing WordPress Pros and ConsThe Ultimate Guide to Choosing WordPress Pros and Cons
The Ultimate Guide to Choosing WordPress Pros and ConsPixlogix Infotech
 
The State of Passkeys with FIDO Alliance.pptx
The State of Passkeys with FIDO Alliance.pptxThe State of Passkeys with FIDO Alliance.pptx
The State of Passkeys with FIDO Alliance.pptxLoriGlavin3
 
How to write a Business Continuity Plan
How to write a Business Continuity PlanHow to write a Business Continuity Plan
How to write a Business Continuity PlanDatabarracks
 

Kürzlich hochgeladen (20)

What is DBT - The Ultimate Data Build Tool.pdf
What is DBT - The Ultimate Data Build Tool.pdfWhat is DBT - The Ultimate Data Build Tool.pdf
What is DBT - The Ultimate Data Build Tool.pdf
 
TrustArc Webinar - How to Build Consumer Trust Through Data Privacy
TrustArc Webinar - How to Build Consumer Trust Through Data PrivacyTrustArc Webinar - How to Build Consumer Trust Through Data Privacy
TrustArc Webinar - How to Build Consumer Trust Through Data Privacy
 
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
 
Take control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test SuiteTake control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test Suite
 
The Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptx
The Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptxThe Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptx
The Fit for Passkeys for Employee and Consumer Sign-ins: FIDO Paris Seminar.pptx
 
SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024
 
DevEX - reference for building teams, processes, and platforms
DevEX - reference for building teams, processes, and platformsDevEX - reference for building teams, processes, and platforms
DevEX - reference for building teams, processes, and platforms
 
WordPress Websites for Engineers: Elevate Your Brand
WordPress Websites for Engineers: Elevate Your BrandWordPress Websites for Engineers: Elevate Your Brand
WordPress Websites for Engineers: Elevate Your Brand
 
Advanced Computer Architecture – An Introduction
Advanced Computer Architecture – An IntroductionAdvanced Computer Architecture – An Introduction
Advanced Computer Architecture – An Introduction
 
Dev Dives: Streamline document processing with UiPath Studio Web
Dev Dives: Streamline document processing with UiPath Studio WebDev Dives: Streamline document processing with UiPath Studio Web
Dev Dives: Streamline document processing with UiPath Studio Web
 
How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.
 
Developer Data Modeling Mistakes: From Postgres to NoSQL
Developer Data Modeling Mistakes: From Postgres to NoSQLDeveloper Data Modeling Mistakes: From Postgres to NoSQL
Developer Data Modeling Mistakes: From Postgres to NoSQL
 
Streamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project SetupStreamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project Setup
 
DMCC Future of Trade Web3 - Special Edition
DMCC Future of Trade Web3 - Special EditionDMCC Future of Trade Web3 - Special Edition
DMCC Future of Trade Web3 - Special Edition
 
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
 
Merck Moving Beyond Passwords: FIDO Paris Seminar.pptx
Merck Moving Beyond Passwords: FIDO Paris Seminar.pptxMerck Moving Beyond Passwords: FIDO Paris Seminar.pptx
Merck Moving Beyond Passwords: FIDO Paris Seminar.pptx
 
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdfHyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
 
The Ultimate Guide to Choosing WordPress Pros and Cons
The Ultimate Guide to Choosing WordPress Pros and ConsThe Ultimate Guide to Choosing WordPress Pros and Cons
The Ultimate Guide to Choosing WordPress Pros and Cons
 
The State of Passkeys with FIDO Alliance.pptx
The State of Passkeys with FIDO Alliance.pptxThe State of Passkeys with FIDO Alliance.pptx
The State of Passkeys with FIDO Alliance.pptx
 
How to write a Business Continuity Plan
How to write a Business Continuity PlanHow to write a Business Continuity Plan
How to write a Business Continuity Plan
 

Free software and bioinformatics