Example of a position specific scoring matrix (PSSM).
\r\n\tHydrogen gas is the key energy source for hydrogen-based society. Ozone dissolved water is expected as the sterilization and cleaning agent that can comply with the new law enacted by the US Food and Drug Administration (FDA). The law “FDA Food Safety Modernization Act” requires sterilization and washing of foods to prevent food poisoning and has a strict provision that vegetables, meat, and fish must be washed with non-chlorine cleaning agents to make E. coli adhering to food down to “zero”. If ozone dissolved water could be successively applied in this field, electrochemistry would make a significant contribution to society.
\r\n\r\n\t
\r\n\tOxygen-enriched water is said to promote the growth of farmed fish. Hydrogen dissolved water is said to be able to efficiently remove minute dust on the silicon wafer when used in combination with ultrasonic irradiation.
\r\n\tAt present researches on direct water electrolysis have shown significant progress. For example, boron-doped diamonds and complex metal oxides are widely used as an electrode, and the interposing polymer electrolyte membrane (PEM) between electrodes has become one of the major processes of water electrolysis.
\r\n\t
\r\n\tThe purpose of this book is to show the latest water electrolysis technology and the future of society applying it.
Biology has been transformed by the availability of numerous complete genome sequences for a wide variety of organisms, ranging from bacteria and viruses to model plants and animals to humans. Genome sequencing and analysis is constantly evolving and plays an increasingly important part of biological and biomedical research. This has led to new challenges related to the development of the most efficient and effective ways to analyze data and to use them to generate new insights into the function of biological systems. The completion of the genome sequences is just a first step toward the beginning of efforts to decipher the meaning of the genetic “instruction book.” Whole‐genome sequencing is commonly associated with sequencing human genomes, where the genetic data represent a treasure trove for discovering how genes contribute to our health and well‐being. However, the scalable, flexible nature of next‐generation sequencing (NGS) technology makes it equally useful for sequencing any species, such as agriculturally important livestock, plants, or disease‐related microbes.
\nThe exponential increase in the size of the datasets produced by this new generation of instruments clearly poses unique computational challenges. A single run of a NGS machine can produce terabytes of data, and even after image processing, base calling, and assembly, there will be hundreds of gigabytes of uncompressed primary data that must be stored either in flat files or in a database. Efficient treatment of all this data will require new computational approaches in terms of data storage and management, but also new effective algorithms to analyze the data and extract useful knowledge.
\nThe major challenge today is to understand how the genetic information encoded in the genome sequence is translated into the complex processes involved in the organism and the effects of environmental factors on these processes. Bioinformatics plays a crucial role in the systematic interpretation of genome information, associated with data from other high‐throughput experimental techniques, such as structural genomics, proteomics, or transcriptomics.
\nA widely used tool in all these stages is the comparison (or alignment) of the new genetic sequences with existing sequences. During genome assembly, short read sequences are often aligned to a reference genome to form longer contigs. Identification of coding regions then involves alignment of known genes to the new genomic sequence. Finally, functional significance is most often assigned to the protein coding regions by searching public databases for similar sequences and by transferring the pertinent information from the known to the unknown protein. A wide variety of computational algorithms have been applied to the sequence comparison problem in diverse domains, notably in natural language processing. Nevertheless, the analysis of biological sequences involves more than abstract string parsing, for behind the string of bases or amino acids is the whole complexity of molecular and evolutionary biology.
\nOne major problem is the identification of important features, such as regulatory sites in the genomes, or functional domains or active sites in proteins, that are conserved within a family of sequences, without prior alignment of the sequences. In this context, motif recognition and discovery tools are widely used. The retrieved motifs are often compiled in databases including DNA regulatory motifs in TRANSFAC [1], JASPAR [2], or RegulonDB [3], and protein motifs in PRINTS [4], PROSITE [5], or ELM [6]. These well‐characterized motifs can be used as a starting point for the identification of known motifs in other sequences. This is otherwise known as the pattern recognition problem. The challenges associated with de novo pattern discovery, or the detection of previously unknown motifs [7], is far more difficult due to the nature of the motifs.
\nBiological sequence motifs are defined as short, usually fixed length, sequence patterns that may represent important structural or functional features in nucleic acid and protein sequences such as transcription binding sites, splice junctions, active sites, or interaction interfaces. They occur in an exact or approximate form within a family or a subfamily of sequences. Motif discovery is therefore an important challenge in bioinformatics and numerous methods have been developed for the identification of motifs shared by a set of functionally related sequences.
\nConsequently, much effort has been applied to de novo motif discovery, for example, in DNA sequences, with a large number of specialized methods that were reviewed recently in [8]. One interesting aspect is the development of nature‐inspired algorithms, for example, particle swarm optimization has been used to find gapped motifs in DNA sequences [9], while DNA motifs have been discovered using an artificial immune system (AIS) [10]. Unfortunately, far fewer tools have been dedicated to the de novo search for protein motifs. This is due to the combinatorial explosion created by the large alphabet size of protein sequences, as well as the degeneracy of the motifs, i.e., the large number of wildcard symbols within the motifs. Some tools, such as Teiresias [11], or the MEME suite [12], can discover motifs in both DNA and protein sequences. Other work has been dedicated to the discovery of specific types of protein motifs, such as patterns containing large irregular gaps with “eukaryotic linear motifs” with SLiMFinder [13] or phosphorylation sites [14]. Many studies have been conducted to compare these specific motif discovery tools, such as [15].
\nIn most cases, de novo motif discovery algorithms take as input a set of related sequences and search for patterns that are unlikely to occur by chance and that might represent a biologically important sequence pattern. Since protein motifs are usually short and can be highly variable, a challenging problem for motif discovery algorithms is to distinguish functional motifs from random patterns that are overrepresented. One solution to this challenge is to first construct a global multiple alignment of the sequences and then search for motifs in the aligned sequences. This reduces the search space to the aligned regions of the sequences, but also severely limits the possibilities of finding new motifs.
\nFurthermore, existing motif discovery methods are able to find motifs that are conserved within a complete family, but most of them are still unable to find motifs that are conserved only within a subfamily of the sequences. These subfamily‐specific motifs, which we will call “rare” motifs, are often conserved within groups of proteins that perform the same function (specificity groups) and vary between groups with different functions/specificities. These sites generally determine protein specificity either by binding specific substrates/inhibitors or through interaction with other protein.
\nIn Section 2, we will provide a brief description of protein sequences and the motifs that characterize them. Then, in Section 3, the main approaches used for discovery of motifs in protein sequences will be presented. Section 3 also deals with motif recognition in protein sequences. In Section 4, the main approaches used for the more difficult problem of de novo motif discovery will be presented. Finally, in Section 5, we will propose new horizons for motif discovery in order to address the short comings of the existent methods.
\nSome basic concepts in protein biology are necessary for understanding the rest of this chapter. For many readers, this will be a familiar territory and in this case, they may want to skip this section and go directly to Section 3.
\nThe genetic information encoded in the genome sequence of any organism contains the blueprint for its potential development and activity. However, the translation of this information into cellular or organism‐level behavior depends on the gene products, especially proteins. Proteins perform a wide variety of cellular functions, ranging from catalysis of reactions, nutrient transport, and signal transmission to structural and mechanical roles. A protein is composed of a single chain of amino acids (of which there are 20 different kinds), represented by their single letter codes. This “primary structure” or sequence is none other than a string of characters that we can read from left to right, i.e., from NH2 part (N‐terminal) to the COOH part (C‐terminal).
\nEvery protein molecule has a characteristic three‐dimensional (3D) shape or conformation, known as its native state. The process by which a protein sequence assumes its 3D structure is known as folding. Protein folding can be considered as a hierarchical process, in which the primary sequence defines secondary structure, which in turn defines the tertiary structure. Individual protein molecules can then interact with other proteins to form complex quaternary structures. The precise 3D structure of a protein molecule is generally required for proper biological function since a specific conformation is needed that the cell factors can recognize and interact with.
\nDuring evolution, random mutagenesis events take place, which change the genomic sequences that encode proteins. There are several different types of mutation that can occur. A single amino acid can be substituted for another one. Insertions and deletions also occur, involving a single amino acid up to several hundred amino acids. Some of these evolutionary changes will adversely affect the function of a protein, e.g., mutations of active sites in an enzyme, or mutations that disrupt the 3D structure of the protein. If this happens to a protein that takes part in a crucial process for the cell, it will result in cell death. As a result, amino acids that are essential for a protein\'s function, or that are needed for the protein to fold correctly, are conserved over time. Occasionally, mutations occur that give rise to new functions. This is one of the ways that new traits and eventually species may come about during evolution.
\nBy comparing related sequences and looking for those amino acids that remain the same in all of the members in the family, we can predict the sites that might be essential for function. Some examples of important functional sites include the following:\n
Enzyme active sites: to catalyze a reaction, an enzyme will bind to one or more reactant molecules, known as its substrates. The active site consists of the enzyme\'s amino acids that form temporary bonds with the substrate, known as the binding site, and the amino acids that catalyze the reaction of that substrate.
Ligand‐binding sites: a binding site is a region on a protein molecule where ligands (small molecules or ions) can form a chemical bond. Ligand binding often plays a structural or functional role, for example, in stabilization, catalysis, modulation of enzymatic activity, or signal transmission.
Cleavage sites: the location on a protein molecule where peptide bonds are broken down by hydrolysis. For instance, in human digestion, proteins in food are broken down into smaller peptide chains by digestive enzymes. Many viruses also produce their proteins initially as a single polypeptide chain which is then cleaved into individual protein chains.
Posttranslational modification sites: some amino acids in a protein can undergo chemical modification, produced in most cases by an enzyme after its synthesis or during its life in the cell. This change usually results in a change of the protein function, whether in terms of its action, half‐life, or its cellular localization.
Targeting sites: within a cell, the localization of a protein is essential for its proper functioning, but the production site of a protein is often different from the place of action. Protein targeting signals, such as nuclear or mitochondrial localization signals, can be encoded within the polypeptide chain to allow a protein to be directed to the correct location for its function.
An example of a simple functional site is the N‐glycosylation site, which is a posttranslational modification where a carbohydrate is attached to a hydroxyl or other functional group of a protein molecule. The sequence motif representing this site can be indicated by N‐X‐S/T. The first amino acid is asparagine (N), the second amino acid can be any of the 20 amino acids (X), and the third amino acid is either serine (S) or threonine (T). This example introduces the first complication in protein motif discovery: the motifs can contain both exact and ambiguous elements. Asparagine is a necessary amino acid, since this is the site that will be glycosylated, and is represented by an exact element. The third position should be a hydroxyl‐containing amino acid (serine or threonine), while the second position is a “wild card.” Nevertheless, the N‐glycosylation motif shown here is uninterrupted, and so it is relatively easy to recognize. The spacing between the elements in many other sequence motifs can vary considerably, but the presence of such motifs is generally detected from the structure rather than sequence and this kind of motif will not be discussed in detail here. Finally, it should be pointed out that, just because this motif appears in a protein sequence, it does not mean that the site is glycosylated. The functional implications of a motif will depend on the neighboring amino acids and the surrounding 3D context. Therefore, in practice, identifying functional motifs from a protein sequence is far from straightforward.
\nThe motif recognition problem takes as input a set of known patterns or features that in some way define a class of proteins. The goal is then to search in an unsupervised or supervised way for other instances of the same patterns. As mentioned in the Introduction, the known motifs in biological sequences are generally compiled databases that are publically available over the Internet. For example, the PRINTS database (www.bioinf.manchester.ac.uk/dbbrowser/PRINTS) contains “protein fingerprints,” where a fingerprint is composed of a group of motifs that characterize a given set of protein sequences with the same molecular function. In contrast, the PROSITE (prosite.expasy.org) and ELM (elm.eu.org) databases contain single motifs that correspond to known functionally or structurally important amino acids, such as those involved in an active site or a ligand binding site. The motifs contained in these resources are generally manually curated and the entries in the databases include extensive documentation of the specific biological function associated with the sites.
\nOver the years, a variety of motif representation models have been developed to take into account the complexity of protein motifs. The models are attempts to construct generalizations based on known functional motifs, and are used to help characterize the functional sites and to facilitate their identification in unknown protein sequences. They can be divided into two main categories.
\nConsensus sequences are the simplest model for representing protein motifs. They can be constructed easily by selecting the amino acid found most frequently at each position in the signal. The number of matches between a consensus and an unknown candidate sequence can be used to evaluate the significance of a potential functional site. However, consensus sequences are limited models, since they do not capture the variability of each position. To support some degree of ambiguity, regular expressions can be used. Regular expressions are typically composed of exact symbols, ambiguous symbols, fixed gaps, and/or flexible gaps [16]. For example, the IQ motif is an extremely basic unit of about 23 amino acids, whose conserved core can be represented by the regular expression:\n
where x signifies any amino acid, and the square brackets indicate an alternative.
\nAlthough deterministic models provide useful ways to construct human‐readable representations of motifs, their main drawback is that they lose some information. For instance, in the IQ motif discussed above, the first position is usually I and both [RK] are most often R. Probabilistic models can be used to overcome such loss of information. The position‐specific scoring matrix (PSSM) [17], also known as the probability weight matrix (PWM), is undoubtedly one of the most widely used probabilistic models. This model is represented by a matrix where each entry (i,a) is the probability of finding an amino acid a at the ith position in the sequence motif. For example, for a set of motifs:\n\n\n\n
WSEW
WSRW
CSKW
CSKW
YSKY
The corresponding PSSM is shown in Table 1.
\nPosition | \n1 | \n2 | \n3 | \n4 | \n
---|---|---|---|---|
C | \n0.4 | \n0.0 | \n0.0 | \n0.0 | \n
E | \n0.0 | \n0.0 | \n0.2 | \n0.0 | \n
K | \n0.0 | \n0.0 | \n0.6 | \n0.0 | \n
R | \n0.0 | \n0.0 | \n0.2 | \n0.0 | \n
S | \n0.0 | \n1.0 | \n0.0 | \n0.0 | \n
W | \n0.4 | \n0.0 | \n0.0 | \n0.8 | \n
Y | \n0.2 | \n0.0 | \n0.0 | \n0.2 | \n
Example of a position specific scoring matrix (PSSM).
An example of a sequence logo for representing patterns in biological sequences. The logo represents the Pribnow box, a conserved region found upstream of the some genes in prokaryotic genomes.
Although in this example, PSSM containing entries having a value of 0, in general, pseudo‐counts are applied, especially when using a small dataset, in order to allow the calculation of probabilities for new motifs.
\nThe information summarized in the PSSM can also be represented by a sequence logo [18], which is a graphical representation of the motif conservation as shown in Figure 1. A logo consists of a stack of letters at each position in the motif, where the relative sizes of the letters indicate their frequency in the sequences. The total height of the letters corresponds to the information content of the position, in bits.
\nAnother widely used probabilistic model is the hidden Markov model (HMM), a statistical model that is generally applicable to time series or linear sequences. They were first introduced in bioinformatics for DNA sequences [19]. A HMM can be visualized as a finite state machine that moves through a series of states and produces some kind of output. The HMM generates a protein sequence by emitting amino acids as it progresses through a series of states. Each state has a table of amino acid emission probabilities, and transition probabilities for moving from state to state.
\nAll of the representations mentioned so far inherently assume that positions within the motif are independent of each other. However, in some cases, this strong independence assumption may not be reasonable. Markov models of higher order, permuted Markov models, or Bayesian networks can be used to capture local dependencies by considering how each position depends on the other.
\nThe models described in the previous section can be applied to the task of scanning a user‐submitted sequence for matches to known motifs, thus providing evidence for the function of the protein and contributing to its classification in a given protein family. Ideally, a motif model would recognize all and only the members of the family. Unfortunately, this is seldom the case in practice.
\nIn the case of deterministic models including consensus sequences and regular expressions, the models are often either too specific leading to a large number of false negative predictions, or too degenerate resulting in many false positives. The statistical power of such models can be estimated using standard measures, such as the positive and negative predictive values (PPV and NPV, respectively).
\nIn the case of probability matrices or HMM‐based methods, a log‐odds score can be calculated that is a measure of how probable it is that a sequence is generated by a model rather than by a random null model, representing the universe of all sequences (also known as the “background”). The log‐odds score of a motif is defined as:\n
where Pm is the probability that the sequence was generated by the motif model m and Pφ is the probability that the sequence was generated by the null model. The logarithm is usually base 2, and the score is given in bits. A log‐odds score greater than zero indicates that the sequence fits the motif model better.
\nGiven a set of functionally related sequences, the main aim of motif discovery algorithms is to find new and a priori unknown motifs that are frequent, unexpected, or interesting according to some formal criteria. The methods used to discover such motifs follow the same general schema, as shown in Figure 2. They can be grouped into two main categories: alignment‐based methods and methods that search for motifs in unaligned sequences.
General motif discovery process.
Alignment‐based methods for motif discovery first construct a multiple sequence alignment of the set of sequences, where each sequence of amino acids is typically represented as a row within a matrix. Gaps are inserted between the amino acids so that identical or similar characters are aligned in successive columns. Once the multiple alignments are constructed, the patterns are extracted from the alignment by combining the substrings common to most of the sequences.
\nOne of the first automatic methods for the identification of conserved positions in a multiple alignment was the AMAS program [20], using a set‐based description of amino acid properties. Since then, a large number of different methods have been proposed. For example, Al2Co [21] calculates a conservation index at each position in a multiple sequence alignment using weighted amino acid frequencies at each position. The DIVAA method [22] is based on a statistical measure of the diversity at a given position. The diversity measures the proportion of the 20 possible amino acids that are observed.
\nThe advantage of the alignment‐based approach is that no upper limit has to be imposed on the length of the motifs. Moreover, these algorithms usually do not need as input a maximum threshold value for the motif distance from the sequences. In general, this approach works well if the sequences are sufficiently similar and the patterns occur in the same order in all of the sequences. Unfortunately, this is not usually the case and therefore most methods for motif discovery in protein sequences assume that the input sequences are unaligned.
\nThe vast majority of motif discovery methods in bioinformatics are alignment‐free approaches that do not rely on the initial construction of a multiple sequence alignment. Instead, they generally search for patterns that are overrepresented in a given set of sequences. The simplest solution is to generate all possible motifs up to a maximum length l, and then to search separately for the approximate occurrences of each motif in the set of sequences. Once a list of candidate patterns is obtained, the ones with the highest significance scores are selected. This approach guarantees to find all motifs that satisfy the input constraints. Moreover, the sequences can be organized in suitable indexing structures, such as suffix trees, etc., so that the time needed by the algorithm to search for a single motif is linear in the overall length of the sequences.
\nThis simplistic approach has an evident disadvantage: the number of candidate motifs, and therefore the time required by the algorithm, grows exponentially with the length of the sequences. Computing a significance score for each motif further increases the time required by the algorithm. A number of more efficient tools have been developed to address these issues and in the next chapter, we will discuss some of the more widely used ones.
\nIn this section, we will present of the programs that are specifically designed to search for motifs in protein sequences that are biologically significant. The search for motifs in a set of unaligned sequences is a complex problem because many factors come into play, such as the precise start and end boundaries of the motif, the size variability (presence of gaps or not), or stronger or weaker motif conservation during evolution.
\nDe novo motif discovery programs are generally based on one of the following three algorithms:\n
Enumeration is a method that involves counting all substrings of a certain length (known as words or k‐mers) and then seeking overrepresentations. Such exhaustive motif finding approaches are guaranteed to report all instances of motifs in a set of sequences. However, the exponential complexity of such searches means that the problem quickly becomes intractable for large alphabets.
Deterministic optimization is based on the expectation‐maximization (EM) algorithm that estimates the likelihood of a motif from existing data in two stages repeated iteratively. The first uses a set of parameters to reconstruct the hidden motif structure. The second uses this structure to reestimate the parameters. This method allows finding alternate sequences representing the motif and updating the motif model.
Probabilistic optimization is an iterative method in which a random subsequence is extracted from each sequence to build an initial model. In each subsequent iteration, the ith sequence is removed and the model is recalculated. Then, a new motif is extracted from the ith sequence. This process is repeated until convergence.
Below, and in Table 2, we present the most used motif discovery programs and discuss their advantages and limitations.
\nTeiresias [11] is based on an enumeration algorithm. It operates in two phases: scanning and convolution. During the scanning phase, elementary motifs with sufficient support are identified. These elementary motifs constitute the building blocks for the convolution phase. They are combined into progressively larger motifs until all the existing maximal motifs are generated.
\nMEME [12] is an example of a deterministic optimization algorithm. It allows discovery of motifs in DNA or protein sequences based on expectation maximization (EM). MEME discovers at least three motifs, each of which may be present in some or all of the input sequences. MEME chooses the width and number of occurrences of each motif automatically in order to minimize the “E‐value” of the motif, i.e., the probability of finding a similarly well‐conserved pattern in random sequences. With default parameters, only motif widths between 6 and 50 are considered, but the user have the possibility to change this as well as several other parameters (options) of the motif discovery.
\nPratt [23] is based on probabilistic optimization. It first searches the space of motifs, as constrained by the user, and compiles a list of the most significant sequences that matches at least the user‐defined minimum number of sequences. If the user has not switched off the refinement, these motifs will be input to one of the motif refinement algorithms. The most significant motifs resulting from this are then output to a file.
\nqPMS [24] stands for quorum planted motif search. The program searches for motifs in either DNA or protein sequences. It uses the (l, d) motif search algorithm known as the planted motif search. qPMS takes as input a set of sequences and two values, l and d. It returns all sequences M of length l, which appear in at least q% of the sequences.
\nSLiMFinder [13] identifies novel short linear motifs (SLiMs) in a set of sequences. SLiMs are microdomains that have important functions in many diverse biological pathways. SLiM‐mediated functions include posttranslational modification, subcellular localization, and ligand binding. SLiMs are generally less than 10 amino acids long, many of which will be “flexible” in terms of the conserved amino acid. SLiMFinder constructs such motifs by grouping dimers into longer patterns: motifs with fixed amino acid positions are identified and then grouped to include amino acid ambiguity and variable‐length wildcards. Finally, motifs that are overrepresented in a set of unrelated proteins are identified.
\nDilimot [25] proceeds as follows: in the first step, a user provided set of protein sequences is filtered to eliminate repetitive sequences as well as the regions least likely to contain linear motifs. In the second step, overrepresented motifs are identified in the nonfiltered sequences and ranked according to scores that take into account the background probability of the motif, the number of sequences containing the motif, the size of the sequence set, and the degree to which the motif is conserved in other orthologous proteins.
\nProgram | \nDescription | \nAdvantages | \nDisadvantages | \n
---|---|---|---|
Teiresias | \nFinds motifs that are frequent in a set of related sequences | \nDoes not need background sequences; Very fast | \nToo many redundant motifs discovered | \n
MEME | \nFinds motifs in related sequences using Gibbs sampling and expectation maximization | \nDoes not need background sequences; Fast, Multi‐thread version available; User friendly output | \nUser defines the number of motifs to discover | \n
Pratt | \nDiscovers flexible motifs in related sequences | \nDoes not need background sequences | \nUnable to discover effectively exact motifs | \n
qPMS | \nFinds overrepresented motifs in a set of sequences based on Quorum Planted Motif Search | \nFast; Low memory consumption | \nLimited to 20 protein sequences | \n
SlimFinder | \nFinds overrepresented motifs in a set of unrelated sequences relative to background sequences | \nWell documented; Can use filters | \nNeeds background sequences | \n
MotifHound | \nExhaustively finds motifs overrepresented in a set of unrelated sequences relative to background sequences | \nExhaustive exploration of motifs; Can use filters Fast; Multi‐thread version available | \nNeeds background sequences | \n
Dilimot | \nFinds overrepresented motifs in a set of unrelated sequences relative to a background sequences | \nIntegrates several types of sequence information on motifs | \nNeeds background sequences; Source code not available | \n
FirePro | \nCorrelates overrepresented motifs in a set of sequences with specific functions or behaviors | \nUser friendly output | \nNeeds background sequences | \n
Advantages and limitations of the most used motif discovery programs.
MotifHound [26] is suitable for the discovery of small and degenerate linear motifs. The method needs two input datasets: a background set of protein sequences and a subset of this background set that represents the query sequences. MotifHound first enumerates all possible motifs present in the query sequences, and then calculates the frequency of each motif in both the query and the background sets.
\nFIRE‐pro [27] stands for finding informative regulatory elements in proteins. Its main goal is to discover protein motifs that correlate with the biological behavior of the corresponding proteins. FIRE‐pro calculates a mutual information measure between frequent k‐mer motifs and a “protein behavior profile” containing experimental data about the function of the proteins.
\n\nMost of these programs need prior knowledge about either the input sequences or the motif structure. Furthermore, they are generally designed to discover frequent motifs that occur in all or most of the sequences. The subfamily‐specific motifs, which differentiate a specific subset of sequences, pose a greater challenge due to the statistical nature of these programs or the default choice of parameters used. Nevertheless, these “rare” motifs are often characteristic of important biological functions or context‐specific modifications, including substrate binding sites, protein‐protein interactions, or posttranslational modification sites.
\nIn the final section of this chapter, we will discuss the use of “intelligent algorithms” that should be more reliable for the discovery of significant rare motifs in addition to the conserved and known ones.
\nIntelligent algorithms include optimization and nature inspired algorithms. Among these, artificial immune systems are especially adapted to pattern discovery, and have been used recently for motif discovery in DNA sequences. The high complexity and dimensionality of the problems in bioinformatics are an interesting challenge for testing and validating new computational intelligence techniques. Similarly, the application of AIS to bioinformatics may bring important contributions to the biological sciences, providing an alternative form of analyzing and interpreting the huge volume of data from molecular biology and genomics [28].
\nArtificial immune systems are a class of computationally intelligent systems inspired by the principles and processes of the vertebrate immune system. The algorithms typically apply the structure and function of the immune system to solving hard computational problems. Since their introduction in the 1990s, a number of common techniques have been developed, including:\n
Clonal selection algorithms model how antibodies of the immune system adaptively learn the features of the intruding antigen and defend the body from it. The algorithms are most commonly applied to optimization and pattern recognition domains.
Negative selection refers to the identification and deletion of self‐reacting cells, i.e., cells that may attack self‐tissues. The algorithms are typically used for classification and pattern recognition problems, especially in the anomaly detection domain.
Immune network algorithms focus on the network graph structures involved where antibodies represent the nodes and the training algorithm involves growing or pruning edges between the nodes based on affinity. The algorithms have been used to solve clustering, data visualization, control, and optimization problems.
Dendritic cell algorithms are inspired by the danger theory algorithm of the mammalian immune system, and particularly the role and function of dendritic cells, from the molecular networks present within the cell to the behavior exhibited by a population of cells as a whole.
Although a number of these different AIS can be used for pattern recognition, the clonal selection algorithm seems to be particularly well suited for protein motif discovery in large sets of sequences. In particular, the capabilities for self‐organization of huge numbers of immune cells mean that no prior information is needed. In addition, the system does not require outside intervention and so it can automatically classify pathogens (motifs) and it can react to pathogens that the body has never seen before. Another advantage of AIS is the fact that there are varying types of elements that protect the body from invaders, and there are different lines of defense, such as innate and adaptive immunity. These features can be abstracted to model the diverse types of motifs found in protein molecules (see Section 1). These different mechanisms are organized in multiple layers that act cooperatively to provide high noise tolerance and high overall security.
\nThe use of such intelligent algorithmic approaches should improve the whole motif discovery process: from the selection of suitable sets of sequences, via data cleaning and preprocessing, motif identification and evaluation, to the final presentation and visualization of the results. Nevertheless, a number of issues remain to be addressed before such systems can be applied to the very large datasets produced by NGS technologies. In particular, the substantial time and memory requirements of AIS are a limiting factor, although these can be significantly reduced thanks to the inherently parallel nature of the algorithms.
\nWe would like to thank the members of the BICS and BISTRO Bioinformatics Platforms in Strasbourg for their support. This work was supported by Institute funds from the CNRS, the Université de Strasbourg and the Faculté de Médecine de Strasbourg.
\nThe knowledge of electrical properties of soils in physics and electrical engineering are important for many applications. The long-distance electromagnetic telegraph systems from 1820 are used, with two or more wires to carry the signal and the return currents. It was discovered that the earth could be used as a return path to complete the circuit, making the return wire unnecessary [1]. However, during dry weather, the earth connection often developed a high resistance, requiring water on the earth electrode to enable the telegraph to ring [1].
\nAn important radio propagation and engineering problem has been solved in 1909 by A. Sommerfeld. He has solved the general problem of the effect of the finite conductivity of the ground on the radiation from a short vertical antenna at the surface of a plane earth. The surface wave propagation is produced over real ground for the medium frequency AM radio service, where the attenuation of the electric field depends on the dielectric properties of the soil, mainly of the dielectric losses [2]. Considering the word “Soil” means the uppermost layer of the earth’s crust, it contains the organic as well as mineral matter. From 1936 up to 1941, Norton, Van der Pol, and Bremmer made the computation of the field strengths at distant points on the flat and spherical Earth’s surface [3, 4].
\nIn agriculture applications, the electrical resistivity methods have been introduced by Conrad Schlumberger in France and Frank Wenner in the United States, for the evaluation of ground electrical resistivity. In saline soils, the electric conductivity measured is high, and the effects of salinity are manifested in the loss of stand, reduced rates of plant growth, reduced yields, and in severe cases, total crop failure [5].
\nThe applications like the protection of electrical generating plant are necessary to provide earth connections with low electrical resistance. The radio transmitting and receiving stations for broadcasting is generally covered by radiation transmitted directly along the ground [6]. In electrical engineering, “ground” is the reference point in an electrical circuit from which voltages are measured.
\nFor archeology, geophysics, engineering, and military applications, the so-called ground-penetrating radar (GPR) is a technique widely used. The radar signal is an electromagnetic wave that propagates through the earth, and its signal is reflected when an object appears or there is a change in the properties of the earth. In order to determine the depth of an object under the ground, it is necessary to know the electrical properties of the soil [7].
\nThe equations that relate the electric field (E) and magnetic field (H) are based on the electromagnetic theory formulated by James Clerk Maxwell in 1864, whose validity has allowed great advances in diverse areas, such as telecommunications, electricity, electronics, and materials [8].
\nRegarding the behavior of the materials under the action of an electric field, in the conductive materials, the charges can move freely, meaning that the electrons are not associated with an atomic nucleus. In the case of dielectric materials, the charges are associated with an atom or specific molecule [9]. There are two main mechanisms where the electric field distorts the distribution of charge in a dielectric, stretching and rotation. The relationship between the electric dipole moment inducted under the action of an applied electric field is called atomic electric polarizability \n
In a material with an applied electric field, a convenient definition is to consider the contributions of the dipole moment per unit volume; this parameter is called polarization, which is a macroscopic definition instead of a molecular or atomic definition [9, 10]:
\nIt is evident that the contributions of the electric dipole moment in a volume element \n
And the polarization
\nIn Figure 1, the external electric field applied to a dielectric material and the resulting polarization can be observed.
\nPolarization applying external electric field E, to a dielectric material.
From the macroscopic point of view in most of the dielectric material, when the electric field is canceled, the polarization in the material will be nullified. In addition, the polarization of the material will vary as the electric field varies, i.e., \n
It is convenient to define the electric displacement, because it allows to relate by means of the Gaussian law with the free charges; therefore
\nThen
\nThe electrical permittivity is defined as the relationship between the electric displacement vector \n
Result
\nIt is convenient to define [11]:
\nResult
\nThe electric properties of the material are completely defined by means of \n
In problems with electromagnetic fields, four vectors are defined: E and B; D and H. These vectors are assumed to be finite throughout the entire field, and at all ordinary points to be continuous functions of position and time, with continuous derivatives [12]. The constitutive relations link the vectors of the fields \n
For the electromagnetic propagation in soils, the parameters \n
The electrical resistivity obtained by soil mapping exhibits a large range of values from \n
Table of electric resistivity \n\n\n\nΩ\n/\nm\n\n\n\n and electric conductivity \n\n\n\nσ\n/\nm\n\n\n\n of soils (Ref. Samoulian et al.) [13].
There are evidences that for compacted soils of clay, it exhibits an anisotropic behavior in the resistivity measured in the horizontal and vertical directions [14].
\nThe literature contains the measurement of the dielectric properties of soils at different frequencies with slotted lines and time-domain reflectometry (TDR) methods [15].
\nThe measured variations of the electric permittivity of soils with fractions of sand, silt, and clay and with volumetric moisture content have been studied for frequency of 440 MHz used by the radar observations [16].
\nThe coaxial probe technique terminated in the material under test has been used to measure the dielectric properties of the vegetation. The dielectric data reported are based on measurements of the amplitude and phase of the reflection coefficient of a coaxial probe [17, 18].
\nThe transmission line method has been used to measure the dielectric properties [19, 20]. These transmission lines are coaxial, quasi-coaxial, and two-wire transmission lines. Consider a transmission line with a homogenous dielectric material inside, and the propagation is transverse electromagnetic mode (TEM), where the electric and magnetic field are perpendicular to the propagation direction; this can be observed in Figures 3 and 4.
\nSection of the two-wire transmission line with the electric and magnetic fields.
Section of coaxial transmission lines and the electric and magnetic fields.
The separation between the conductive cylinders that form the coax transmission line should be much lower than the wavelength of the signal that propagates, so the transmission line will not be affected by the propagation modes of high orders, such as the TE\n11 [19].
\nCoaxial transmission lines are widely used for the transmission of radiofrequency signals and its application in radiocommunications and for broadcasting [21]. The transmission lines allow the connection between a generator or emitter and a load or antenna. The air coaxial transmission line consists of two cylindrical conductors, with air between both conductors. These metallic conductors are those that impose the boarder conditions that must comply with the electric and magnetic fields of the electromagnetic wave that travel inside the line. The coaxial transmission lines are used to measure the electrical properties of a dielectric material located inside the coaxial transmission line, as shown in Figure 4.
\nBy analyzing the circuit model of a transmission line, the currents and voltages that propagate along it can be determined, using the circuit theory [22]. The equivalent circuit model of a transmission line can be seen in Figure 5. According to the equivalent circuit model of a transmission line, the characteristic impedance \n
Distributed parameters of the transmission line.
where R is the series resistance per unit length \n
If the transmission line has no losses, it means that R = 0 and G = 0; then the characteristic impedance can be reduced as follows:
\nThe input impedance of a transmission line, with a material inside considering the material with dielectric losses, can be expressed thus [23]:
\nwhere \n
The time-domain reflectometry (TDR) is a well-known technique used to find the interruption point of the transmission lines in a CATV installation and is also useful to determine the dielectric permittivity (see Figure 6).
\nSetup of the dielectric measurement by the TDR method [24].
The time-domain reflectometry uses a step generator and an oscilloscope; a fast edge is launched into the transmission line under investigation, where the incident and reflected voltage waves on the transmission line are monitored by the oscilloscope. This method shows the losses and the characteristic impedance of the line: resistive, inductive, or capacitive [25]. The TDR method is based on the velocity of the electromagnetic wave that propagates through the soil, and the velocity of the wave depends on the water content of the soil. If a pulse is applied to a no-loss transmission line, the time domain graphic can be shown like in Figure 7. Considering the soil like a nonmagnetic media with low dielectric loss is [26, 27]:
\nPropagation of the pulses in the time domain graphic with dielectric air [24].
where \n
The time interval \n
Picture of the voltage as a function of time for the probe is in the soil [26].
where \n
Then
\nUsually the transmission line probes have a minimum length of 15 cm, because the incident electromagnetic wave takes a time of 1 ns in air in order to return to the input of the line. This time is too short to be measured.
\nThe conductivity of the soil can be determined computing the reflected pulses in the probe in the time domain graphic (see Figure 8) [26, 28]. Numerous methods have been proposed by researchers; one of these is the procedure of Dalton et al. (1984) [26]:
\nwhere \n
Also the conductivity can expressed thus [29]:
\nwhere:
\n\n\n
\n\n
Temperature correction \n
This method is based on the measurement of the reflection coefficient by means of the vector network analyzer (VNA) on the frequency domain of a coaxial transmission line in the soil; this can be observed in Figure 9 [30, 31, 32].
\nDielectric measurement by the coaxial transmission line method. (a) Setup of the measurement experiment; (b) section of the transmission line and the material under test [33].
The vector network analyzer can measure the scattering coefficient of a two-port passive network where the reflection coefficient in voltage \n
where \n
The impedance of the probe can be calculated thus:
\nwhere \n
Then the complex electric permittivity for frequencies lower than 50 MHz can be approximated thus [31]:
\nSome references of these measurement methods by means of characteristic impedance have been developed [35, 36]. This methods is shown in Figure 10.
\nInput impedance of the transmission line for \n\n\nZ\nL\n\n=\n0\n\n and \n\n\nZ\nL\n\n→\n∞\n\n.
The input impedance can be computed by Eq. (17) for two different loads’ impedance:
(a) Open circuit in the load \n
\n
(b) Short circuit in the load \n
where, in general, the material inside the transmission line could be a dielectric loss; the propagation constant can be written thus:
\nwhere \n
Using the relation between \n
The argument of the ln
\nReplacing the Ln
\nThen the propagation constant can be written thus:
\nBy these last equations, the attenuation constant and the phase constant can be calculated with \n
The propagation constant \n
Equating real and imaginary parts of \n
\n\n
Another expression of \n
Equating real and imaginary part of Eq. (43)\n
\nResults
\nThe series resistance of the conductor of the coaxial transmission line used is \n
\n
The input impedances are measured for a load impedance at short circuit \n
The attenuation constant \n
The electric permittivity \n
In this way, a practical method of measurement is available to determine the parameters of dielectric materials, using coaxial transmission lines, in the frequency range from 1 to 1000 MHz. A problem that appears when measuring dielectric materials is the connector that establishes the link between the coaxial transmission line and the vector impedance meter. A systematic error in the impedance measured is introduced.
\nTherefore, the study and correction of the mentioned error in the section will be carried out.
\nThree coaxial transmission lines of General Radio (GR) Type 874, with air dielectric, have been used with a length of 100, 200, and 300 mm. The main characteristics of the General Radio coaxial transmission lines, type 874, are the following:
\nCharacteristic impedance \n
Input and output connector GR874
\nIt is important to perform the correction of the impedance introduced by the connector of the transmission line used. This connector is shown in Figure 11, and it is composed by a dielectric of very low dielectric losses and has a length of 10 mm (Figure 12). The characteristic impedance of the connector is practically \n
N connector and its equivalent of a transmission line with dielectric of air.
Equivalent length of the transmission line of the connector GR874.
The input impedance to the connector can be written thus:
\nwhere \n
The electric permittivity of the dielectric of the connector is unknown; then it is easy to assume a transmission line with air equivalent to the connector with \n
Considering the connector with no losses
\nThen the input impedance of the connector with \n
where \n
The length \n
The experimental results of the electric conductivity and the dielectric permittivity measurement of the dry sand can be observed in Figures 13 and 14. In Figure 13, the electric conductivity as a function of the frequency, by means of the capacitive method, and the three types of transmission line lengths have been measured: L = 100, 200, and 300 mm; the convergence of all measurements are evident.
\nElectric conductivity as a function of the frequency for dry sand samples, using a capacitive method and three transmission lines: 100, 200, and 300 mm.
The relative dielectric permittivity as a function of the frequency for dry sand samples has been measured, using a capacitive method and three transmission lines: 100, 200, and 300 mm.
In Figure 14, the relative electric permittivity as a function of the frequency, by means of the capacitive method, and the three types of transmission line lengths have been measured: L = 100, 200, and 300 mm; there is a convergence of all measurements. It is important to note that the shorter transmission line has a wider bandwidth of measurement. The transmission line length of \n
The expected value of the dielectric permittivity measured for the dry sand by means of a parallel plate capacitor and the three transmission lines used are shown in Table 1. The standard deviation of the three measurements shows a good agreement up to the vicinity of the resonant frequency of each transmission line. In Table 2, the electric conductivity of the dry sand can be observed. These curves have the same slope and show a good convergence.
\nfreq.(MHz) | \nCapacitor | \nT. line 100 mm | \nT. line 200 mm | \nT. line 300 mm | \nExpected value | \nStd. dev | \n
---|---|---|---|---|---|---|
1 | \n2.80 | \n2.86 | \n2.65 | \n2.65 | \n2.74 | \n0.034 | \n
2 | \n2.60 | \n2.76 | \n2.62 | \n2.75 | \n2.68 | \n0.021 | \n
3 | \n2.60 | \n2.70 | \n2.60 | \n2.70 | \n2.65 | \n0.010 | \n
5 | \n2.50 | \n2.61 | \n2.57 | \n2.65 | \n2.58 | \n0.012 | \n
7 | \n2.50 | \n2.54 | \n2.55 | \n2.62 | \n2.55 | \n0.0075 | \n
10 | \n2.50 | \n2.51 | \n2.50 | \n2.60 | \n2.52 | \n0.0073 | \n
20 | \n2.40 | \n2.45 | \n2.47 | \n2.57 | \n2.47 | \n0.0153 | \n
30 | \n2.40 | \n2.42 | \n2.46 | \n2.57 | \n2.46 | \n0.0173 | \n
50 | \n2.40 | \n2.40 | \n2.46 | \n— | \n2.41 | \n0.0028 | \n
70 | \n— | \n2.37 | \n— | \n— | \n— | \n— | \n
100 | \n— | \n2.35 | \n— | \n— | \n— | \n— | \n
Relative electric permittivity of dry sand.
freq.(MHz) | \nCapacitor | \nT. line 100 mm | \nT. line 200 mm | \nT. line 300 mm | \nExpected value | \nStd. dev | \n
---|---|---|---|---|---|---|
1 | \n1 | \n1.1 | \n1.3 | \n1.2 | \n1.15 | \n0.13 | \n
2 | \n1.6 | \n2.0 | \n1.7 | \n1.7 | \n1.75 | \n0.17 | \n
3 | \n2.1 | \n2.6 | \n2.3 | \n2.2 | \n2.30 | \n0.22 | \n
5 | \n3.2 | \n3.1 | \n3.3 | \n3.1 | \n3.20 | \n0.096 | \n
7 | \n4.4 | \n5 | \n4.3 | \n4 | \n4.40 | \n0.42 | \n
10 | \n6.0 | \n6.5 | \n5.5 | \n5.1 | \n5.80 | \n0.6 | \n
20 | \n10 | \n11 | \n9.4 | \n8.4 | \n9.70 | \n1.08 | \n
30 | \n14.4 | \n14.6 | \n12.7 | \n11.1 | \n13.20 | \n1.60 | \n
50 | \n21.9 | \n21.5 | \n20.8 | \n16 | \n20.00 | \n2.7 | \n
Electric conductivity of dry sand \n
The values of the electrical conductivity and the electrical permittivity are very useful to evaluate the propagation of surface waves in real ground, where the attenuation depends mostly on the conductivity of the soil. Such is the case that AM transmitters include radials, which consist of metallic conductors, placed at the base of the monopole antenna to increase conductivity, and in this way the losses due to Joule effect on the earth’s surface are reduced. When the conductivity of the soil is perfect, the electric field vector that propagates will be perpendicular to the earth’s surface; however, in real soils the electric field vector tilts and partly spreads into the earth, which dissipates power and transforms into heat [2]. This constitutes losses on earth.
\nApparent soil electrical conductivity (ECa) to agriculture has its origin in the measurement of soil salinity, in arid-zone problem, which is associated with irrigated agricultural land. ECa is a quick, reliable, easy-to-take soil measurement that often relates to crop yield. For these reasons, the measurement of ECa is among the most frequently used tools in precision agriculture research for the spatiotemporal characterization of edaphic and anthropogenic properties that influence crop yield [37]. There are portable instruments for measuring the electrical conductivity of the soil by the method of electromagnetic induction and by the method of the four conductors, which are installed in the agricultural machinery to obtain a map of the soil, before carrying out the work of tilling the earth.
\nFor geophysics applications, the solar disturbances (flares, coronal mass ejections) create variations of the Earth’s magnetic field. These geomagnetic variations induce a geoelectric field at the Earth’s surface and interior. The geoelectric field in turn drives geomagnetically induced currents, also called telluric currents along electrically conductive technological networks, such as power transmission lines, railways, and pipelines [38]. This geomagnetically induced currents create conditions where enhanced corrosion may occur. Earth conductivity can create geomagnetically induced current variations, in particular where a pipeline crosses a highly resistive intrusive rock. It is important to make pipeline surveys once a year to measure the voltage at test posts to ensure that pipe-to-soil potential variations are within the safe range, impressed by cathodic protection systems [38].
\nAuthors are listed below with their open access chapters linked via author name:
",metaTitle:"IntechOpen authors on the Global Highly Cited Researchers 2018 list",metaDescription:null,metaKeywords:null,canonicalURL:null,contentRaw:'[{"type":"htmlEditorComponent","content":"New for 2018 (alphabetically by surname).
\\n\\n\\n\\n\\n\\n\\n\\n\\n\\nJocelyn Chanussot (chapter to be published soon...)
\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\nYuekun Lai
\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\n\\nPrevious years (alphabetically by surname)
\\n\\nAbdul Latif Ahmad 2016-18
\\n\\nKhalil Amine 2017, 2018
\\n\\nEwan Birney 2015-18
\\n\\nFrede Blaabjerg 2015-18
\\n\\nGang Chen 2016-18
\\n\\nJunhong Chen 2017, 2018
\\n\\nZhigang Chen 2016, 2018
\\n\\nMyung-Haing Cho 2016, 2018
\\n\\nMark Connors 2015-18
\\n\\nCyrus Cooper 2017, 2018
\\n\\nLiming Dai 2015-18
\\n\\nWeihua Deng 2017, 2018
\\n\\nVincenzo Fogliano 2017, 2018
\\n\\nRon de Graaf 2014-18
\\n\\nHarald Haas 2017, 2018
\\n\\nFrancisco Herrera 2017, 2018
\\n\\nJaakko Kangasjärvi 2015-18
\\n\\nHamid Reza Karimi 2016-18
\\n\\nJunji Kido 2014-18
\\n\\nJose Luiszamorano 2015-18
\\n\\nYiqi Luo 2016-18
\\n\\nJoachim Maier 2014-18
\\n\\nAndrea Natale 2017, 2018
\\n\\nAlberto Mantovani 2014-18
\\n\\nMarjan Mernik 2017, 2018
\\n\\nSandra Orchard 2014, 2016-18
\\n\\nMohamed Oukka 2016-18
\\n\\nBiswajeet Pradhan 2016-18
\\n\\nDirk Raes 2017, 2018
\\n\\nUlrike Ravens-Sieberer 2016-18
\\n\\nYexiang Tong 2017, 2018
\\n\\nJim Van Os 2015-18
\\n\\nLong Wang 2017, 2018
\\n\\nFei Wei 2016-18
\\n\\nIoannis Xenarios 2017, 2018
\\n\\nQi Xie 2016-18
\\n\\nXin-She Yang 2017, 2018
\\n\\nYulong Yin 2015, 2017, 2018
\\n"}]'},components:[{type:"htmlEditorComponent",content:'New for 2018 (alphabetically by surname).
\n\n\n\n\n\n\n\n\n\nJocelyn Chanussot (chapter to be published soon...)
\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\nYuekun Lai
\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\n\nPrevious years (alphabetically by surname)
\n\nAbdul Latif Ahmad 2016-18
\n\nKhalil Amine 2017, 2018
\n\nEwan Birney 2015-18
\n\nFrede Blaabjerg 2015-18
\n\nGang Chen 2016-18
\n\nJunhong Chen 2017, 2018
\n\nZhigang Chen 2016, 2018
\n\nMyung-Haing Cho 2016, 2018
\n\nMark Connors 2015-18
\n\nCyrus Cooper 2017, 2018
\n\nLiming Dai 2015-18
\n\nWeihua Deng 2017, 2018
\n\nVincenzo Fogliano 2017, 2018
\n\nRon de Graaf 2014-18
\n\nHarald Haas 2017, 2018
\n\nFrancisco Herrera 2017, 2018
\n\nJaakko Kangasjärvi 2015-18
\n\nHamid Reza Karimi 2016-18
\n\nJunji Kido 2014-18
\n\nJose Luiszamorano 2015-18
\n\nYiqi Luo 2016-18
\n\nJoachim Maier 2014-18
\n\nAndrea Natale 2017, 2018
\n\nAlberto Mantovani 2014-18
\n\nMarjan Mernik 2017, 2018
\n\nSandra Orchard 2014, 2016-18
\n\nMohamed Oukka 2016-18
\n\nBiswajeet Pradhan 2016-18
\n\nDirk Raes 2017, 2018
\n\nUlrike Ravens-Sieberer 2016-18
\n\nYexiang Tong 2017, 2018
\n\nJim Van Os 2015-18
\n\nLong Wang 2017, 2018
\n\nFei Wei 2016-18
\n\nIoannis Xenarios 2017, 2018
\n\nQi Xie 2016-18
\n\nXin-She Yang 2017, 2018
\n\nYulong Yin 2015, 2017, 2018
\n'}]},successStories:{items:[]},authorsAndEditors:{filterParams:{sort:"featured,name"},profiles:[{id:"289905",title:"Dr.",name:null,middleName:null,surname:"Inamuddin",slug:"inamuddin",fullName:"Inamuddin",position:null,profilePictureURL:"https://mts.intechopen.com/storage/users/289905/images/system/289905.jpeg",biography:"Dr. Inamuddin is currently working as an assistant professor in the Chemistry Department, Faculty of Science, King Abdulaziz University, Jeddah, Saudi Arabia. He has extensive research experience in multidisciplinary fields of analytical chemistry, materials chemistry, electrochemistry, and more specifically, renewable energy and the environment. He has published 127 research articles in international journals of repute and 18 book chapters in knowledge-based book editions published by renowned international publishers. He has published 39 edited books with Springer, United Kingdom, Elsevier, Nova Science Publishers, Inc. USA, CRC Press Taylor & Francis, Asia Pacific, Trans Tech Publications Ltd., Switzerland, and Materials Science Forum, USA. He is a member of various editorial boards serving as associate editor for journals such as Environmental Chemistry Letter, Applied Water Science, Euro-Mediterranean Journal for Environmental Integration, Springer-Nature, Scientific Reports-Nature, and the editor of Eurasian Journal of Analytical Chemistry.",institutionString:"King Abdulaziz University",institution:{name:"King Abdulaziz University",country:{name:"Saudi Arabia"}}},{id:"99002",title:"Dr.",name:null,middleName:null,surname:"Koontongkaew",slug:"koontongkaew",fullName:"Koontongkaew",position:null,profilePictureURL:"//cdnintech.com/web/frontend/www/assets/author.svg",biography:null,institutionString:null,institution:{name:"Thammasat University",country:{name:"Thailand"}}},{id:"156647",title:"Dr.",name:"A K M Mamunur",middleName:null,surname:"Rashid",slug:"a-k-m-mamunur-rashid",fullName:"A K M Mamunur Rashid",position:null,profilePictureURL:"//cdnintech.com/web/frontend/www/assets/author.svg",biography:"MBBS, DCH, MD(Paed.), Grad. Cert. P. Rheum.(UWA, Australia), FRCP(Edin.)",institutionString:null,institution:{name:"Khulna Medical College",country:{name:"Bangladesh"}}},{id:"234696",title:"Prof.",name:"A K M Mominul",middleName:null,surname:"Islam",slug:"a-k-m-mominul-islam",fullName:"A K M Mominul Islam",position:null,profilePictureURL:"https://intech-files.s3.amazonaws.com/a043Y00000cA8dpQAC/Co2_Profile_Picture-1588761796759",biography:"Prof. Dr. A. K. M. Mominul Islam received both of his bachelor's and Master’s degree from Bangladesh Agricultural University. After that, he joined as Lecturer of Agronomy at Bangladesh Agricultural University (BAU), Mymensingh, Bangladesh, and became Professor in the same department of the university. Dr. Islam did his second Master’s in Physical Land Resources from Ghent University, Belgium. He is currently serving as a postdoctoral researcher at the Department of Horticulture & Landscape Architecture at Purdue University, USA. Dr. Islam has obtained his Ph.D. degree in Plant Allelopathy from The United Graduate School of Agricultural Sciences, Ehime University, Japan. The dissertation title of Dr. Islam was “Allelopathy of five Lamiaceae medicinal plant species”. Dr. Islam is the author of 38 articles published in nationally and internationally reputed journals, 1 book chapter, and 3 books. He is a member of the editorial board and referee of several national and international journals. He is supervising the research of MS and Ph.D. students in areas of Agronomy. Prof. Islam is conducting research on crop management, bio-herbicides, and allelopathy.",institutionString:"Bangladesh Agricultural University",institution:{name:"Bangladesh Agricultural University",country:{name:"Bangladesh"}}},{id:"214531",title:"Mr.",name:"A T M Sakiur",middleName:null,surname:"Rahman",slug:"a-t-m-sakiur-rahman",fullName:"A T M Sakiur Rahman",position:null,profilePictureURL:"//cdnintech.com/web/frontend/www/assets/author.svg",biography:null,institutionString:null,institution:{name:"University of Rajshahi",country:{name:"Bangladesh"}}},{id:"66545",title:"Dr.",name:"A. F.",middleName:null,surname:"Omar",slug:"a.-f.-omar",fullName:"A. F. Omar",position:null,profilePictureURL:"//cdnintech.com/web/frontend/www/assets/author.svg",biography:"Dr. A. F. Omar obtained\nhis Bachelor degree in electrical and\nelectronics engineering from Universiti\nSains Malaysia in 2002, Master of Science in electronics\nengineering from Open University\nMalaysia in 2008 and PhD in optical physics from Universiti\nSains Malaysia in 2012. His research mainly\nfocuses on the development of optical\nand electronics systems for spectroscopy\napplication in environmental monitoring,\nagriculture and dermatology. He has\nmore than 10 years of teaching\nexperience in subjects related to\nelectronics, mathematics and applied optics for\nuniversity students and industrial engineers.",institutionString:null,institution:{name:"Universiti Sains Malaysia",country:{name:"Malaysia"}}},{id:"191072",title:"Prof.",name:"A. K. M. Aminul",middleName:null,surname:"Islam",slug:"a.-k.-m.-aminul-islam",fullName:"A. K. M. Aminul Islam",position:null,profilePictureURL:"https://mts.intechopen.com/storage/users/191072/images/system/191072.jpg",biography:"Prof. Dr. A. K. M. Aminul Islam received both of his bachelor and Master’s degree from Bangladesh Agricultural University. After that he joined as Lecturer of Genetics and Plant Breeding at Bangabandhu Sheikh Mujibur Rahman Agricultural University (BSMRAU), Gazipur, Bangladesh and became Professor in the same department of the university. He is currently serving as Director (Research) of Bangabandhu Sheikh Mujibur Rahman Agricultural University (BSMRAU), Gazipur, Bangladesh. Dr. Islam has obtained his Ph D degree in Chemical and Process Engineering from Universiti Kebangsaan Malaysia. The dissertation title of Dr. Islam was “Improvement of Biodiesel Production through Genetic Studies of Jatropha (Jatropha curcas L.)”. Dr. Islam is the author of 98 articles published in nationally and internationally reputed journals, 11 book chapters and 3 books. He is a member of editorial board and referee of several national and international journals. He is also serving as the General Secretary of Plant Breeding and Genetics Society of Bangladesh, Seminar and research Secretary of JICA Alumni Association of Bangladesh and member of several professional societies. Prof. Islam acted as Principal Breeder in the releasing system of BU Hybrid Lau 1, BU Lau 1, BU Capsicum 1, BU Lalshak 1, BU Baromashi Seem 1, BU Sheem 1, BU Sheem 2, BU Sheem 3 and BU Sheem 4. He supervised 50 MS and 3 Ph D students. Prof. Islam currently supervising research of 5 MS and 3 Ph D students in areas Plant Breeding & Seed Technologies. Conducting research on development of hybrid vegetables, hybrid Brassica napus using CMS system, renewable energy research with Jatropha curcas.",institutionString:"Bangabandhu Sheikh Mujibur Rahman Agricultural University",institution:{name:"Bangabandhu Sheikh Mujibur Rahman Agricultural University",country:{name:"Bangladesh"}}},{id:"322225",title:"Dr.",name:"A. K. M. Aminul",middleName:null,surname:"Islam",slug:"a.-k.-m.-aminul-islam",fullName:"A. K. M. Aminul Islam",position:null,profilePictureURL:"https://mts.intechopen.com/storage/users/no_image.jpg",biography:"Prof. Dr. A. K. M. Aminul Islam received both of his bachelor's and Master’s degree from Bangladesh Agricultural University. After that he joined as Lecturer of Genetics and Plant Breeding at Bangabandhu Sheikh Mujibur Rahman Agricultural University (BSMRAU), Gazipur, Bangladesh, and became Professor in the same department of the university. He is currently serving as Director (Research) of Bangabandhu Sheikh Mujibur Rahman Agricultural University (BSMRAU), Gazipur, Bangladesh. Dr. Islam has obtained his Ph.D. degree in Chemical and Process Engineering from Universiti Kebangsaan Malaysia. The dissertation title of Dr. Islam was 'Improvement of Biodiesel Production through Genetic Studies of Jatropha (Jatropha curcas L.)”. Dr. Islam is the author of 99 articles published in nationally and internationally reputed journals, 11 book chapters, 3 books, and 20 proceedings and conference paper. He is a member of the editorial board and referee of several national and international journals. He is also serving as the General Secretary of Plant Breeding and Genetics Society of Bangladesh, Seminar, and research Secretary of JICA Alumni Association of Bangladesh and a member of several professional societies. Prof. Islam acted as Principal Breeder in the releasing system of BU Hybrid Lau 1, BU Lau 1, BU Capsicum 1, BU Lalshak 1, BU Baromashi Seem 1, BU Sheem 1, BU Sheem 2, BU Sheem 3 and BU Sheem 4. He supervised 50 MS and 3 PhD students. Prof. Islam currently supervising the research of 5 MS and 3 PhD students in areas Plant Breeding & Seed Technologies. Conducting research on the development of hybrid vegetables, hybrid Brassica napus using CMS system, renewable energy research with Jatropha curcas.",institutionString:"Bangabandhu Sheikh Mujibur Rahman Agricultural University",institution:{name:"Bangabandhu Sheikh Mujibur Rahman Agricultural University",country:{name:"Bangladesh"}}},{id:"91977",title:"Dr.",name:"A.B.M. Sharif",middleName:null,surname:"Hossain",slug:"a.b.m.-sharif-hossain",fullName:"A.B.M. Sharif Hossain",position:null,profilePictureURL:"//cdnintech.com/web/frontend/www/assets/author.svg",biography:null,institutionString:null,institution:{name:"University of Malaya",country:{name:"Malaysia"}}},{id:"97123",title:"Prof.",name:"A.M.M.",middleName:null,surname:"Sharif Ullah",slug:"a.m.m.-sharif-ullah",fullName:"A.M.M. Sharif Ullah",position:null,profilePictureURL:"https://mts.intechopen.com/storage/users/97123/images/4209_n.jpg",biography:"AMM Sharif Ullah is currently an Associate Professor of Design and Manufacturing in Department of Mechanical Engineering at Kitami Institute of Technology, Japan. He received the Bachelor of Science Degree in Mechanical Engineering in 1992 from the Bangladesh University of Engineering and Technology, Dhaka, Bangladesh. In 1993, he moved to Japan for graduate studies. He received the Master of Engineering degree in 1996 from the Kansai University Graduate School of Engineering in Mechanical Engineering (Major: Manufacturing Engineering). He also received the Doctor of Engineering degree from the same institute in the same field in 1999. He began his academic career in 2000 as an Assistant Professor in the Industrial Systems Engineering Program at the Asian Institute of Technology, Thailand, as an Assistant Professor in the Industrial Systems Engineering Program. In 2002, he took up the position of Assistant Professor in the Department of Mechanical Engineering at the United Arab Emirates (UAE) University. He was promoted to Associate Professor in 2006 at the UAE University. He moved to his current employer in 2009. His research field is product realization engineering (design, manufacturing, operations, and sustainability). He teaches design and manufacturing related courses at undergraduate and graduate degree programs. He has been mentoring a large number of students for their senior design projects and theses. He has published more than 90 papers in refereed journals, edited books, and international conference proceedings. He made more than 35 oral presentations. Since 2005, he directs the advanced manufacturing engineering research laboratory at Kitami Institute of Technology.",institutionString:null,institution:{name:"Kitami Institute of Technology",country:{name:"Japan"}}},{id:"213441",title:"Dr.",name:"A.R.Kavitha",middleName:null,surname:"Balaji",slug:"a.r.kavitha-balaji",fullName:"A.R.Kavitha Balaji",position:null,profilePictureURL:"//cdnintech.com/web/frontend/www/assets/author.svg",biography:null,institutionString:null,institution:{name:"Anna University, Chennai",country:{name:"India"}}},{id:"172688",title:"Prof.",name:"A.V.",middleName:null,surname:"Salker",slug:"a.v.-salker",fullName:"A.V. Salker",position:null,profilePictureURL:"//cdnintech.com/web/frontend/www/assets/author.svg",biography:null,institutionString:null,institution:{name:"Goa University",country:{name:"India"}}}],filtersByRegion:[{group:"region",caption:"North America",value:1,count:5684},{group:"region",caption:"Middle and South America",value:2,count:5166},{group:"region",caption:"Africa",value:3,count:1682},{group:"region",caption:"Asia",value:4,count:10211},{group:"region",caption:"Australia and Oceania",value:5,count:887},{group:"region",caption:"Europe",value:6,count:15616}],offset:12,limit:12,total:10241},chapterEmbeded:{data:{}},editorApplication:{success:null,errors:{}},ofsBooks:{filterParams:{topicId:"15"},books:[{type:"book",id:"10471",title:"Advances in Dynamical Systems Theory, Models, Algorithms and Applications",subtitle:null,isOpenForSubmission:!0,hash:"689fdf3cdc78ade03f0c43a245dcf818",slug:null,bookSignature:"Dr. Bruno Carpentieri",coverURL:"https://cdn.intechopen.com/books/images_new/10471.jpg",editedByType:null,editors:[{id:"92921",title:"Dr.",name:"Bruno",surname:"Carpentieri",slug:"bruno-carpentieri",fullName:"Bruno Carpentieri"}],productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"10677",title:"Topology",subtitle:null,isOpenForSubmission:!0,hash:"85eac84b173d785f989522397616124e",slug:null,bookSignature:"",coverURL:"https://cdn.intechopen.com/books/images_new/10677.jpg",editedByType:null,editors:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"10678",title:"Biostatistics",subtitle:null,isOpenForSubmission:!0,hash:"f63db439474a574454a66894db8b394c",slug:null,bookSignature:"",coverURL:"https://cdn.intechopen.com/books/images_new/10678.jpg",editedByType:null,editors:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}}],filtersByTopic:[{group:"topic",caption:"Agricultural and Biological Sciences",value:5,count:9},{group:"topic",caption:"Biochemistry, Genetics and Molecular Biology",value:6,count:18},{group:"topic",caption:"Business, Management and Economics",value:7,count:2},{group:"topic",caption:"Chemistry",value:8,count:7},{group:"topic",caption:"Computer and Information Science",value:9,count:10},{group:"topic",caption:"Earth and Planetary Sciences",value:10,count:5},{group:"topic",caption:"Engineering",value:11,count:15},{group:"topic",caption:"Environmental Sciences",value:12,count:2},{group:"topic",caption:"Immunology and Microbiology",value:13,count:5},{group:"topic",caption:"Materials Science",value:14,count:4},{group:"topic",caption:"Mathematics",value:15,count:1},{group:"topic",caption:"Medicine",value:16,count:60},{group:"topic",caption:"Nanotechnology and Nanomaterials",value:17,count:1},{group:"topic",caption:"Neuroscience",value:18,count:1},{group:"topic",caption:"Pharmacology, Toxicology and Pharmaceutical Science",value:19,count:6},{group:"topic",caption:"Physics",value:20,count:2},{group:"topic",caption:"Psychology",value:21,count:3},{group:"topic",caption:"Robotics",value:22,count:1},{group:"topic",caption:"Social Sciences",value:23,count:3},{group:"topic",caption:"Technology",value:24,count:1},{group:"topic",caption:"Veterinary Medicine and Science",value:25,count:2}],offset:12,limit:12,total:3},popularBooks:{featuredBooks:[{type:"book",id:"9208",title:"Welding",subtitle:"Modern Topics",isOpenForSubmission:!1,hash:"7d6be076ccf3a3f8bd2ca52d86d4506b",slug:"welding-modern-topics",bookSignature:"Sadek Crisóstomo Absi Alfaro, Wojciech Borek and Błażej Tomiczek",coverURL:"https://cdn.intechopen.com/books/images_new/9208.jpg",editors:[{id:"65292",title:"Prof.",name:"Sadek Crisostomo Absi",middleName:"C. Absi",surname:"Alfaro",slug:"sadek-crisostomo-absi-alfaro",fullName:"Sadek Crisostomo Absi Alfaro"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9139",title:"Topics in Primary Care Medicine",subtitle:null,isOpenForSubmission:!1,hash:"ea774a4d4c1179da92a782e0ae9cde92",slug:"topics-in-primary-care-medicine",bookSignature:"Thomas F. Heston",coverURL:"https://cdn.intechopen.com/books/images_new/9139.jpg",editors:[{id:"217926",title:"Dr.",name:"Thomas F.",middleName:null,surname:"Heston",slug:"thomas-f.-heston",fullName:"Thomas F. Heston"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"8697",title:"Virtual Reality and Its Application in Education",subtitle:null,isOpenForSubmission:!1,hash:"ee01b5e387ba0062c6b0d1e9227bda05",slug:"virtual-reality-and-its-application-in-education",bookSignature:"Dragan Cvetković",coverURL:"https://cdn.intechopen.com/books/images_new/8697.jpg",editors:[{id:"101330",title:"Dr.",name:"Dragan",middleName:"Mladen",surname:"Cvetković",slug:"dragan-cvetkovic",fullName:"Dragan Cvetković"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9785",title:"Endometriosis",subtitle:null,isOpenForSubmission:!1,hash:"f457ca61f29cf7e8bc191732c50bb0ce",slug:"endometriosis",bookSignature:"Courtney Marsh",coverURL:"https://cdn.intechopen.com/books/images_new/9785.jpg",editors:[{id:"255491",title:"Dr.",name:"Courtney",middleName:null,surname:"Marsh",slug:"courtney-marsh",fullName:"Courtney Marsh"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9343",title:"Trace Metals in the Environment",subtitle:"New Approaches and Recent Advances",isOpenForSubmission:!1,hash:"ae07e345bc2ce1ebbda9f70c5cd12141",slug:"trace-metals-in-the-environment-new-approaches-and-recent-advances",bookSignature:"Mario Alfonso Murillo-Tovar, Hugo Saldarriaga-Noreña and Agnieszka Saeid",coverURL:"https://cdn.intechopen.com/books/images_new/9343.jpg",editors:[{id:"255959",title:"Dr.",name:"Mario Alfonso",middleName:null,surname:"Murillo-Tovar",slug:"mario-alfonso-murillo-tovar",fullName:"Mario Alfonso Murillo-Tovar"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"7831",title:"Sustainability in Urban Planning and Design",subtitle:null,isOpenForSubmission:!1,hash:"c924420492c8c2c9751e178d025f4066",slug:"sustainability-in-urban-planning-and-design",bookSignature:"Amjad Almusaed, Asaad Almssad and Linh Truong - Hong",coverURL:"https://cdn.intechopen.com/books/images_new/7831.jpg",editors:[{id:"110471",title:"Dr.",name:"Amjad",middleName:"Zaki",surname:"Almusaed",slug:"amjad-almusaed",fullName:"Amjad Almusaed"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"8468",title:"Sheep Farming",subtitle:"An Approach to Feed, Growth and Sanity",isOpenForSubmission:!1,hash:"838f08594850bc04aa14ec873ed1b96f",slug:"sheep-farming-an-approach-to-feed-growth-and-sanity",bookSignature:"António Monteiro",coverURL:"https://cdn.intechopen.com/books/images_new/8468.jpg",editors:[{id:"190314",title:"Prof.",name:"António",middleName:"Cardoso",surname:"Monteiro",slug:"antonio-monteiro",fullName:"António Monteiro"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"8816",title:"Financial Crises",subtitle:"A Selection of Readings",isOpenForSubmission:!1,hash:"6f2f49fb903656e4e54280c79fabd10c",slug:"financial-crises-a-selection-of-readings",bookSignature:"Stelios Markoulis",coverURL:"https://cdn.intechopen.com/books/images_new/8816.jpg",editors:[{id:"237863",title:"Dr.",name:"Stelios",middleName:null,surname:"Markoulis",slug:"stelios-markoulis",fullName:"Stelios Markoulis"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9376",title:"Contemporary Developments and Perspectives in International Health Security",subtitle:"Volume 1",isOpenForSubmission:!1,hash:"b9a00b84cd04aae458fb1d6c65795601",slug:"contemporary-developments-and-perspectives-in-international-health-security-volume-1",bookSignature:"Stanislaw P. Stawicki, Michael S. Firstenberg, Sagar C. Galwankar, Ricardo Izurieta and Thomas Papadimos",coverURL:"https://cdn.intechopen.com/books/images_new/9376.jpg",editors:[{id:"181694",title:"Dr.",name:"Stanislaw P.",middleName:null,surname:"Stawicki",slug:"stanislaw-p.-stawicki",fullName:"Stanislaw P. Stawicki"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"7769",title:"Medical Isotopes",subtitle:null,isOpenForSubmission:!1,hash:"f8d3c5a6c9a42398e56b4e82264753f7",slug:"medical-isotopes",bookSignature:"Syed Ali Raza Naqvi and Muhammad Babar Imrani",coverURL:"https://cdn.intechopen.com/books/images_new/7769.jpg",editors:[{id:"259190",title:"Dr.",name:"Syed Ali Raza",middleName:null,surname:"Naqvi",slug:"syed-ali-raza-naqvi",fullName:"Syed Ali Raza Naqvi"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9279",title:"Concepts, Applications and Emerging Opportunities in Industrial Engineering",subtitle:null,isOpenForSubmission:!1,hash:"9bfa87f9b627a5468b7c1e30b0eea07a",slug:"concepts-applications-and-emerging-opportunities-in-industrial-engineering",bookSignature:"Gary Moynihan",coverURL:"https://cdn.intechopen.com/books/images_new/9279.jpg",editors:[{id:"16974",title:"Dr.",name:"Gary",middleName:null,surname:"Moynihan",slug:"gary-moynihan",fullName:"Gary Moynihan"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"7807",title:"A Closer Look at Organizational Culture in Action",subtitle:null,isOpenForSubmission:!1,hash:"05c608b9271cc2bc711f4b28748b247b",slug:"a-closer-look-at-organizational-culture-in-action",bookSignature:"Süleyman Davut Göker",coverURL:"https://cdn.intechopen.com/books/images_new/7807.jpg",editors:[{id:"190035",title:"Associate Prof.",name:"Süleyman Davut",middleName:null,surname:"Göker",slug:"suleyman-davut-goker",fullName:"Süleyman Davut Göker"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}}],offset:12,limit:12,total:5131},hotBookTopics:{hotBooks:[],offset:0,limit:12,total:null},publish:{},publishingProposal:{success:null,errors:{}},books:{featuredBooks:[{type:"book",id:"9208",title:"Welding",subtitle:"Modern Topics",isOpenForSubmission:!1,hash:"7d6be076ccf3a3f8bd2ca52d86d4506b",slug:"welding-modern-topics",bookSignature:"Sadek Crisóstomo Absi Alfaro, Wojciech Borek and Błażej Tomiczek",coverURL:"https://cdn.intechopen.com/books/images_new/9208.jpg",editors:[{id:"65292",title:"Prof.",name:"Sadek Crisostomo Absi",middleName:"C. Absi",surname:"Alfaro",slug:"sadek-crisostomo-absi-alfaro",fullName:"Sadek Crisostomo Absi Alfaro"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9139",title:"Topics in Primary Care Medicine",subtitle:null,isOpenForSubmission:!1,hash:"ea774a4d4c1179da92a782e0ae9cde92",slug:"topics-in-primary-care-medicine",bookSignature:"Thomas F. Heston",coverURL:"https://cdn.intechopen.com/books/images_new/9139.jpg",editors:[{id:"217926",title:"Dr.",name:"Thomas F.",middleName:null,surname:"Heston",slug:"thomas-f.-heston",fullName:"Thomas F. Heston"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"8697",title:"Virtual Reality and Its Application in Education",subtitle:null,isOpenForSubmission:!1,hash:"ee01b5e387ba0062c6b0d1e9227bda05",slug:"virtual-reality-and-its-application-in-education",bookSignature:"Dragan Cvetković",coverURL:"https://cdn.intechopen.com/books/images_new/8697.jpg",editors:[{id:"101330",title:"Dr.",name:"Dragan",middleName:"Mladen",surname:"Cvetković",slug:"dragan-cvetkovic",fullName:"Dragan Cvetković"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9785",title:"Endometriosis",subtitle:null,isOpenForSubmission:!1,hash:"f457ca61f29cf7e8bc191732c50bb0ce",slug:"endometriosis",bookSignature:"Courtney Marsh",coverURL:"https://cdn.intechopen.com/books/images_new/9785.jpg",editors:[{id:"255491",title:"Dr.",name:"Courtney",middleName:null,surname:"Marsh",slug:"courtney-marsh",fullName:"Courtney Marsh"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9343",title:"Trace Metals in the Environment",subtitle:"New Approaches and Recent Advances",isOpenForSubmission:!1,hash:"ae07e345bc2ce1ebbda9f70c5cd12141",slug:"trace-metals-in-the-environment-new-approaches-and-recent-advances",bookSignature:"Mario Alfonso Murillo-Tovar, Hugo Saldarriaga-Noreña and Agnieszka Saeid",coverURL:"https://cdn.intechopen.com/books/images_new/9343.jpg",editors:[{id:"255959",title:"Dr.",name:"Mario Alfonso",middleName:null,surname:"Murillo-Tovar",slug:"mario-alfonso-murillo-tovar",fullName:"Mario Alfonso Murillo-Tovar"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"8468",title:"Sheep Farming",subtitle:"An Approach to Feed, Growth and Sanity",isOpenForSubmission:!1,hash:"838f08594850bc04aa14ec873ed1b96f",slug:"sheep-farming-an-approach-to-feed-growth-and-sanity",bookSignature:"António Monteiro",coverURL:"https://cdn.intechopen.com/books/images_new/8468.jpg",editors:[{id:"190314",title:"Prof.",name:"António",middleName:"Cardoso",surname:"Monteiro",slug:"antonio-monteiro",fullName:"António Monteiro"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"8816",title:"Financial Crises",subtitle:"A Selection of Readings",isOpenForSubmission:!1,hash:"6f2f49fb903656e4e54280c79fabd10c",slug:"financial-crises-a-selection-of-readings",bookSignature:"Stelios Markoulis",coverURL:"https://cdn.intechopen.com/books/images_new/8816.jpg",editors:[{id:"237863",title:"Dr.",name:"Stelios",middleName:null,surname:"Markoulis",slug:"stelios-markoulis",fullName:"Stelios Markoulis"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"7831",title:"Sustainability in Urban Planning and Design",subtitle:null,isOpenForSubmission:!1,hash:"c924420492c8c2c9751e178d025f4066",slug:"sustainability-in-urban-planning-and-design",bookSignature:"Amjad Almusaed, Asaad Almssad and Linh Truong - Hong",coverURL:"https://cdn.intechopen.com/books/images_new/7831.jpg",editors:[{id:"110471",title:"Dr.",name:"Amjad",middleName:"Zaki",surname:"Almusaed",slug:"amjad-almusaed",fullName:"Amjad Almusaed"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"9376",title:"Contemporary Developments and Perspectives in International Health Security",subtitle:"Volume 1",isOpenForSubmission:!1,hash:"b9a00b84cd04aae458fb1d6c65795601",slug:"contemporary-developments-and-perspectives-in-international-health-security-volume-1",bookSignature:"Stanislaw P. Stawicki, Michael S. Firstenberg, Sagar C. Galwankar, Ricardo Izurieta and Thomas Papadimos",coverURL:"https://cdn.intechopen.com/books/images_new/9376.jpg",editors:[{id:"181694",title:"Dr.",name:"Stanislaw P.",middleName:null,surname:"Stawicki",slug:"stanislaw-p.-stawicki",fullName:"Stanislaw P. Stawicki"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}},{type:"book",id:"7769",title:"Medical Isotopes",subtitle:null,isOpenForSubmission:!1,hash:"f8d3c5a6c9a42398e56b4e82264753f7",slug:"medical-isotopes",bookSignature:"Syed Ali Raza Naqvi and Muhammad Babar Imrani",coverURL:"https://cdn.intechopen.com/books/images_new/7769.jpg",editors:[{id:"259190",title:"Dr.",name:"Syed Ali Raza",middleName:null,surname:"Naqvi",slug:"syed-ali-raza-naqvi",fullName:"Syed Ali Raza Naqvi"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}}],latestBooks:[{type:"book",id:"7434",title:"Molecular Biotechnology",subtitle:null,isOpenForSubmission:!1,hash:"eceede809920e1ec7ecadd4691ede2ec",slug:"molecular-biotechnology",bookSignature:"Sergey Sedykh",coverURL:"https://cdn.intechopen.com/books/images_new/7434.jpg",editedByType:"Edited by",editors:[{id:"178316",title:"Ph.D.",name:"Sergey",middleName:null,surname:"Sedykh",slug:"sergey-sedykh",fullName:"Sergey Sedykh"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"8545",title:"Animal Reproduction in Veterinary Medicine",subtitle:null,isOpenForSubmission:!1,hash:"13aaddf5fdbbc78387e77a7da2388bf6",slug:"animal-reproduction-in-veterinary-medicine",bookSignature:"Faruk Aral, Rita Payan-Carreira and Miguel Quaresma",coverURL:"https://cdn.intechopen.com/books/images_new/8545.jpg",editedByType:"Edited by",editors:[{id:"25600",title:"Prof.",name:"Faruk",middleName:null,surname:"Aral",slug:"faruk-aral",fullName:"Faruk Aral"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"9569",title:"Methods in Molecular Medicine",subtitle:null,isOpenForSubmission:!1,hash:"691d3f3c4ac25a8093414e9b270d2843",slug:"methods-in-molecular-medicine",bookSignature:"Yusuf Tutar",coverURL:"https://cdn.intechopen.com/books/images_new/9569.jpg",editedByType:"Edited by",editors:[{id:"158492",title:"Prof.",name:"Yusuf",middleName:null,surname:"Tutar",slug:"yusuf-tutar",fullName:"Yusuf Tutar"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"9839",title:"Outdoor Recreation",subtitle:"Physiological and Psychological Effects on Health",isOpenForSubmission:!1,hash:"5f5a0d64267e32567daffa5b0c6a6972",slug:"outdoor-recreation-physiological-and-psychological-effects-on-health",bookSignature:"Hilde G. Nielsen",coverURL:"https://cdn.intechopen.com/books/images_new/9839.jpg",editedByType:"Edited by",editors:[{id:"158692",title:"Ph.D.",name:"Hilde G.",middleName:null,surname:"Nielsen",slug:"hilde-g.-nielsen",fullName:"Hilde G. Nielsen"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"7802",title:"Modern Slavery and Human Trafficking",subtitle:null,isOpenForSubmission:!1,hash:"587a0b7fb765f31cc98de33c6c07c2e0",slug:"modern-slavery-and-human-trafficking",bookSignature:"Jane Reeves",coverURL:"https://cdn.intechopen.com/books/images_new/7802.jpg",editedByType:"Edited by",editors:[{id:"211328",title:"Prof.",name:"Jane",middleName:null,surname:"Reeves",slug:"jane-reeves",fullName:"Jane Reeves"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"8063",title:"Food Security in Africa",subtitle:null,isOpenForSubmission:!1,hash:"8cbf3d662b104d19db2efc9d59249efc",slug:"food-security-in-africa",bookSignature:"Barakat Mahmoud",coverURL:"https://cdn.intechopen.com/books/images_new/8063.jpg",editedByType:"Edited by",editors:[{id:"92016",title:"Dr.",name:"Barakat",middleName:null,surname:"Mahmoud",slug:"barakat-mahmoud",fullName:"Barakat Mahmoud"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"10118",title:"Plant Stress Physiology",subtitle:null,isOpenForSubmission:!1,hash:"c68b09d2d2634fc719ae3b9a64a27839",slug:"plant-stress-physiology",bookSignature:"Akbar Hossain",coverURL:"https://cdn.intechopen.com/books/images_new/10118.jpg",editedByType:"Edited by",editors:[{id:"280755",title:"Dr.",name:"Akbar",middleName:null,surname:"Hossain",slug:"akbar-hossain",fullName:"Akbar Hossain"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"9157",title:"Neurodegenerative Diseases",subtitle:"Molecular Mechanisms and Current Therapeutic Approaches",isOpenForSubmission:!1,hash:"bc8be577966ef88735677d7e1e92ed28",slug:"neurodegenerative-diseases-molecular-mechanisms-and-current-therapeutic-approaches",bookSignature:"Nagehan Ersoy Tunalı",coverURL:"https://cdn.intechopen.com/books/images_new/9157.jpg",editedByType:"Edited by",editors:[{id:"82778",title:"Ph.D.",name:"Nagehan",middleName:null,surname:"Ersoy Tunalı",slug:"nagehan-ersoy-tunali",fullName:"Nagehan Ersoy Tunalı"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"9961",title:"Data Mining",subtitle:"Methods, Applications and Systems",isOpenForSubmission:!1,hash:"ed79fb6364f2caf464079f94a0387146",slug:"data-mining-methods-applications-and-systems",bookSignature:"Derya Birant",coverURL:"https://cdn.intechopen.com/books/images_new/9961.jpg",editedByType:"Edited by",editors:[{id:"15609",title:"Dr.",name:"Derya",middleName:null,surname:"Birant",slug:"derya-birant",fullName:"Derya Birant"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}},{type:"book",id:"8686",title:"Direct Torque Control Strategies of Electrical Machines",subtitle:null,isOpenForSubmission:!1,hash:"b6ad22b14db2b8450228545d3d4f6b1a",slug:"direct-torque-control-strategies-of-electrical-machines",bookSignature:"Fatma Ben Salem",coverURL:"https://cdn.intechopen.com/books/images_new/8686.jpg",editedByType:"Edited by",editors:[{id:"295623",title:"Associate Prof.",name:"Fatma",middleName:null,surname:"Ben Salem",slug:"fatma-ben-salem",fullName:"Fatma Ben Salem"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}}]},subject:{topic:{id:"1254",title:"Mobile Robot",slug:"android-science-mobile-robot",parent:{title:"Android Science",slug:"android-science"},numberOfBooks:1,numberOfAuthorsAndEditors:59,numberOfWosCitations:48,numberOfCrossrefCitations:29,numberOfDimensionsCitations:52,videoUrl:null,fallbackUrl:null,description:null},booksByTopicFilter:{topicSlug:"android-science-mobile-robot",sort:"-publishedDate",limit:12,offset:0},booksByTopicCollection:[{type:"book",id:"1881",title:"Mobile Robots",subtitle:"Current Trends",isOpenForSubmission:!1,hash:"6f1ee45d3e50f6d5295a1d8c190b646c",slug:"mobile-robots-current-trends",bookSignature:"Zoran Gacovski",coverURL:"https://cdn.intechopen.com/books/images_new/1881.jpg",editedByType:"Edited by",editors:[{id:"89211",title:"Dr.",name:"Zoran",middleName:null,surname:"Gacovski",slug:"zoran-gacovski",fullName:"Zoran Gacovski"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter",authoredCaption:"Edited by"}}],booksByTopicTotal:1,mostCitedChapters:[{id:"22300",doi:"10.5772/26512",title:"Influence of the Size Factor of a Mobile Robot Moving Toward a Human on Subjective Acceptable Distance",slug:"influence-of-the-size-factor-of-a-mobile-robot-moving-toward-a-human-on-subjective-acceptable-distan",totalDownloads:1626,totalCrossrefCites:4,totalDimensionsCites:10,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Yutaka Hiroi and Akinori Ito",authors:[{id:"66916",title:"Dr.",name:"Yutaka",middleName:null,surname:"Hiroi",slug:"yutaka-hiroi",fullName:"Yutaka Hiroi"},{id:"71987",title:"Prof.",name:"Akinori",middleName:null,surname:"Ito",slug:"akinori-ito",fullName:"Akinori Ito"}]},{id:"22305",doi:"10.5772/25497",title:"Dynamic Modeling and Power Modeling of Robotic Skid-Steered Wheeled Vehicles",slug:"dynamic-modeling-and-power-modeling-of-robotic-skid-steered-wheeled-vehicles",totalDownloads:3951,totalCrossrefCites:6,totalDimensionsCites:7,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Wei Yu, Emmanuel Collins and Oscar Chuy",authors:[{id:"29474",title:"Prof.",name:"Emmanuel",middleName:null,surname:"Collins",slug:"emmanuel-collins",fullName:"Emmanuel Collins"},{id:"39957",title:"Dr.",name:"Oscar",middleName:null,surname:"Chuy",slug:"oscar-chuy",fullName:"Oscar Chuy"},{id:"63522",title:"Dr.",name:"Wei",middleName:null,surname:"Yu",slug:"wei-yu",fullName:"Wei Yu"}]},{id:"22308",doi:"10.5772/25936",title:"Design and Prototyping of Autonomous Ball Wheel Mobile Robots",slug:"design-and-prototyping-of-autonomous-ball-wheel-mobile-robots",totalDownloads:2415,totalCrossrefCites:6,totalDimensionsCites:7,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"H. Ghariblu, A. Moharrami and B. Ghalamchi",authors:[{id:"65019",title:"Dr.",name:"Hashem",middleName:null,surname:"Ghariblu",slug:"hashem-ghariblu",fullName:"Hashem Ghariblu"},{id:"72044",title:"Ms.",name:"Ali",middleName:null,surname:"Moharrami",slug:"ali-moharrami",fullName:"Ali Moharrami"},{id:"72048",title:"Ms.",name:"Behnam",middleName:null,surname:"Ghalamchi",slug:"behnam-ghalamchi",fullName:"Behnam Ghalamchi"}]}],mostDownloadedChaptersLast30Days:[{id:"22298",title:"Mobile Platform with Leg-Wheel Mechanism for Practical Use",slug:"mobile-platform-with-leg-wheel-mechanism-for-practical-use",totalDownloads:3178,totalCrossrefCites:1,totalDimensionsCites:1,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Shuro Nakajima",authors:[{id:"63562",title:"Prof.",name:"Shuro",middleName:null,surname:"Nakajima",slug:"shuro-nakajima",fullName:"Shuro Nakajima"}]},{id:"22292",title:"Autonomous Mobile Robot Emmy III",slug:"autonomous-mobile-robot-emmy-iii",totalDownloads:2069,totalCrossrefCites:0,totalDimensionsCites:1,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Cláudio Rodrigo Torres, Jair Minoro Abe, Germano Lambert-Torres and João Inácio da Silva Filho",authors:[{id:"65919",title:"Dr.",name:"Claudio",middleName:"Rodrigo",surname:"Torres",slug:"claudio-torres",fullName:"Claudio Torres"},{id:"112971",title:"Prof.",name:"Germano",middleName:null,surname:"Lambert-Torres",slug:"germano-lambert-torres",fullName:"Germano Lambert-Torres"},{id:"137199",title:"Dr.",name:"Jair Minoro",middleName:null,surname:"Abe",slug:"jair-minoro-abe",fullName:"Jair Minoro Abe"},{id:"137200",title:"Dr.",name:"João Inácio",middleName:null,surname:"da Silva Filho",slug:"joao-inacio-da-silva-filho",fullName:"João Inácio da Silva Filho"}]},{id:"22293",title:"Mobile Robotics in Education and Research",slug:"mobile-robotics-in-education-and-research",totalDownloads:5113,totalCrossrefCites:0,totalDimensionsCites:5,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Georgios A. Demetriou",authors:[{id:"66153",title:"Dr.",name:"Georgios A.",middleName:null,surname:"Demetriou",slug:"georgios-a.-demetriou",fullName:"Georgios A. Demetriou"}]},{id:"22300",title:"Influence of the Size Factor of a Mobile Robot Moving Toward a Human on Subjective Acceptable Distance",slug:"influence-of-the-size-factor-of-a-mobile-robot-moving-toward-a-human-on-subjective-acceptable-distan",totalDownloads:1626,totalCrossrefCites:4,totalDimensionsCites:10,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Yutaka Hiroi and Akinori Ito",authors:[{id:"66916",title:"Dr.",name:"Yutaka",middleName:null,surname:"Hiroi",slug:"yutaka-hiroi",fullName:"Yutaka Hiroi"},{id:"71987",title:"Prof.",name:"Akinori",middleName:null,surname:"Ito",slug:"akinori-ito",fullName:"Akinori Ito"}]},{id:"22294",title:"The KCLBOT: A Framework of the Nonholonomic Mobile Robot Platform Using Double Compass Self-Localisation",slug:"the-kclbot-a-framework-of-the-nonholonomic-mobile-robot-platform-using-double-compass-self-localisat",totalDownloads:1861,totalCrossrefCites:0,totalDimensionsCites:0,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Evangelos Georgiou, Jian Dai and Michael Luck",authors:[{id:"63454",title:"MSc.",name:"Evangelos",middleName:null,surname:"Georgiou",slug:"evangelos-georgiou",fullName:"Evangelos Georgiou"},{id:"68156",title:"Prof.",name:"Jian",middleName:null,surname:"Dai",slug:"jian-dai",fullName:"Jian Dai"},{id:"68157",title:"Prof.",name:"Michael",middleName:null,surname:"Luck",slug:"michael-luck",fullName:"Michael Luck"}]},{id:"22307",title:"The Development of the Omnidirectional Mobile Home Care Robot",slug:"the-development-of-the-omnidirectional-mobile-home-care-robot",totalDownloads:1994,totalCrossrefCites:0,totalDimensionsCites:1,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Jie-Tong Zou",authors:[{id:"67765",title:"Prof.",name:"Jie-Tong",middleName:"Tong",surname:"Zou",slug:"jie-tong-zou",fullName:"Jie-Tong Zou"}]},{id:"22299",title:"A Micro Mobile Robot with Suction Cups in the Abdominal Cavity for NOTES",slug:"a-micro-mobile-robot-with-suction-cups-in-the-abdominal-cavity-for-notes",totalDownloads:1890,totalCrossrefCites:0,totalDimensionsCites:0,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Chika Hiroki and Wenwei Yu",authors:[{id:"48648",title:"Prof.",name:"Wenwei",middleName:null,surname:"Yu",slug:"wenwei-yu",fullName:"Wenwei Yu"},{id:"71018",title:"Ms.",name:"Chika",middleName:null,surname:"Hiroki",slug:"chika-hiroki",fullName:"Chika Hiroki"}]},{id:"22301",title:"Development of Mobile Robot Based on I2C Bus System",slug:"development-of-mobile-robot-based-on-i2c-bus-system",totalDownloads:3123,totalCrossrefCites:0,totalDimensionsCites:0,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Surachai Panich",authors:[{id:"5704",title:"Dr.",name:"Surachai",middleName:null,surname:"Panich",slug:"surachai-panich",fullName:"Surachai Panich"}]},{id:"22305",title:"Dynamic Modeling and Power Modeling of Robotic Skid-Steered Wheeled Vehicles",slug:"dynamic-modeling-and-power-modeling-of-robotic-skid-steered-wheeled-vehicles",totalDownloads:3951,totalCrossrefCites:6,totalDimensionsCites:7,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Wei Yu, Emmanuel Collins and Oscar Chuy",authors:[{id:"29474",title:"Prof.",name:"Emmanuel",middleName:null,surname:"Collins",slug:"emmanuel-collins",fullName:"Emmanuel Collins"},{id:"39957",title:"Dr.",name:"Oscar",middleName:null,surname:"Chuy",slug:"oscar-chuy",fullName:"Oscar Chuy"},{id:"63522",title:"Dr.",name:"Wei",middleName:null,surname:"Yu",slug:"wei-yu",fullName:"Wei Yu"}]},{id:"22295",title:"Gaining Control Knowledge Through an Applied Mobile Robotics Course",slug:"gaining-control-knowledge-through-an-applied-mobile-robotics-course",totalDownloads:1938,totalCrossrefCites:1,totalDimensionsCites:1,book:{slug:"mobile-robots-current-trends",title:"Mobile Robots",fullTitle:"Mobile Robots - Current Trends"},signatures:"Lluís Pacheco, Ningsu Luo, Inès Ferrer, Xavier Cufí and Roger Arbuse",authors:[{id:"30281",title:"Dr.",name:"Lluís",middleName:null,surname:"Pacheco",slug:"lluis-pacheco",fullName:"Lluís Pacheco"},{id:"32046",title:"Dr.",name:"Ningsu",middleName:null,surname:"Luo",slug:"ningsu-luo",fullName:"Ningsu Luo"},{id:"118672",title:"Dr.",name:"Xavier",middleName:null,surname:"Cufí",slug:"xavier-cufi",fullName:"Xavier Cufí"},{id:"137380",title:"Dr.",name:"Inès",middleName:null,surname:"Ferrer",slug:"ines-ferrer",fullName:"Inès Ferrer"},{id:"137381",title:"Mr.",name:"Roger",middleName:null,surname:"Arbuse",slug:"roger-arbuse",fullName:"Roger Arbuse"}]}],onlineFirstChaptersFilter:{topicSlug:"android-science-mobile-robot",limit:3,offset:0},onlineFirstChaptersCollection:[],onlineFirstChaptersTotal:0},preDownload:{success:null,errors:{}},aboutIntechopen:{},privacyPolicy:{},peerReviewing:{},howOpenAccessPublishingWithIntechopenWorks:{},sponsorshipBooks:{sponsorshipBooks:[{type:"book",id:"10176",title:"Microgrids and Local Energy Systems",subtitle:null,isOpenForSubmission:!0,hash:"c32b4a5351a88f263074b0d0ca813a9c",slug:null,bookSignature:"Prof. Nick Jenkins",coverURL:"https://cdn.intechopen.com/books/images_new/10176.jpg",editedByType:null,editors:[{id:"55219",title:"Prof.",name:"Nick",middleName:null,surname:"Jenkins",slug:"nick-jenkins",fullName:"Nick Jenkins"}],equalEditorOne:null,equalEditorTwo:null,equalEditorThree:null,productType:{id:"1",chapterContentType:"chapter"}}],offset:8,limit:8,total:1},route:{name:"profile.detail",path:"/profiles/147485/caroline-struvay",hash:"",query:{},params:{id:"147485",slug:"caroline-struvay"},fullPath:"/profiles/147485/caroline-struvay",meta:{},from:{name:null,path:"/",hash:"",query:{},params:{},fullPath:"/",meta:{}}}},function(){var e;(e=document.currentScript||document.scripts[document.scripts.length-1]).parentNode.removeChild(e)}()