10-bit Pipeline ADC Design

Size: px
Start display at page:

Download "10-bit Pipeline ADC Design"

Transcription

1 Wenxu Zhao ID: ECE592 Analog Digital Converter 10-bit Pipeline ADC Design Part I Results 1. Block diagram A 10-bit pipeline ADC was designed with 100MHz nyquist frequency at full scale of 500mV. A 1.5-bit sub-adc was implemented in each stage. Delay & Combine CLK ф1 D Q CLK ф1 Σ D Q CLK Σ D Q CLK 10 Dout Vin SHA Stage 1 Stage 2 Stage 10 ф1 ф1 ф1 Vin1 SHA Σ G Vres1 ADC DAC - 2 Unit Stage Figure 1 Diagram of 10 bit pipeline ADC implemented with 1.5 bit sub ADC 2. Nonlinearity performance Table 1 DNL/INL and ENOB calculated from Monte Carlo Simulation Offset Noise Gain error DNL (3σ) INL (3σ) ENOB (no cali) ENOB (with cali) σ = 3mV σ = 1mV σ = lsb 39 lsb 4.7 bits 8 bits 3. Timing domain and FFT analysis SNDR =63.34dB ENOB=10.2 bits Figure 2 Testbench configuration for time domain and FFT analysis 4. Limiting factors of ENOB The nonlinearity of gain block in the first several stages contributes to the DNL/INL degradation. For instance, 1 σ (3mV) of input offset in the gain block of first stage would result in a DNL of 6.15 lsb (lsb = 0.488uV) at the output.

2 Part II Simulation and Calculation Figure 3 DNL of each code without calibration Figure 4 INL of each code without calibration σ_(dnl_max) = 2.4 lsb σ_(inl_max) = 13 lsb Figure 5 SNDR of a 101MHz sine wave input Table 2 FFT analysis of sine wave input f f f B N SNDR ENOB 101MHz 1GHz 10GHz dB 10.2 bits ENOB = (SNDR-1.76)/6.02 = 10.2 bits

3 Part III Calibration of gain stage input offset An ideal 5-bit DAC driven by finite state machine was designed to implement the offset calibration scheme. The full scale of 5-bit DAC is from -10mV to 10mV, successfully covers the 3σ (9mV) offset mismatch of gain input. IDLE Startup FIRST MAX offset? NO Ideal DAC 5 FSM YES INCREASE NO Vin + + Σ G Vout MIN offset? YES KEEP Figure 6 Block diagram of calibration method Figure 7 Flow diagram of calibration (FSM) Two worst case of offset scenarios (± 3 σ) demonstrations: Gain input Gain output Figure 8 start up calibration for 9mV input offset Note 9mV offset has been cancelled by DAC output of 8.75mV, resulting in an overall 250uV input offset Gain input Gain output Figure 9 start up calibration for 9mV input offset Note 9mV offset has been cancelled by DAC output of 8.75mV, resulting in an overall 250uV input offset

4 Appix A. Finite state machine implemented with Verilog-a code // VerilogA for pipeline_adc, offset_cali_fsm, veriloga // case should be put into clock block `include "constants.vams" `include "disciplines.vams" `define IDLE 0 `define FIRST 1 `define INCREASE 2 `define KEEP 3 module offset_cali_fsm (clk, gain, dac, finish); input clk, gain; electrical clk, gain; output [4:0] dac; output finish; electrical [4:0] dac; electrical finish; parameter real zero = 0; parameter real one = 2; parameter real vth = 1; parameter real slack = 1p from [0:inf); parameter real trise = 10p from [0:inf); parameter real tfall = 10p from [0:inf); parameter real tconv = 10p from [0:inf); parameter integer traceflag = 0; integer counter, counter_current, offset, offset_current, ii; integer current_state, next_state; real gain_p2, gain_p1, gain_current; real dac_out[4:0]; real finish_out; analog begin

5 @( initial_step or initial_step("dc", "ac", "tran", "xf") ) begin counter = zero; counter_current = zero; offset = zero; current_state = `IDLE; next_state = `IDLE; gain_p2 = zero; gain_p1 = zero; gain_current = zero; finish_out = zero; generate i (4, 0) begin dac_out[i] = cross (V(clk)-vth, 1, slack ) ) begin // counter = counter+1; counter_current = counter; gain_p2 = gain_p1; gain_p1 = gain_current; current_state = next_state; case (current_state) `IDLE: begin next_state = `FIRST; finish_out = zero; generate i (4, 0) begin dac_out[i] = zero; gain_current = V(gain); `FIRST: begin // next_state = SECOND; finish_out = zero; generate i (4, 1) begin dac_out[i] = zero;

