874 resultados para T-loop
Resumo:
High-level loop transformations are a key instrument in mapping computational kernels to effectively exploit the resources in modern processor architectures. Nevertheless, selecting required compositions of loop transformations to achieve this remains a significantly challenging task; current compilers may be off by orders of magnitude in performance compared to hand-optimized programs. To address this fundamental challenge, we first present a convex characterization of all distinct, semantics-preserving, multidimensional affine transformations. We then bring together algebraic, algorithmic, and performance analysis results to design a tractable optimization algorithm over this highly expressive space. Our framework has been implemented and validated experimentally on a representative set of benchmarks running on state-of-the-art multi-core platforms.
Resumo:
Motivated by experiments on Josephson junction arrays in a magnetic field and ultracold interacting atoms in an optical lattice in the presence of a ``synthetic'' orbital magnetic field, we study the ``fully frustrated'' Bose-Hubbard model and quantum XY model with half a flux quantum per lattice plaquette. Using Monte Carlo simulations and the density matrix renormalization group method, we show that these kinetically frustrated boson models admit three phases at integer filling: a weakly interacting chiral superfluid phase with staggered loop currents which spontaneously break time-reversal symmetry, a conventional Mott insulator at strong coupling, and a remarkable ``chiral Mott insulator'' (CMI) with staggered loop currents sandwiched between them at intermediate correlation. We discuss how the CMI state may be viewed as an exciton condensate or a vortex supersolid, study a Jastrow variational wave function which captures its correlations, present results for the boson momentum distribution across the phase diagram, and consider various experimental implications of our phase diagram. Finally, we consider generalizations to a staggered flux Bose-Hubbard model and a two-dimensional (2D) version of the CMI in weakly coupled ladders.
Resumo:
Conformational diversity or shapeshifting in cyclic peptide natural products can, in principle, confer a single molecular entity with the property of binding to multiple receptors. Conformational equilibria have been probed in the contryphans, which are peptides derived from Conus venom possessing a 23-membered cyclic disulfide moiety. The natural sequences derived from Conus inscriptus, GCV(D)LYPWC* (In936) and Conus loroisii, GCP(D)WDPWC* (Lo959) differ in the number of proline residues within the macrocyclic ring. Structural characterisation of distinct conformational states arising from cis-trans equilibria about Xxx-Pro bonds is reported. Isomerisation about the C2-P3 bond is observed in the case of Lo959 and about the Y5-P6 bond in In936. Evidence is presented for as many as four distinct species in the case of the synthetic analogue V3P In936. The Tyr-Pro-Trp segment in In936 is characterised by distinct sidechain orientations as a consequence of aromatic/proline interactions as evidenced by specific sidechain-sidechain nuclear Overhauser effects and ring current shifted proton chemical shifts. Molecular dynamics simulations suggest that Tyr5 and Trp7 sidechain conformations are correlated and depend on the geometry of the Xxx-Pro bond. Thermodynamic parameters are derived for the cis trans equilibrium for In936. Studies on synthetic analogues provide insights into the role of sequence effects in modulating isomerisation about Xxx-Pro bonds.
Resumo:
Closed loop current sensors used in power electronics applications are expected to have high bandwidth and minimal measurement transients. In this paper, a closed loop compensated Hall-effect current sensor is modeled. The model is used to tune the sensor's compensator. Analytical expression of step response is used to evaluate the performance of the PI compensator in the current sensor. This analysis is used to devise a procedure to design parameters of the PI compensator for fast dynamic response and for small dynamic error. A prototype current sensor is built in the laboratory. Simulations using the model are compared with experimental results to validate the model and to study the variation in performance with compensator parameters. The performance of the designed PI compensator for the sensor is compared with a commercial current sensor. The measured bandwidth of the designed current sensor is above 200 kHz, which is comparable to commercial standards. Implementation issues of PI compensator using operational amplifiers are also addressed.
Resumo:
This paper reports instability and oscillations in the stator current under light-load conditions in a practical 100-kW induction motor drive. Dead-time is shown to be a cause for such oscillations. This paper shows experimentally that these oscillations could be mitigated significantly with the help of a simple dead-time compensation scheme.
Resumo:
Thiolases are essential CoA-dependent enzymes in lipid metabolism. In the present study we report the crystal structures of trypanosomal and leishmanial SCP2 (sterol carrier protein, type-2)-thiolases. Trypanosomatidae cause various widespread devastating (sub)-tropical diseases, for which adequate treatment is lacking. The structures reveal the unique geometry of the active site of this poorly characterized subfamily of thiolases. The key catalytic residues of the classical thiolases are two cysteine residues, functioning as a nucleophile and an acid/base respectively. The latter cysteine residue is part of a CxG motif. Interestingly, this cysteine residue is not conserved in SCP2-thiolases. The structural comparisons now show that in SCP2-thiolases the catalytic acid/base is provided by the cysteine residue of the HDCF motif, which is unique for this thiolase subfamily. This HDCF cysteine residue is spatially equivalent to the CxG cysteine residue of classical thiolases. The HDCF cysteine residue is activated for acid/base catalysis by two main chain NH-atoms, instead of two water molecules, as present in the CxG active site. The structural results have been complemented with enzyme activity data, confirming the importance of the HDCF cysteine residue for catalysis. The data obtained suggest that these trypanosomatid SCP2-thiolases are biosynthetic thiolases. These findings provide promise for drug discovery as biosynthetic thiolases catalyse the first step of the sterol biosynthesis pathway that is essential in several of these parasites.
Resumo:
This paper reports instability and oscillations in the stator current under light-load conditions in a practical 100-kW induction motor drive. Dead-time is shown to be a cause for such oscillations. This paper shows experimentally that these oscillations could be mitigated significantly with the help of a simple dead-time compensation scheme.
Resumo:
Mitochondrial Hsp70 (mtHsp70) is essential for a vast repertoire of functions, including protein import, and requires effective interdomain communication for efficient partner-protein interactions. However, the in vivo functional significance of allosteric regulation in eukaryotes is poorly defined. Using integrated biochemical and yeast genetic approaches, we provide compelling evidence that a conserved substrate-binding domain (SBD) loop, L-4,L-5, plays a critical role in allosteric communication governing mtHsp70 chaperone functions across species. In yeast, a temperature-sensitive L-4,L-5 mutation (E467A) disrupts bidirectional domain communication, leading to compromised protein import and mitochondrial function. Loop L-4,L-5 functions synergistically with the linker in modulating the allosteric interface and conformational transitions between SBD and the nucleotide-binding domain (NBD), thus regulating interdomain communication. Second-site intragenic suppressors of E467A isolated within the SBD suppress domain communication defects by conformationally altering the allosteric interface, thereby restoring import and growth phenotypes. Strikingly, the suppressor mutations highlight that restoration of communication from NBD to SBD alone is the minimum essential requirement for effective in vivo function when primed at higher basal ATPase activity, mimicking the J-protein-bound state. Together these findings provide the first mechanistic insights into critical regions within the SBD of mtHsp70s regulating interdomain communication, thus highlighting its importance in protein translocation and mitochondrial biogenesis.
Resumo:
Polyhedral techniques for program transformation are now used in several proprietary and open source compilers. However, most of the research on polyhedral compilation has focused on imperative languages such as C, where the computation is specified in terms of statements with zero or more nested loops and other control structures around them. Graphical dataflow languages, where there is no notion of statements or a schedule specifying their relative execution order, have so far not been studied using a powerful transformation or optimization approach. The execution semantics and referential transparency of dataflow languages impose a different set of challenges. In this paper, we attempt to bridge this gap by presenting techniques that can be used to extract polyhedral representation from dataflow programs and to synthesize them from their equivalent polyhedral representation. We then describe PolyGLoT, a framework for automatic transformation of dataflow programs which we built using our techniques and other popular research tools such as Clan and Pluto. For the purpose of experimental evaluation, we used our tools to compile LabVIEW, one of the most widely used dataflow programming languages. Results show that dataflow programs transformed using our framework are able to outperform those compiled otherwise by up to a factor of seventeen, with a mean speed-up of 2.30x while running on an 8-core Intel system.
Resumo:
This paper demonstrates light-load instability in open-loop induction motor drives on account of inverter dead-time. The dynamic equations of an inverter fed induction motor, incorporating the effect of dead-time, are considered. A procedure to derive the small-signal model of the motor, including the effect of inverter dead-time, is presented. Further, stability analysis is carried out on a 100-kW, 415V, 3-phase induction motor considering no-load. For voltage to frequency (i.e. V/f) ratios between 0.5 and 1 pu, the analysis brings out regions of instability on the V-f plane, in the frequency range between 5Hz and 20Hz. Simulation and experimental results show sub-harmonic oscillations in the motor current in this region, confirming instability as predicted by the analysis.
Resumo:
Wavelength Division Multiplexing (WDM) techniques overfibrelinks helps to exploit the high bandwidth capacity of single mode fibres. A typical WDM link consisting of laser source, multiplexer/demultiplexer, amplifier and detectoris considered for obtaining the open loop gain model of the link. The methodology used here is to obtain individual component models using mathematical and different curve fitting techniques. These individual models are then combined to obtain the WDM link model. The objective is to deduce a single variable model for the WDM link in terms of input current to system. Thus it provides a black box solution for a link. The Root Mean Square Error (RMSE) associated with each of the approximated models is given for comparison. This will help the designer to select the suitable WDM link model during a complex link design.
Resumo:
The charge-pump (CP) mismatch current is a dominant source of static phase error and reference spur in the nano-meter CMOS PLL implementations due to its worsened channel length modulation effect. This paper presents a charge-pump (CP) mismatch current reduction technique utilizing an adaptive body bias tuning of CP transistors and a zero CP mismatch current tracking PLL architecture for reference spur suppression. A chip prototype of the proposed circuit was implemented in 0.13 mu m CMOS technology. The frequency synthesizer consumes 8.2 mA current from a 13 V supply voltage and achieves a phase noise of -96.01 dBc/Hz @ 1 MHz offset from a 2.4 GHz RF carrier. The charge-pump measurements using the proposed calibration technique exhibited a mismatch current of less than 0.3 mu A (0.55%) over the VCO control voltage range of 0.3-1.0 V. The closed loop measurements show a minimized static phase error of within +/- 70 ps and a similar or equal to 9 dB reduction in reference spur level across the PLL output frequency range 2.4-2.5 GHz. The presented CP calibration technique compensates for the DC current mismatch and the mismatch due to channel length modulation effect and therefore improves the performance of CP-PLLs in nano-meter CMOS implementations. (C) 2015 Elsevier Ltd. All rights reserved.
Resumo:
This paper demonstrates light-load instability in a 100-kW open-loop induction motor drive on account of inverter deadtime. An improved small-signal model of an inverter-fed induction motor is proposed. This improved model is derived by linearizing the nonlinear dynamic equations of the motor, which include the inverter deadtime effect. Stability analysis is carried out on the 100-kW415-V three-phase induction motor considering no load. The analysis brings out the region of instability of this motor drive on the voltage versus frequency (V-f) plane. This region of light-load instability is found to expand with increase in inverter deadtime. Subharmonic oscillations of significant amplitude are observed in the steady-state simulated and measured current waveforms, at numerous operating points in the unstable region predicted, confirming the validity of the stability analysis. Furthermore, simulation and experimental results demonstrate that the proposed model is more accurate than an existing small-signal model in predicting the region of instability.
Resumo:
The objective of this paper is to study the influence of inverter dead-time on steady as well as dynamic operation of an open-loop induction motor drive fed from a voltage source inverter (VSI). Towards this goal, this paper presents a systematic derivation of a dynamic model for an inverter-fed induction motor, incorporating the effect of inverter dead-time, in the synchronously revolving dq reference frame. Simulation results based on this dynamic model bring out the impact of inverter dead-time on both the transient response and steady-state operation of the motor drive. For the purpose of steady-state analysis, the dynamic model of the motor drive is used to derive a steady-state model, which is found to be non-linear. The steady-state model shows that the impact of dead-time can be seen as an additional resistance in the stator circuit, whose value depends on the stator current. Towards precise evaluation of this dead-time equivalent resistance, an analytical expression is proposed for the same in terms of inverter dead-time, switching frequency, modulation index and load impedance. The notion of dead-time equivalent resistance is shown to simplify the solution of the non-linear steady-state model. The analytically evaluated steady-state solutions are validated through numerical simulations and experiments.
Resumo:
Despite extensive research into triosephosphate isomerases (TIMs), there exists a gap in understanding of the remarkable conjunction between catalytic loop-6 (residues 166-176) movement and the conformational flip of Glu165 (catalytic base) upon substrate binding that primes the active site for efficient catalysis. The overwhelming occurrence of serine at position96 (98% of the 6277 unique TIM sequences), spatially proximal to E165 and the loop-6 residues, raises questions about its role in catalysis. Notably, Plasmodium falciparum TIM has an extremely rare residuephenylalanineat this position whereas, curiously, the mutant F96S was catalytically defective. We have obtained insights into the influence of residue96 on the loop-6 conformational flip and E165 positioning by combining kinetic and structural studies on the PfTIM F96 mutants F96Y, F96A, F96S/S73A, and F96S/L167V with sequence conservation analysis and comparative analysis of the available apo and holo structures of the enzyme from diverse organisms.