6 dac_out[0] = one; gain_current = V(gain); if ( abs(gain_p1) < abs(gain_current) ) begin next_state = `KEEP; else begin next_state = `INCREASE; `INCREASE:begin finish_out = zero; for (ii = 0; ii<=4; ii = ii+1) begin if(counter_current%2) begin dac_out[ii] = one; else begin dac_out[ii] = zero; counter_current = counter_current/2; gain_current = V(gain); if ( abs(gain_p1) < abs(gain_current) && abs(gain_p1) < abs(gain_p2) ) begin next_state = `KEEP; else begin next_state = `INCREASE; offset = counter-1; `KEEP: begin finish_out = one; offset_current = offset; for (ii = 0; ii<=4; ii = ii+1) begin if(offset_current%2) begin dac_out[ii] = one; else begin dac_out[ii] = zero; offset_current = offset_current/2; next_state = `KEEP;

7 case V(finish) <+ transition (finish_out, tconv, trise, tfall); generate i (4, 0) begin V(dac[i]) <+ transition ( dac_out[i], tconv, trise, tfall ); module

8 B. Matlab code for FFT analysis % Code for FFT analysis of Pipeline ADC followed by ideal DAC output % Author: Wenxu Zhao % Date: 11/12/2013 % Input frequency = MHz % ADC clock = 1GHz % Fs = 10GHz clear all close all fc = 5e8; %cutoff frequency for SNDR calculation fadc = 1e9; fs = 1e10; N = 8192; cycles = 83; fx = ; % fx=fs*cycles/n B = 10; Vfs = 0.5; LSB = Vfs/(2^B-1); %take FFT data = load('101m_1g_10g_8192.matlab'); y = data (:,2); % second column of data length_data = length(y); y=y.'; Y = abs(fft(y, N)); Y = Y(1:/2)./N*2; PSD = fft(y, N).*conj(fft(y, N))./N./fs; psd_db = 10*log10(PSD); figure(1) plot(fx/fs.*[0:n-1],psd_db); title('psd') xlabel('bins') ylabel('psd') % frequency vector f = [0:N/2-1]/N;

9 figure(2) plot(f, 20*log10(Y(1:N/2)),'-b'); title('fft') xlabel('frequency [f/fs]') ylabel('dft Magnitude [dbfs]') % calculate SNR Boser_quantization_noise_2 sigbin = find(y==max(y)); %find signal bin r = Y(sigbin+1:); %find image bin image_bin = find(y==max(y)); %store image bin noise = [Y(2:sigbin-1), Y(sigbin+1:round(N*fadc/fs/2))]; %only count upto fdac/fs; sndr = 10*log10( Y(sigbin)^2/sum(noise.^2) ); quant_noise=10*log10((sum(noise.^2))); quant_noise_calc=10*log10((lsb^2/b)); sig_power=(y(sigbin)^2); enob = (sndr )/6.02; figure(3); [enob,sndr,sfdr,snr] = prettyfft(y, fs); SNDR = sndr; ENOB = (sndr-1.76)/6.02;

10 C. Matlab code for DNL/INL calculation clear all; close all; N_mc = 49; N_code = 1024; OSR = 10; dac_data = load('dac_49_sampled.matlab'); %dac_out = []; %1D dnl = []; %2D DNL results inl = []; for n = 1:N_mc dac_out = dac_data(:, n*2); length_code = length(dac_out); Wavg = length_code/n_code; counter_dnl = 1; code_dnl = 1; for m = 2:length_code code_previous = dac_out(m-1); code_current = dac_out(m); if code_previous == code_current counter_dnl = counter_dnl + 1; else dnl(code_dnl, n) = (counter_dnl-wavg)/wavg; if code_dnl < 2 inl(code_dnl, n) = 0; else inl(code_dnl, n) = inl(code_dnl-1, n) + dnl(code_dnl, n); code_dnl = code_dnl + 1; counter_dnl = 1; dnl_rms = []; N_dnl_rows = size(dnl,1); for k = 1:N_dnl_rows dnl_rms(k) = sqrt(mean(dnl(k).^2));

11 figure(1) plot(dnl_rms); title('monte Carlo DNL'); ylabel('dnl(rms)'); xlabel('codes'); inl_rms = []; N_inl_rows = size(inl,1); for l = 1:N_inl_rows inl_rms(l) = sqrt(mean(inl(l).^2)); figure(2) plot(inl_rms); title('monte Carlo INL'); ylabel('inl(rms)'); xlabel('codes');

Finite state machines (cont d)

Finite state machines (cont d) Finite state machines (cont d)! Another type of shift register " Linear-feedback shift register (LFSR)! Used to generate pseudo-random numbers! Some FSM examples Autumn 2014 CSE390C - VIII - Finite State

More information

Accelerating Financial Computation

Accelerating Financial Computation Accelerating Financial Computation Wayne Luk Department of Computing Imperial College London HPC Finance Conference and Training Event Computational Methods and Technologies for Finance 13 May 2013 1 Accelerated

More information

Lattice Coding and its Applications in Communications

Lattice Coding and its Applications in Communications Lattice Coding and its Applications in Communications Alister Burr University of York alister.burr@york.ac.uk Introduction to lattices Definition; Sphere packings; Basis vectors; Matrix description Codes

More information

Machine Learning for Quantitative Finance

Machine Learning for Quantitative Finance Machine Learning for Quantitative Finance Fast derivative pricing Sofie Reyners Joint work with Jan De Spiegeleer, Dilip Madan and Wim Schoutens Derivative pricing is time-consuming... Vanilla option pricing

More information

CDA6530: Performance Models of Computers and Networks. Chapter 9: Discrete Event Simulation Example --- Three callers problem

CDA6530: Performance Models of Computers and Networks. Chapter 9: Discrete Event Simulation Example --- Three callers problem CDA6530: Performance Models of Computers and Networks Chapter 9: Discrete Event Simulation Example --- Three callers problem Problem Description Two lines services three callers. Each caller makes calls

More information

FPGA PUF Based on Programmable LUT Delays

FPGA PUF Based on Programmable LUT Delays FPGA PUF Based on Programmable LUT Delays Bilal Habib Kris Gaj Jens-Peter Kaps Cryptographic Engineering Research Group (CERG) http://cryptography.gmu.edu Department of ECE, Volgenau School of Engineering,

More information

Uncertainty modeling revisited: What if you don t know the probability distribution?

Uncertainty modeling revisited: What if you don t know the probability distribution? : What if you don t know the probability distribution? Hans Schjær-Jacobsen Technical University of Denmark 15 Lautrupvang, 275 Ballerup, Denmark hschj@dtu.dk Uncertain input variables Uncertain system

More information

Chapter 7. Registers & Register Transfers. J.J. Shann. J. J. Shann

Chapter 7. Registers & Register Transfers. J.J. Shann. J. J. Shann Chapter 7 Registers & Register Transfers J. J. Shann J.J. Shann Chapter Overview 7-1 Registers and Load Enable 7-2 Register Transfers 7-3 Register Transfer Operations 7-4 A Note for VHDL and Verilog Users

More information

Power Spectral Density

Power Spectral Density Spectral Estimation Power Spectral Density Estimation of PSD of a stochastic process X is most commonly done by sampling it for a finite time and analyzing the samples with the discrete Fourier transform

More information

EE115C Spring 2013 Digital Electronic Circuits. Lecture 19: Timing Analysis

EE115C Spring 2013 Digital Electronic Circuits. Lecture 19: Timing Analysis EE115C Spring 2013 Digital Electronic Circuits Lecture 19: Timing Analysis Outline Timing parameters Clock nonidealities (skew and jitter) Impact of Clk skew on timing Impact of Clk jitter on timing Flip-flop-

More information

Reconfigurable Acceleration for Monte Carlo based Financial Simulation

Reconfigurable Acceleration for Monte Carlo based Financial Simulation Reconfigurable Acceleration for Monte Carlo based Financial Simulation G.L. Zhang, P.H.W. Leong, C.H. Ho, K.H. Tsoi, C.C.C. Cheung*, D. Lee**, Ray C.C. Cheung*** and W. Luk*** The Chinese University of

More information

White Paper: Comparison of Narrowband and Ultra Wideband Channels. January 2008

White Paper: Comparison of Narrowband and Ultra Wideband Channels. January 2008 White Paper: Comparison of Narrowband and Ultra Wideband Channels January 28 DOCUMENT APPROVAL: Author signature: Satisfied that this document is fit for purpose, contains sufficient and correct detail

More information

Oorja Technical Services Private Limited, 316/317 Block MS 1-B, Opp. Mall Godown Road, New Siyaganj, Indore, Madhya Pradesh

Oorja Technical Services Private Limited, 316/317 Block MS 1-B, Opp. Mall Godown Road, New Siyaganj, Indore, Madhya Pradesh Last Amended on 05.02.2016 Page 1 of 5 MEASURE 1. DC VOLTAGE $ 1mV to 100 mv 0.029 % to 0.002 % Using Fluke 8½ Digit 100 mv to 10 V 0.002 % to 0.0004% Reference Mutimeter by 10 V to 1000 V 0.0004 % to

More information

Calcolatori Elettronici Anno Accademico 2001/2002. FSM in VHDL. Macchina a Stati Finiti (FSM) Tipo Moore. Esempio: Macchina di Moore a due stati

Calcolatori Elettronici Anno Accademico 2001/2002. FSM in VHDL. Macchina a Stati Finiti (FSM) Tipo Moore. Esempio: Macchina di Moore a due stati Macchina a Stati Finiti (FSM) Tipo Moore Calcolatori Elettronici Anno Accademico 2/22 FSM in VHDL Gianluca Palermo Politecnico di Milano Dipartimento di Elettronica e Informazione e-mail: gpalermo@fusberta.elet.polimi.it

More information

PUF RO (RING OSCILLATOR)

PUF RO (RING OSCILLATOR) PUF RO (RING OSCILLATOR) EEC 492/592, CIS 493 Hands-on Experience on Computer System Security Chan Yu Cleveland State University CIRCUIT PUF - PREVIOUS WORK Ravikanth et. al proposed the first PUF in literature

More information

Module 2: Monte Carlo Methods

Module 2: Monte Carlo Methods Module 2: Monte Carlo Methods Prof. Mike Giles mike.giles@maths.ox.ac.uk Oxford University Mathematical Institute MC Lecture 2 p. 1 Greeks In Monte Carlo applications we don t just want to know the expected

More information

3.6V / 2600mAh Primary Lithium x 0.85 (60mm x 21mm) 1.0 oz (28 gr) -30 C to +77 C. Bluetooth Low Energy dBm. +5dBm. 1Mbit/s / 2Mbit/s*

3.6V / 2600mAh Primary Lithium x 0.85 (60mm x 21mm) 1.0 oz (28 gr) -30 C to +77 C. Bluetooth Low Energy dBm. +5dBm. 1Mbit/s / 2Mbit/s* SPECIFICATION SHEET BEEKs Industrial VER 1.6 HARDWARE SPECIFICATION Battery Size Weight Temperature Range Bluetooth Type Bluetooth Sensitivity Bluetooth Max Power Output Bluetooth Antenna Frequency Supported

More information

1. In this exercise, we can easily employ the equations (13.66) (13.70), (13.79) (13.80) and

1. In this exercise, we can easily employ the equations (13.66) (13.70), (13.79) (13.80) and CHAPTER 13 Solutions Exercise 1 1. In this exercise, we can easily employ the equations (13.66) (13.70), (13.79) (13.80) and (13.82) (13.86). Also, remember that BDT model will yield a recombining binomial

More information

Analytical Finance 1 Seminar Monte-Carlo application for Value-at-Risk on a portfolio of Options, Futures and Equities

Analytical Finance 1 Seminar Monte-Carlo application for Value-at-Risk on a portfolio of Options, Futures and Equities Analytical Finance 1 Seminar Monte-Carlo application for Value-at-Risk on a portfolio of Options, Futures and Equities Radhesh Agarwal (Ral13001) Shashank Agarwal (Sal13002) Sumit Jalan (Sjn13024) Calculating

More information

Physical Unclonable Functions (PUFs) and Secure Processors. Srini Devadas Department of EECS and CSAIL Massachusetts Institute of Technology

Physical Unclonable Functions (PUFs) and Secure Processors. Srini Devadas Department of EECS and CSAIL Massachusetts Institute of Technology Physical Unclonable Functions (PUFs) and Secure Processors Srini Devadas Department of EECS and CSAIL Massachusetts Institute of Technology 1 Security Challenges How to securely authenticate devices at

More information

Chapter Fourteen: Simulation

Chapter Fourteen: Simulation TaylCh14ff.qxd 4/21/06 8:39 PM Page 213 Chapter Fourteen: Simulation PROBLEM SUMMARY 1. Rescue squad emergency calls PROBLEM SOLUTIONS 1. 2. Car arrivals at a service station 3. Machine breakdowns 4. Income

More information

System Simulation Chapter 2: Simulation Examples

System Simulation Chapter 2: Simulation Examples System Simulation Chapter 2: Simulation Examples Fatih Cavdur fatihcavdur@uludag.edu.tr March 29, 21 Introduction Several examples of simulation that can be performed by devising a simulation table either

More information

Lecture 8: Skew Tolerant Design (including Dynamic Circuit Issues)

Lecture 8: Skew Tolerant Design (including Dynamic Circuit Issues) Lecture 8: Skew Tolerant Design (including Dynamic Circuit Issues) Computer Systems Laboratory Stanford University horowitz@stanford.edu Copyright 2007 by Mark Horowitz w/ material from David Harris 1

More information

Practical Section 02 May 02, Part 1: Analytic transforms versus FFT algorithm. AnalBoxCar = 2*AB*BW*sin(2*pi*BW*f).

Practical Section 02 May 02, Part 1: Analytic transforms versus FFT algorithm. AnalBoxCar = 2*AB*BW*sin(2*pi*BW*f). 12.714 Practical Section 02 May 02, 2012 Part 1: Analytic transforms versus FFT algorithm (a) For a box car time domain signal with width 2*BW and amplitude BA, compare the analytic version of the Fourier

More information

Soft Response Generation and Thresholding Strategies for Linear and Feed-Forward MUX PUFs

Soft Response Generation and Thresholding Strategies for Linear and Feed-Forward MUX PUFs Soft Response Generation and Thresholding Strategies for Linear and Feed-Forward MUX PUFs Chen Zhou, SarojSatapathy, YingjieLao, KeshabK. Parhiand Chris H. Kim Department of ECE University of Minnesota

More information

A Heuristic Method for Statistical Digital Circuit Sizing

A Heuristic Method for Statistical Digital Circuit Sizing A Heuristic Method for Statistical Digital Circuit Sizing Stephen Boyd Seung-Jean Kim Dinesh Patil Mark Horowitz Microlithography 06 2/23/06 Statistical variation in digital circuits growing in importance

More information

Pathloss and Link Budget From Physical Propagation to Multi-Path Fading Statistical Characterization of Channels. P r = P t Gr G t L P

Pathloss and Link Budget From Physical Propagation to Multi-Path Fading Statistical Characterization of Channels. P r = P t Gr G t L P Path Loss I Path loss L P relates the received signal power P r to the transmitted signal power P t : P r = P t Gr G t L P, where G t and G r are antenna gains. I Path loss is very important for cell and

More information

Write legibly. Unreadable answers are worthless.

Write legibly. Unreadable answers are worthless. MMF 2021 Final Exam 1 December 2016. This is a closed-book exam: no books, no notes, no calculators, no phones, no tablets, no computers (of any kind) allowed. Do NOT turn this page over until you are

More information

Moving PUFs out of the lab

Moving PUFs out of the lab Moving PUFs out of the lab Patrick Schaumont 2/3/2012 Research results by Abhranil Maiti, Jeff Casarona, Luke McHale, Logan McDougall, Vikash Gunreddy, Michael Cantrell What is a Physical Unclonable Function?

More information

Max Registers, Counters and Monotone Circuits

Max Registers, Counters and Monotone Circuits James Aspnes 1 Hagit Attiya 2 Keren Censor 2 1 Yale 2 Technion Counters Model Collects Our goal: build a cheap counter for an asynchronous shared-memory system. Two operations: increment and read. Read

More information

Razor Risk Market Risk Overview

Razor Risk Market Risk Overview Razor Risk Market Risk Overview Version 1.0 (Final) Prepared by: Razor Risk Updated: 20 April 2012 Razor Risk 7 th Floor, Becket House 36 Old Jewry London EC2R 8DD Telephone: +44 20 3194 2564 e-mail: peter.walsh@razor-risk.com

More information

Notes. Cases on Static Optimization. Chapter 6 Algorithms Comparison: The Swing Case

Notes. Cases on Static Optimization. Chapter 6 Algorithms Comparison: The Swing Case Notes Chapter 2 Optimization Methods 1. Stationary points are those points where the partial derivatives of are zero. Chapter 3 Cases on Static Optimization 1. For the interested reader, we used a multivariate

More information

A Physical Unclonable Function based on Capacitor Mismatch in a Charge-Redistribution SAR-ADC

A Physical Unclonable Function based on Capacitor Mismatch in a Charge-Redistribution SAR-ADC A Physical Unclonable Function based on Capacitor Mismatch in a Charge-Redistribution SAR-ADC Qianying Tang, Won Ho Choi, Luke Everson, Keshab K. Parhi and Chris H. Kim University of Minnesota Department

More information

CS476/676 Mar 6, Today s Topics. American Option: early exercise curve. PDE overview. Discretizations. Finite difference approximations

CS476/676 Mar 6, Today s Topics. American Option: early exercise curve. PDE overview. Discretizations. Finite difference approximations CS476/676 Mar 6, 2019 1 Today s Topics American Option: early exercise curve PDE overview Discretizations Finite difference approximations CS476/676 Mar 6, 2019 2 American Option American Option: PDE Complementarity

More information

AN021: RF MODULES RANGE CALCULATIONS AND TEST

AN021: RF MODULES RANGE CALCULATIONS AND TEST AN021: RF MODULES RANGE CALCULATIONS AND TEST We Make Embedded Wireless Easy to Use RF Modules Range Calculation and Test By T.A.Lunder and P.M.Evjen Keywords Definition of Link Budget, Link Margin, Antenna

More information

Lecture 8: Skew Tolerant Domino Clocking

Lecture 8: Skew Tolerant Domino Clocking Lecture 8: Skew Tolerant Domino Clocking Computer Systems Laboratory Stanford University horowitz@stanford.edu Copyright 2001 by Mark Horowitz (Original Slides from David Harris) 1 Introduction Domino

More information

Insertion loss (db) TOP VIEW SIDE VIEW BOTTOM VIEW. 4x ± ± Orientation Marker Denotes Pin Location 4x 0.

Insertion loss (db) TOP VIEW SIDE VIEW BOTTOM VIEW. 4x ± ± Orientation Marker Denotes Pin Location 4x 0. Model DC4759J52AHF Ultra Low Profile 85 2dB Directional Coupler Description The DC4759J52AHF is a low cost, low profile sub-miniature high performance 2 db directional coupler in an easy to use RoH compliant,

More information

Midas Margin Model SIX x-clear Ltd

Midas Margin Model SIX x-clear Ltd xcl-n-904 March 016 Table of contents 1.0 Summary 3.0 Introduction 3 3.0 Overview of methodology 3 3.1 Assumptions 3 4.0 Methodology 3 4.1 Stoc model 4 4. Margin volatility 4 4.3 Beta and sigma values

More information

Analytics in 10 Micro-Seconds Using FPGAs. David B. Thomas Imperial College London

Analytics in 10 Micro-Seconds Using FPGAs. David B. Thomas Imperial College London Analytics in 10 Micro-Seconds Using FPGAs David B. Thomas dt10@imperial.ac.uk Imperial College London Overview 1. The case for low-latency computation 2. Quasi-Random Monte-Carlo in 10us 3. Binomial Trees

More information

Design of a Financial Application Driven Multivariate Gaussian Random Number Generator for an FPGA

Design of a Financial Application Driven Multivariate Gaussian Random Number Generator for an FPGA Design of a Financial Application Driven Multivariate Gaussian Random Number Generator for an FPGA Chalermpol Saiprasert, Christos-Savvas Bouganis and George A. Constantinides Department of Electrical

More information

Final exam solutions

Final exam solutions EE365 Stochastic Control / MS&E251 Stochastic Decision Models Profs. S. Lall, S. Boyd June 5 6 or June 6 7, 2013 Final exam solutions This is a 24 hour take-home final. Please turn it in to one of the

More information

Model Calibration in MATLAB. Sam Bailey, PRUDENTIAL

Model Calibration in MATLAB. Sam Bailey, PRUDENTIAL Model Calibration in MATLAB Sam Bailey, PRUDENTIAL Calibrating the Risk Scenarios Need to calibrate statistical models for all the market risks we are exposed to for example equity level equity volatility

More information

FAILURE RATE TRENDS IN AN AGING POPULATION MONTE CARLO APPROACH

FAILURE RATE TRENDS IN AN AGING POPULATION MONTE CARLO APPROACH FAILURE RATE TRENDS IN AN AGING POPULATION MONTE CARLO APPROACH Niklas EKSTEDT Sajeesh BABU Patrik HILBER KTH Sweden KTH Sweden KTH Sweden niklas.ekstedt@ee.kth.se sbabu@kth.se hilber@kth.se ABSTRACT This

More information

SCHEDULE CREATION AND ANALYSIS. 1 Powered by POeT Solvers Limited

SCHEDULE CREATION AND ANALYSIS. 1   Powered by POeT Solvers Limited SCHEDULE CREATION AND ANALYSIS 1 www.pmtutor.org Powered by POeT Solvers Limited While building the project schedule, we need to consider all risk factors, assumptions and constraints imposed on the project

More information

CDAUI-8 Chip-to-Module (C2M) System Analysis. Stephane Dallaire and Ben Smith, August 24 th 2015

CDAUI-8 Chip-to-Module (C2M) System Analysis. Stephane Dallaire and Ben Smith, August 24 th 2015 CDAUI-8 Chip-to-Module (C2M) System Analysis Stephane Dallaire and Ben Smith, August 24 th 2015 Introduction We investigate the merits of various reference receiver architectures for 26.5625GBaud PAM4

More information

Atmospheric Turbulence Degraded Image Restoration by Kurtosis Minimization

Atmospheric Turbulence Degraded Image Restoration by Kurtosis Minimization Atmospheric Turbulence Degraded Image Restoration by Kurtosis Minimization Dalong Li, Steve Simske HP Laboratories HPL-2008-214 Keyword(s): blur identification, atmospheric turbulence, image restoration,

More information

Barrier Option. 2 of 33 3/13/2014

Barrier Option. 2 of 33 3/13/2014 FPGA-based Reconfigurable Computing for Pricing Multi-Asset Barrier Options RAHUL SRIDHARAN, GEORGE COOKE, KENNETH HILL, HERMAN LAM, ALAN GEORGE, SAAHPC '12, PROCEEDINGS OF THE 2012 SYMPOSIUM ON APPLICATION

More information

PROJECT MANAGEMENT Course Assignment REVISION 19

PROJECT MANAGEMENT Course Assignment REVISION 19 PROJECT MANAGEMENT Course Assignment REVISION 19 COPYRIGHT 1997 BY QMUZIK All rights reserved. The contents, nor any part thereof, nor the format, the configuration or any other aspect thereof may be copied,

More information

Much of what appears here comes from ideas presented in the book:

Much of what appears here comes from ideas presented in the book: Chapter 11 Robust statistical methods Much of what appears here comes from ideas presented in the book: Huber, Peter J. (1981), Robust statistics, John Wiley & Sons (New York; Chichester). There are many

More information

Table of Contents. Kocaeli University Computer Engineering Department 2011 Spring Mustafa KIYAR Optimization Theory

Table of Contents. Kocaeli University Computer Engineering Department 2011 Spring Mustafa KIYAR Optimization Theory 1 Table of Contents Estimating Path Loss Exponent and Application with Log Normal Shadowing...2 Abstract...3 1Path Loss Models...4 1.1Free Space Path Loss Model...4 1.1.1Free Space Path Loss Equation:...4

More information

TP3 ISI Parameter Selection Methodology

TP3 ISI Parameter Selection Methodology TP3 ISI Parameter Selection Methodology Contributions & Support: John Ewen Lars Thon Piers Dawe, David Cunningham Sudeep Bhoja, John Jaeger Vivek Telang Tom Lindsay Lew Aronson, Jim McVey Martin Lobel

More information

EE6604 Personal & Mobile Communications. Week 7. Path Loss Models. Shadowing

EE6604 Personal & Mobile Communications. Week 7. Path Loss Models. Shadowing EE6604 Personal & Mobile Communications Week 7 Path Loss Models Shadowing 1 Okumura-Hata Model L p = A+Blog 10 (d) A+Blog 10 (d) C A+Blog 10 (d) D for urban area for suburban area for open area where A

More information

Capital Management for Conglomerates. Jennifer Lang BEc, FIA, FIAA Mark Young BSc, MAppStat

Capital Management for Conglomerates. Jennifer Lang BEc, FIA, FIAA Mark Young BSc, MAppStat Capital Management for Conglomerates Jennifer Lang BEc, FIA, FIAA Mark Young BSc, MAppStat Agenda Managing capital in conglomerates Measures for individual types of company Banks Life insurers General

More information

WHY ARE PROJECTS ALWAYS LATE?

WHY ARE PROJECTS ALWAYS LATE? WHY ARE PROJECTS ALWAYS LATE? (what can the Project Manager DO about that?) Craig Henderson, MBA, PMP ARVEST Bank Operations Introduction PM Basics FIO GID KISS (Figure it out) (Get it done) (Keep it simple,

More information

Path Loss Models and Link Budget

Path Loss Models and Link Budget Path Loss Models and Link Budget A universal path loss model P r dbm = P t dbm + db Gains db Losses Gains: the antenna gains compared to isotropic antennas Transmitter antenna gain Receiver antenna gain

More information

Agricultural and Applied Economics 637 Applied Econometrics II

Agricultural and Applied Economics 637 Applied Econometrics II Agricultural and Applied Economics 637 Applied Econometrics II Assignment I Using Search Algorithms to Determine Optimal Parameter Values in Nonlinear Regression Models (Due: February 3, 2015) (Note: Make

More information

King s College London

King s College London King s College London University Of London This paper is part of an examination of the College counting towards the award of a degree. Examinations are governed by the College Regulations under the authority

More information

2011 Dr. Vassiliy Tchoumatchenko. Въведение в VHDL Проектиране на Крайни Автомати с VHDL

2011 Dr. Vassiliy Tchoumatchenko. Въведение в VHDL Проектиране на Крайни Автомати с VHDL 2011 Dr. Vassiliy Tchoumatchenko Въведение в VHDL Проектиране на Крайни Автомати с VHDL Диаграма на Състоянията на Краен Автомат Reset B = 1 2 State 0 X

More information

NOISE VARIANCE ESTIMATION IN DS-CDMA AND ITS EFFECTS ON THE INDIVIDUALLY OPTIMUM RECEIVER

NOISE VARIANCE ESTIMATION IN DS-CDMA AND ITS EFFECTS ON THE INDIVIDUALLY OPTIMUM RECEIVER NOISE VRINCE ESTIMTION IN DS-CDM ND ITS EFFECTS ON THE INDIVIDULLY OPTIMUM RECEIVER R. Gaudel, F. Bonnet, J.B. Domelevo-Entfellner ENS Cachan Campus de Ker Lann 357 Bruz, France. Roumy IRIS-INRI Campus

More information

Propagation Path Loss Measurements for Wireless Sensor Networks in Sand and Dust Storms

Propagation Path Loss Measurements for Wireless Sensor Networks in Sand and Dust Storms Frontiers in Sensors (FS) Volume 4, 2016 doi: 10.14355/fs.2016.04.004 www.seipub.org/fs Propagation Path Loss Measurements for Wireless Sensor Networks in Sand and Dust Storms Hana Mujlid*, Ivica Kostanic

More information

Acritical aspect of any capital budgeting decision. Using Excel to Perform Monte Carlo Simulations TECHNOLOGY

Acritical aspect of any capital budgeting decision. Using Excel to Perform Monte Carlo Simulations TECHNOLOGY Using Excel to Perform Monte Carlo Simulations By Thomas E. McKee, CMA, CPA, and Linda J.B. McKee, CPA Acritical aspect of any capital budgeting decision is evaluating the risk surrounding key variables

More information

-10. (12) Patent Application Publication (10) Pub. No.: US 2012/ A1. (19) United States. Chang et al. (43) Pub. Date: Mar.

-10. (12) Patent Application Publication (10) Pub. No.: US 2012/ A1. (19) United States. Chang et al. (43) Pub. Date: Mar. (19) United States US 201200.52815A1 (12) Patent Application Publication (10) Pub. No.: US 2012/0052815 A1 Chang et al. (43) Pub. Date: Mar. 1, 2012 (54) METHODS FOR DYNAMIC CALIBRATION OF OVER-THE-AIR

More information

Asian Option Pricing: Monte Carlo Control Variate. A discrete arithmetic Asian call option has the payoff. S T i N N + 1

Asian Option Pricing: Monte Carlo Control Variate. A discrete arithmetic Asian call option has the payoff. S T i N N + 1 Asian Option Pricing: Monte Carlo Control Variate A discrete arithmetic Asian call option has the payoff ( 1 N N + 1 i=0 S T i N K ) + A discrete geometric Asian call option has the payoff [ N i=0 S T

More information

1 The ECN module. Note

1 The ECN module. Note Version 1.11.0 NOVA ECN tutorial 1 The ECN module The ECN is an optional module for the Autolab PGSTAT. The ECN module provides the means to perform Electrochemical Noise measurements (ECN). Electrochemical

More information

Distributed Computing in Finance: Case Model Calibration

Distributed Computing in Finance: Case Model Calibration Distributed Computing in Finance: Case Model Calibration Global Derivatives Trading & Risk Management 19 May 2010 Techila Technologies, Tampere University of Technology juho.kanniainen@techila.fi juho.kanniainen@tut.fi

More information

Applications of Dataflow Computing to Finance. Florian Widmann

Applications of Dataflow Computing to Finance. Florian Widmann Applications of Dataflow Computing to Finance Florian Widmann Overview 1. Requirement Shifts in the Financial World 2. Case 1: Real Time Margin 3. Case 2: FX Option Monitor 4. Conclusions Market Context

More information

Modeling the Spot Price of Electricity in Deregulated Energy Markets

Modeling the Spot Price of Electricity in Deregulated Energy Markets in Deregulated Energy Markets Andrea Roncoroni ESSEC Business School roncoroni@essec.fr September 22, 2005 Financial Modelling Workshop, University of Ulm Outline Empirical Analysis of Electricity Spot

More information

Automated Options Trading Using Machine Learning

Automated Options Trading Using Machine Learning 1 Automated Options Trading Using Machine Learning Peter Anselmo and Karen Hovsepian and Carlos Ulibarri and Michael Kozloski Department of Management, New Mexico Tech, Socorro, NM 87801, U.S.A. We summarize

More information

Performance Comparison Based on SMG 2 Evaluation Reports: WCDMA vs. WB-TDMA/CDMA

Performance Comparison Based on SMG 2 Evaluation Reports: WCDMA vs. WB-TDMA/CDMA ETSI SMG #24 Tdoc SMG 99 / 97 Madrid, Spain December, 5-9, 997 Source: Ericsson Performance Comparison Based on SMG 2 Evaluation Reports: WCDMA vs. WB-TDMA/CDMA Contents. INTRODUCTION...2 2. LINK LEVEL

More information

ADVANCED QUANTITATIVE SCHEDULE RISK ANALYSIS

ADVANCED QUANTITATIVE SCHEDULE RISK ANALYSIS ADVANCED QUANTITATIVE SCHEDULE RISK ANALYSIS DAVID T. HULETT, PH.D. 1 HULETT & ASSOCIATES, LLC 1. INTRODUCTION Quantitative schedule risk analysis is becoming acknowledged by many project-oriented organizations

More information

Link Budget Calculation. Ermanno Pietrosemoli Marco Zennaro

Link Budget Calculation. Ermanno Pietrosemoli Marco Zennaro Link Budget Calculation Ermanno Pietrosemoli Marco Zennaro Goals To be able to calculate how far we can go with the equipment we have To understand why we need high masts for long links To learn about

More information

Chapter 3 Discrete Random Variables and Probability Distributions

Chapter 3 Discrete Random Variables and Probability Distributions Chapter 3 Discrete Random Variables and Probability Distributions Part 3: Special Discrete Random Variable Distributions Section 3.5 Discrete Uniform Section 3.6 Bernoulli and Binomial Others sections

More information

Advanced Quantitative Methods for Asset Pricing and Structuring

Advanced Quantitative Methods for Asset Pricing and Structuring MSc. Finance/CLEFIN 2017/2018 Edition Advanced Quantitative Methods for Asset Pricing and Structuring May 2017 Exam for Attending Students Time Allowed: 55 minutes Family Name (Surname) First Name Student

More information

Economic Capital. Implementing an Internal Model for. Economic Capital ACTUARIAL SERVICES

Economic Capital. Implementing an Internal Model for. Economic Capital ACTUARIAL SERVICES Economic Capital Implementing an Internal Model for Economic Capital ACTUARIAL SERVICES ABOUT THIS DOCUMENT THIS IS A WHITE PAPER This document belongs to the white paper series authored by Numerica. It

More information

Part D Request Claim Billing/Claim Rebill Test Data

Part D Request Claim Billing/Claim Rebill Test Data Part D Request Test Data Transaction Header Transaction Header Segment Paid Claim Resubmit Duplicate Clinical Prior Auth Rejected Reversal 1Ø1-A1 BIN Number M 603286 603286 603286 603286 603286 1Ø2-A2

More information

STOCHASTIC COST ESTIMATION AND RISK ANALYSIS IN MANAGING SOFTWARE PROJECTS

STOCHASTIC COST ESTIMATION AND RISK ANALYSIS IN MANAGING SOFTWARE PROJECTS STOCHASTIC COST ESTIMATION AND RISK ANALYSIS IN MANAGING SOFTWARE PROJECTS Dr A.M. Connor Software Engineering Research Lab Auckland University of Technology Auckland, New Zealand andrew.connor@aut.ac.nz

More information

Realtime Regular Expressions for Analog and Mixed-Signal Assertions

Realtime Regular Expressions for Analog and Mixed-Signal Assertions . Realtime Regular Expressions for Analog and Mixed-Signal Assertions John Havlicek Scott Little 1 Motivation Assertions are a key piece to industrial verification flows SVA and PSL are based upon discrete

More information

Week 1 Quantitative Analysis of Financial Markets Distributions B

Week 1 Quantitative Analysis of Financial Markets Distributions B Week 1 Quantitative Analysis of Financial Markets Distributions B Christopher Ting http://www.mysmu.edu/faculty/christophert/ Christopher Ting : christopherting@smu.edu.sg : 6828 0364 : LKCSB 5036 October

More information

Valuation of Asian Option. Qi An Jingjing Guo

Valuation of Asian Option. Qi An Jingjing Guo Valuation of Asian Option Qi An Jingjing Guo CONTENT Asian option Pricing Monte Carlo simulation Conclusion ASIAN OPTION Definition of Asian option always emphasizes the gist that the payoff depends on

More information

(b) per capita consumption grows at the rate of 2%.

(b) per capita consumption grows at the rate of 2%. 1. Suppose that the level of savings varies positively with the level of income and that savings is identically equal to investment. Then the IS curve: (a) slopes positively. (b) slopes negatively. (c)

More information

Oracle Financial Services Market Risk User Guide

Oracle Financial Services Market Risk User Guide Oracle Financial Services User Guide Release 8.0.4.0.0 March 2017 Contents 1. INTRODUCTION... 1 PURPOSE... 1 SCOPE... 1 2. INSTALLING THE SOLUTION... 3 2.1 MODEL UPLOAD... 3 2.2 LOADING THE DATA... 3 3.

More information

Calculating VaR. There are several approaches for calculating the Value at Risk figure. The most popular are the

Calculating VaR. There are several approaches for calculating the Value at Risk figure. The most popular are the VaR Pro and Contra Pro: Easy to calculate and to understand. It is a common language of communication within the organizations as well as outside (e.g. regulators, auditors, shareholders). It is not really

More information

Lecture 3a. Review Chapter 10 Nise. Skill Assessment Problems. G. Hovland 2004

Lecture 3a. Review Chapter 10 Nise. Skill Assessment Problems. G. Hovland 2004 METR4200 Advanced Control Lecture 3a Review Chapter 10 Nise Skill Assessment Problems G. Hovland 2004 Skill-Assessment Exercise 10.1 a) Find analytical expressions for the magnitude and phase responses

More information

Stochastic Proximal Algorithms with Applications to Online Image Recovery

Stochastic Proximal Algorithms with Applications to Online Image Recovery 1/24 Stochastic Proximal Algorithms with Applications to Online Image Recovery Patrick Louis Combettes 1 and Jean-Christophe Pesquet 2 1 Mathematics Department, North Carolina State University, Raleigh,

More information

Path Loss Prediction in Wireless Communication System using Fuzzy Logic

Path Loss Prediction in Wireless Communication System using Fuzzy Logic Indian Journal of Science and Technology, Vol 7(5), 64 647, May 014 ISSN (Print) : 0974-6846 ISSN (Online) : 0974-5645 Path Loss Prediction in Wireless Communication System using Fuzzy Logic Sanu Mathew

More information

Limit Theorems for the Empirical Distribution Function of Scaled Increments of Itô Semimartingales at high frequencies

Limit Theorems for the Empirical Distribution Function of Scaled Increments of Itô Semimartingales at high frequencies Limit Theorems for the Empirical Distribution Function of Scaled Increments of Itô Semimartingales at high frequencies George Tauchen Duke University Viktor Todorov Northwestern University 2013 Motivation

More information

c: Mr. Shay Mardan, Pariplay Limited RN-127-PAY-13-01

c: Mr. Shay Mardan, Pariplay Limited RN-127-PAY-13-01 August 27, 2014 Mr. Gili Lisani, CEO Pariplay Limited Clinch's House Lord Street Douglas Isle of Man IM99 1RZ World Headquarters 600 Airport Road Lakewood, NJ 08701 Phone (732) 942-3999 Fax (732) 942-0043

More information

Legend. Extra options used in the different configurations slow Apache (all default) svnserve (all default) file: (all default) dump (all default)

Legend. Extra options used in the different configurations slow Apache (all default) svnserve (all default) file: (all default) dump (all default) Legend Environment Computer VM on XEON E5-2430 2.2GHz; assigned 2 cores, 4GB RAM OS Windows Server 2012, x64 Storage iscsi SAN, using spinning SCSI discs Tests log $repo/ -v --limit 50000 export $ruby/trunk

More information

STOCHASTIC COST ESTIMATION AND RISK ANALYSIS IN MANAGING SOFTWARE PROJECTS

STOCHASTIC COST ESTIMATION AND RISK ANALYSIS IN MANAGING SOFTWARE PROJECTS Full citation: Connor, A.M., & MacDonell, S.G. (25) Stochastic cost estimation and risk analysis in managing software projects, in Proceedings of the ISCA 14th International Conference on Intelligent and

More information

Stochastic Receding Horizon Control for Dynamic Option Hedging

Stochastic Receding Horizon Control for Dynamic Option Hedging Stochastic Receding Horizon Control for Dynamic Option Hedging Alberto Bemporad http://www.dii.unisi.it/~bemporad University of Siena Department of Information Engineering joint work with L. Bellucci and

More information

TIE2140 / IE2140e Engineering Economy Tutorial 6 (Lab 2) Engineering-Economic Decision Making Process using EXCEL

TIE2140 / IE2140e Engineering Economy Tutorial 6 (Lab 2) Engineering-Economic Decision Making Process using EXCEL TIE2140 / IE2140e Engineering Economy Tutorial 6 (Lab 2) Engineering-Economic Decision Making Process using EXCEL Solutions Guide by Wang Xin, Hong Lanqing & Mei Wenjie 1. Learning Objectives In this lab-based

More information

In this lecture, we will use the semantics of our simple language of arithmetic expressions,

In this lecture, we will use the semantics of our simple language of arithmetic expressions, CS 4110 Programming Languages and Logics Lecture #3: Inductive definitions and proofs In this lecture, we will use the semantics of our simple language of arithmetic expressions, e ::= x n e 1 + e 2 e

More information

Credit Exposure Measurement Fixed Income & FX Derivatives

Credit Exposure Measurement Fixed Income & FX Derivatives 1 Credit Exposure Measurement Fixed Income & FX Derivatives Dr Philip Symes 1. Introduction 2 Fixed Income Derivatives Exposure Simulation. This methodology may be used for fixed income and FX derivatives.

More information

Homework 4 SOLUTION Out: April 18, 2014 LOOKUP and IF-THEN-ELSE Functions

Homework 4 SOLUTION Out: April 18, 2014 LOOKUP and IF-THEN-ELSE Functions I.E. 438 SYSTEM DYNAMICS SPRING 204 Dr.Onur ÇOKGÖR Homework 4 SOLUTION Out: April 8, 204 LOOKUP and IF-THEN-ELSE Functions Due: May 02, 204, Learning Objectives: In this homework you will use LOOKUP and

More information

2015 American Journal of Engineering Research (AJER)

2015 American Journal of Engineering Research (AJER) American Journal of Engineering Research (AJER) e-issn: 2320-0847 p-issn : 2320-0936 Volume-4, Issue-11, pp-109-115 www.ajer.org Research Paper Open Access Comparative Study of Path Loss Models for Wireless

More information

Value of Information in Spreadsheet Monte Carlo Simulation Models

Value of Information in Spreadsheet Monte Carlo Simulation Models Value of Information in Spreadsheet Monte Carlo Simulation Models INFORMS 010 Austin Michael R. Middleton, Ph.D. Decision Toolworks Mike@DecisionToolworks.com 15.10.7190 Background Spreadsheet models are

More information

Bitline PUF:! Building Native Challenge-Response PUF Capability into Any SRAM. Daniel E. Holcomb Kevin Fu University of Michigan

Bitline PUF:! Building Native Challenge-Response PUF Capability into Any SRAM. Daniel E. Holcomb Kevin Fu University of Michigan Sept 26, 24 Cryptographic Hardware and Embedded Systems Bitline PUF:! Building Native Challenge-Response PUF Capability into Any SRAM Daniel E. Holcomb Kevin Fu University of Michigan Acknowledgment: This

More information

INSTITUTE AND FACULTY OF ACTUARIES. Curriculum 2019 SPECIMEN SOLUTIONS

INSTITUTE AND FACULTY OF ACTUARIES. Curriculum 2019 SPECIMEN SOLUTIONS INSTITUTE AND FACULTY OF ACTUARIES Curriculum 2019 SPECIMEN SOLUTIONS Subject CM1A Actuarial Mathematics Institute and Faculty of Actuaries 1 ( 91 ( 91 365 1 0.08 1 i = + 365 ( 91 365 0.980055 = 1+ i 1+

More information

Radio Propagation Modelling

Radio Propagation Modelling Radio Propagation Modelling Ian Wassell and Yan Wu University of Cambridge Computer Laboratory Why is it needed? To predict coverage between nodes in a wireless network Path loss is different from environment

More information

A METHOD FOR STOCHASTIC ESTIMATION OF COST AND COMPLETION TIME OF A MINING PROJECT

A METHOD FOR STOCHASTIC ESTIMATION OF COST AND COMPLETION TIME OF A MINING PROJECT A METHOD FOR STOCHASTIC ESTIMATION OF COST AND COMPLETION TIME OF A MINING PROJECT E. Newby, F. D. Fomeni, M. M. Ali and C. Musingwini Abstract The standard methodology used for estimating the cost and

More information