program Inner-Product-1 declare m: integer initially assign end 0..P 1 p program Vector-Sum-4 declare i: integer;

Μέγεθος: px
Εμφάνιση ξεκινά από τη σελίδα:

Download "program Inner-Product-1 declare m: integer initially assign end 0..P 1 p program Vector-Sum-4 declare i: integer;"

Transcript

1 program name definitions of (nonglobal) variables state of the data space before execution transformations by the program { state of the data space after execution } program Inner-Product-1 m: integer σ : real x, y: array [0..M 1] of real ; m : 0 m < M :: x[m], y[m] = x m, ỹ m σ := +m : 0 m < M :: x[m] y[m] { σ = σ } P 1 p program Vector-Sum-4 i: integer; x, y, z: array [0..I p 1] of real ; i : 0 i < I p :: x[i], y[i] = x µ 1 (p,i), ỹ µ 1 (p,i) ; i : 0 i < I p :: z[i] := αx[i] + βy[i] { ; i : 0 i < I p :: z[i] = z µ 1 (p,i) } 0..P 1 p program Inner-Product-3 i: integer; σ : real; x, y: array [0..I p 1] of real; ω: array [0..P 1] of real ; i : 0 i < I p :: x[i], y[i] = x µ 1 (p,i), ỹ µ 1 (p,i) ω[p] := +i : 0 i < I p :: x[i] y[i]; s ω[p] to all; ; q : 0 q < P and q p :: receive ω[q] from q ; σ := +q : 0 q < P :: ω[q] { σ = σ } 3 4

2 0..P 1 p program Recursive-Doubling-2 d: integer ω, h: real ω = ω p ; d : 0 d < D :: s ω to bitflip(p, d); receive h from bitflip(p, d); ω := ω + h ; {ω = +q : 0 q < P :: ω q } 0..P 1 0..Q 1 (p, q) program Matrix-Vector-5 i, j, d: integer x: array [0..J q 1] of real y: array [0..I p 1] of real a: array [0..I p 1, 0..J q 1] of real t: array [0..I p 1] of real ; j : 0 j < J q :: x[j] = x ν 1 (q,j); ; (i, j) : 0 i < I p, 0 j < J q :: a[i, j] = ã µ 1 (p,i),ν 1 (q,j) {local sum} ; i : 0 i < I p :: y[i] := +j : 0 j < J q :: a[i, j] x[j] ; {recursive doubling} ; d : 0 d < D :: s {y[i] : 0 i < I p } to (p, bitflip(q, d)); receive {t[i] : 0 i < I p } from (p, bitflip(q, d)); ; i : 0 i < I p :: y[i] := y[i] + t[i] ; { ; i : 0 i < I p :: y[i] = ỹ µ 1 (p,i)} P 1 0..Q 1 (p, q) program Convert-Vector-2 i, j, d, s: integer v: array [0..J q 1] of real y: array [0..I p 1] of real t: array [0..I p 1] of real ; i : 0 i < I p :: y[i] = ĩµ 1 (p,i); ; j : 0 j < J q :: v[j] = 0; {local ment} ; i : 0 i < I p :: (s, j) := ν(µ 1 (p, i)); if q = s then v[j] := y[i] ; {recursive doubling} ; d : 0 d < D :: s {v[j] : 0 j < J q } to (bitflip(p, d), q); receive {t[j] : 0 j < J q } from (bitflip(p, d), q); ; j : 0 j < J q :: v[j] := v[j] + t[j] ; { ; j : 0 j < J q :: v[j] = ṽ ν 1 (q,j)} 7 program Power k: integer; α, β, ε, π xx, π xy, π xz, π yy, π yz : real; x, y, z: array [0..M 1] of real;{x k, x k+1, x k+2} λ: complex; v: array [0..M 1] of complex; π xx := (x, x); x := x/ π xx; y := Ax; π xy := (x, y); π yy := (y, y); if π yy πxy 2 < τ 2 π yy then begin λ := π xy ; {x normalized to one} v := y/ π yy; return; z := Ay; π xz := (x, z); π yz := (y, z); π zz := (z, z); α := (π yz π xyπ xz)/(π yy πxy); 2 β := (π xy π yz π yy π xz )/(π yy πxy 2 ); ε := π zz + α 2 π yy + β 2 + 2(απ yz + βπ xz + αβπ xy); if ε < τ 2 π zz and 4β α 2 > 0 then begin λ := (α i 4β α 2 )/2; v := ( λy z)/ βπ yy + απ yz + π zz ; return; x := y/ π yy; y := z/ π yy ; π xy := π yz/ π yy; π yy := π zz / π yy ; {Error: No convergence} 8

3 program LU-4 k, m, n: integer; M, N : set of integer; r : array [0..M 1] of integer; c: array [0..N 1] of integer; a: array [0..M 1, 0..N 1] of real; a c: array [0..M 1] of real; {pivot row} a r : array [0..N 1] of real; {multiplier column} a r c: real {pivot element} M, N = 0,.., M 1, 0..N 1; ; m, n : (m, n) M, N :: a[m, n] = ã m,n ; k : 0 k < min(m, N) :: Pivot-Strategy-4(k, M, N, a, a r c, r [k], c[k]); if a r c = 0.0 then quit; M := M \ {r [k]}; N := N \ {c[k]}; {Copy the pivot row} n : n N :: a r [n] := a[r [k], n]; {Compute the multiplier column} m : m M :: a c[m] := a[m, c[k]]/a r c; {Elimination} m, n : (m, n) M N :: a[m, n] := a[m, n] a c [m] a r [n] { ; m, n : (m, n) M, N :: if r 1 [m] > c 1 [n] then a[m, n] = l[m, n] a[m, n] = ũ[m, n] } 9 0..P 1 0..Q 1 (p, q)program LU-5 k, i, j, ˆp, î, ˆq, ĵ: integer; I, J: set of integer; r : array [0..M 1] of integer; c: array [0..N 1] of integer; a: array [0..I p 1, 0..J q 1] of real; a c: array [0..I p 1] of real; a r : array [0..J q 1] of real; a r c: real I, J = I p, J q; ; i, j : (i, j) I, J :: a[i, j] = ã µ 1 (p,i),ν 1 (q,j) ; k : 0 k < min(m, N) :: Pivot-Strategy-5(k, I, J, a, a r c, ˆp, î, ˆq, ĵ); if a r c = 0.0 then quit; if p = ˆp then I := I \ {î}; if q = ˆq then J := J \ {ĵ}; r [k] := µ 1 ( ˆp, î); {global indeces} c[k] := ν 1 (ˆq, ĵ); {Broadcast the pivot row} if p = ˆp then begin ; j : j J :: a r [j] := a[î, j]; s {a r [j] : j J} to (all, q); receive {a r [j] : j J} from ( ˆp, q); {Compute and broadcast the multiplier column} if q = ˆq then begin ; i : i I :: a c [i] := a[i, ĵ] := a[i, ĵ]/a r c ; s {a c[i] : i I} to (p, all); receive {a c [i] : i I} from (p, ˆq); {Elimination} i, j : (i, j) I J :: a[i, j] := a[i, j] a c [i] a r [j] P 1 0..Q 1 (p, q) program No-Pivoting(k, I, J, a, a r c, ˆp, î, ˆq, ĵ) k, ˆp, î, ˆq, ĵ : integer; I, J: set of integer; a: array [0..I p 1, 0..J q 1] of real; a r c : real ( ˆp, î) := µ(k); (ˆq, ĵ) := ν(k); if p = ˆp and q = ˆq then a r c := a[î, ĵ]; 0..P 1 0..Q 1 (p, q) program Complete-Pivoting(k, I, J, a, a r c, ˆp, î, ˆq, ĵ) k, d, u, i, j, ˆp, p 0, î, i 0, ˆq, q 0, ĵ, j 0, p u, q u : integer; I, J: set of integer; a: array [0..I p 1, 0..J q 1] of real; a r c, h: real a r c, ˆp, î, ˆq, ĵ := 0.0, p, 1, q, 1; ; i, j : (i, j) I J :: if a[i, j] > a r c then a r c, î, ĵ := a[i, j], i, j ; ; d : 0 d < D :: {Note: PQ = 2 D } u := bitflip(pq + q, d); p u, q u := u/q, u mod Q; s a r c, ˆp, î, ˆq, ĵ to (p u, q u ); receive h, p 0, i 0, q 0, j 0 from (p u, q u ); if h > a r c or h = a r c and p 0 < ˆp or h = a r c and p 0 = ˆp and q 0 < ˆq then a r c, ˆp, î, ˆq, ĵ := h, p 0, i 0, q 0, j

4 program Back-Solve-4 k, m, n: integer; M: set of integer; r : array [0..M 1] of integer; c: array [0..N 1] of integer; a: array [0..M 1, 0..N 1] of real; b: array [0..M 1] of real; x: array [0..N 1] of real; {Final state of LU-4} ; m : 0 m < M :: b[m] = b m M := k : 0 k < K :: {r [k]}; ; k : K > k 0 :: M := M \ {r [k]}; x[c[k]] := b[r [k]]/a[r [k], c[k]]; m : m M :: b[m] := b[m] a[m, c[k]] x[c[k]] { ; n : 0 n < N :: x[n] = x n } P 1 0..Q 1 (p, q)program Back-Solve-5 k, i, j, ˆp, î, ˆq, ˆq +, ˆq, ĵ, ĵ +, ĵ : integer; I: set of integer; r : array [0..M 1] of integer; c: array [0..N 1] of integer; a: array [0..I p 1, 0..J q 1] of real; b: array [0..I p 1] of real; x: array [0..J q 1] of real; {Final state of LU-5} ; b[i] : 0 i < I p :: b[i] = b µ 1 (p,i) I := ; ( ˆp, î) := µ(r [k]); if p = ˆp then I := I {î} ; ; k : K > k 0 :: if k < K 1 then ˆq +, ĵ + := ν(c[k + 1]); ˆq, ĵ := ν(c[k]); if k > 0 then ˆq, ĵ := ν(c[k 1]); ˆp, î := µ(r [k]); if q = ˆq then begin if k < K 1 and q ˆq + then receive I, {b[i] : i I} from (p, ˆq + ); if p = ˆp then begin I := I \ {î}; x[ĵ] := b[ĵ]/a[î, ĵ]; s x[ĵ] to (all, q) receive x[ĵ] from ( ˆp, q); i : i I :: b[i] := b[i] a[i, ĵ] x[ĵ]; if k > 0 and q ˆq then s I, {b[i] : i I} to (p, ˆq ) { ; j : 0 j < J q :: x[j] = x ν 1 (q,j)} P 1 p program Full-Recursive-Doubling-2 d: integer; ω, t: real ω = ω p ; d : 0 d D :: if p + 2 d < P then s ω to p + 2 d ; if p 2 d 0 then begin receive t from p 2 d ; ω := t ω {ω = σ p } 0..P 1 p program Full-Recursive-Doubling-3 i, d: integer; β, t: real; ω: array [0..I p 1] of real ; i : 0 i < I p :: ω[i] = ω µ 1 (p,i) {Sequential recursion} ; i : 0 < i < I p :: ω[i] := ω[i 1] ω[i]; {Full recursive doubling} β := ω[i p 1]; ; d : 0 d D :: if p + 2 d < P then s β to p + 2 d ; if p 2 d 0 then begin receive t from p 2 d ; β := t β ; {Combine step} s β to p + 1; begin receive β from p 1; ; i : 0 i < I p :: ω[i] := β ω[i]; { ; i : 0 i < I p :: ω[i] = σ µ 1 (p,i)} 15 16

5 program Tridiagonal-LU-1 m: integer; σ, ρ, λ, ν: array [0..M 1] of real; µ: array [ 1..M 1] of real σ [0], ρ[0], ν[0] = σ 0, 0, 0; ; m : 0 < m < M :: σ [m], ρ[m], ν[m] = σ m, ρ m, τ m µ[ 1] = 1.0; ; m : 0 m < M :: λ[m] := ρ[m]/µ[m 1]; µ[m] := σ [m] λ[m] ν[m] { ; m : 0 < m < M :: λ[m], µ[m] = λ m, µ m ; λ[0] = λ 0 } 0..P 1 p program Tridiagonal-LU-2 i, d: integer; σ, ρ, λ, ν: array [0..I p 1] of real; µ: array [ 1..I p 1] of real S, T : array [0..1, 0..1] of real ; i : 0 i < I p :: σ [i], ρ[i], ν[i] = σ Mp+i, ρ Mp+i, τ Mp+i {Sequential recursion} S := ( ) ; ; i : 0 i < I p :: S := ( ) σ [i] ν[i] ρ[i] 1 0 S; {Full recursive doubling} ; d : 0 d D :: if p + 2 d < P then s S to p + 2 d ; if p 2 d 0 then begin receive T from p 2 d ; S := S T ; ; 17 {Combine step} µ[i p 1] := (S[0, 0] + S[0, 1])/(S[1, 0] + S[1, 1]); {µ[ 1] = 1.0!!} s µ[i p 1] to p + 1; if p = 0 then µ[ 1] = 1.0 receive µ[ 1] from p 1; ; i : 0 i < I p :: λ[i] := ρ[i]/µ[i 1]; µ[i] := σ [i] λ[i] ν[i] 18 { ; i : 0 i < I p :: λ[i], µ[i] = λ Mp+i, µ Mp+i; µ[ 1] = µ Mp 1} program Fast-Fourier-1 m, t: integer; ε: array [0..2 n 1 1] of complex; b: array [0..2 n 1 1] of complex ; t : 0 t < 2 n 1 :: ε[t] = exp(it 2π 2 n ; ; t : 0 t < 2 n :: b[ρ n (t)] = f t ; ; m : 0 m < n :: t : t 0..2 n 1 :: if t 2 m = 0 then b[t] = b[t] + ε[2 n m 1 t mod 2 n 1 ] b[t + 2 m ] b[t] = b[t 2 m ] ε[2 n m 1 t mod 2 n 1 ] b[t] { ; t : 0 t < 2 n :: ˆf t = b[t]} t : t 0..2 n 1 :: if t 2 m = 0 then b[t] = b[t] + ε[2 n m 1 t mod 2 n 1 ] b[t + 2 m ] b[t] = b[t 2 m ] ε[2 n m 1 t mod 2 n 1 ] b[t] if m T D then t D, t l : t D 0..2 D 1 and t l 0..2 n D 1 :: if t l (2 m ) l = 0 then b[t D, t l ] = b[t D, t l ] + ε[t m ] b[t D, t l + (2 m ) l ] b[t D, t l ] = b[t D, t l (2 m ) l ] ε[t m ] b[t D, t l ] t D, t l : t D 0..2 D 1 and t l 0..2 n D 1 :: if t D (2 m ) D = 0 then b[t D, t l ] = b[t D, t l ] + ε[t m ] b[t D + (2 m ) D, t l ] b[t D, t l ] = b[t D (2 m ) D, t l ] ε[t m ] b[t D, t l ] 19 20

6 if m T D then t D, t l : t D 0..2 D 1 and t l 0..2 n D 1 :: if t l (2 m ) l = 0 then b[t D, t l ] = b[t D, t l ] + ε[t m ] b[t D, t l + (2 m ) l ] b[t D, t l ] = b[t D, t l (2 m ) l ] ε[t m ] b[t D, t l ] begin s {b[t D, t l ] : t D = p and t l 0..2 n D 1} to p (2 m ) D ; receive {x[t D, t l ] : t D = p and t l 0..2 n D 1} from p (2 m ) D ; t D, t l : t D 0..2 D 1 and t l 0..2 n D 1 :: if t D (2 m ) D = 0 then b[t D, t l ] = b[t D, t l ] + ε[t m ] x[t D, t l ] b[t D, t l ] = x[t D, t l ] ε[t m ] b[t D, t l ] 0..P 1 p program Fast-Fourier-2 m, j: integer; ε: array [0..2 n 1 1] of complex; b, x: array [0..2 n D ] of complex ; m : 0 m < n :: if m T D then ; j ( 0..2 n D 1 and ) j ( (2 m ) l = 0 :: ) ( ) b[j] 1 ε[tm (p, j)] b[j] b[j + (2 m := ) l ] 1 ε[t m (p, j)] b[j + (2 m ) l ] begin s {b[j] : j 0..2 n D 1} to p (2 m ) D ; receive {x[j] : j 0..2 n D 1} from p (2 m ) D ; if p (2 m ) D = 0 then ; j : j 0..2 n D 1 :: b[j] = b[j] + ε[t m (p, j)] x[j] ; j : j 0..2 n D 1 :: b[j] = x[j] ε[t m (p, j)] b[j] program Jacobi-1 k, m, n: integer; u, f : array [0..M, 0..N] of real ; m, n : (m, n) 0..M 0..N :: f [m, n] = f m,n ; ; m, n : (m, n) 1..M 1 1..N 1 :: u[m, n] = ũ (0) m,n; ; n : n 0..N :: u[0, n], u[m, n] = g 0,n, g M,n ; ; m : m 0..M :: u[m, 0], u[m, N] = g m,0, g m,n m, n : (m, n) 1..M 1 1..N 1 :: u[m, n] := 0.25 (h 2 f [m, n] + u[m 1, n] + u[m + 1, n] +u[m, n 1] + u[m, n + 1]) { ; m, n : (m, n) 0..M 0..N :: u[m, n] = ũ (K) m,n} 0..P 1 0..Q 1 (p, q) program Jacobi-2 k, ; u: array [ 1..Ip, 1..Jq] of real; f : array [0..Ip 1, 0..Jq 1] of real; b1, b2: array [ 1..Jq 1] of real ; i, j : (i, j) 0..Ip 1 0..Jq 1 :: f [i, j] = fmp+i,nq+j; ; i, j : (i, j) 1..Ip 1..Jq :: u[i, j] = ũ (0) Mp+i,Nq+j ; if p = 0 then ; j : j 1..Jq :: u[ 1, j] = g0,nq+j; if p = P 1 then ; j : j 1..Jq :: u[ip, j] = gm,nq+j; if q = 0 then ; i : i 1..Ip :: u[i, 1] = gmp+i,0; if q = Q 1 then ; i : i 1..Ip :: u[i, Jq] = gmp+i,n {Local Relaxation} ; j : j 0..Jq 1 :: b2[j] := u[ 1, j]; ; i : i 0..Ip 1 :: ; j : j 1..Jq 1 :: b1[j] := u[i, j]; ; j : j 1..Jq 1 :: u[i, j] := 0.25 (h 2 f [i, j] + b1[j 1] + b2[j] + u[i, j + 1] + u[i + 1, j]) ; ; j : j 0..Jq 1 :: b2[j] := b1[j] ; {Ghost-Boundary Exchange} s {u[i, Jq 1] : i 0..Ip 1} to (p, q + 1); receive {u[i, 1] : i 0..Ip 1} from (p, q 1); s {u[i, 0] : i 0..Ip 1} to (p, q 1); receive {u[i, Jq] : j 0..Ip 1} from (p + 1, q); s {u[ip 1, j] : i 1..Jq} to (p + 1, q); receive {u[ 1, j] : i 1..Jq} from (p 1, q); s {u[0, j] : i 1..Jq} to (p 1, q); receive {u[ip, j] : i 1..Jq} from (p, q + 1); 23 24

7 program Gauss-Seidel-1 k, m, n: integer; u, f : array [0..M, 0..N] of real ; m, n : (m, n) 0..M 0..N :: f [m, n] = f m,n ; ; m, n : (m, n) 1..M 1 1..N 1 :: u[m, n] = ũ (0) m,n; ; n : n 0..N :: u[0, n], u[m, n] = g 0,n, g M,n ; ; m : m 0..M :: u[m, 0], u[m, N] = g m,0, g m,n ; n : n 1..N 1 :: ; m : m 1..M 1 :: u[m, n] := 0.25 (h 2 f [m, n] + u[m 1, n] + u[m + 1, n] +u[m, n 1] + u[m, n + 1]) { ; m, n : (m, n) 0..M 0..N :: u[m, n] = ũ (K) m,n} 0..P 1 0..Q 1 (p, q) program Gauss-Seidel-2 k, ; u: array [ 1..Ip, 1..Jq] of real; f : array [0..Ip 1, 0..Jq 1] of real; b1, b2: array [ 1..Jq 1] of real ; i, j : (i, j) 0..Ip 1 0..Jq 1 :: f [i, j] = fmp+i,nq+j; ; i, j : (i, j) 1..Ip 1..Jq :: u[i, j] = ũ (0) Mp+i,Nq+j ; if p = 0 then ; j : j 1..Jq :: u[ 1, j] = g0,nq+j; if p = P 1 then ; j : j 1..Jq :: u[ip, j] = gm,nq+j; if q = 0 then ; i : i 1..Ip :: u[i, 1] = gmp+i,0; if q = Q 1 then ; i : i 1..Ip :: u[i, Jq] = gmp+i,n receive {u[ 1, j] : i 0..Jq 1} from (p 1, q); receive {u[i, 1] : i 0..Ip 1} from (p, q 1); ; j : j 0..Jq 1 :: ; i : i 0..Ip 1 :: u[i, j] := 0.25 (h 2 f [i, j] + u[i 1, j] + u[i + 1, j] +u[i, j 1] + u[i, j + 1]) ; s {u[ip 1, j] : i 0..Jq 1} to (p + 1, q); s {u[i, Jq 1] : i 0..Ip 1} to (p, q + 1); s {u[0, j] : i 0..Jq 1} to (p 1, q); s {u[i, 0] : i 0..Ip 1} to (p, q 1); receive {u[ip, j] : i 0..Jq 1} from (p, q + 1); receive {u[i, Jq] : j 0..Ip 1} from (p + 1, q); program Conjugate-Gradient k: integer; ξ, β, Π 0 r r, π 1 r r, π pw: real; p, r, w, x: vector r := r Ax; p := r ; π 0 r r := r T r ; w := Ap; π pw := p T w; ξ := π 0 r r /π pw; x := x + ξp; r := r ξw; π 1 r r := r T r ; β := π 1 r r /π 0 r r ; p := r + βp; π 0 r r := π 1 r r ; 0..P 1 0..Q 1 (p, q) program Assign(u, g u, v, g v ) {u(g u ) := v(g v )} u, v: array [ 3..I p + 2, 3..J q + 2] of real; g u, u n, u e, u s, u w : integer; g v, v n, v e, v s, v w : integer; u n, u e, u s, u w := J q + g u, I p + g u, 1 g u, 1 g u ; v n, v e, v s, v w := J q + g v, I p + g v, 1 g v, 1 g v ; ; i : 0 i < I p :: u[i, u s ] := v[i, v s ]; ; i : 0 i < I p :: u[i, u n ] := v[i, v n ]; ; i : 0 j < J q :: u[u w, j] := v[v w, j]; ; i : 0 j < J q :: u[u e, j] := v[v e, j]; u[u w, u s ] := v[v w, v s ]; u[u w, u n ] := v[v w, v n ]; u[u e, u s ] := v[v e, v s ]; u[u e, u n ] := v[v e, v n ] 27 28

8 0..P 1 0..Q 1 (p, q) program Vector-Sum(u, g u, v, g v, α, w, g w ) {u(g u ) := v(g v ) + αw(g w )} α: real; u, v, w: array [ 3..I p + 2, 3..J q + 2] of real; g u, u n, u e, u s, u w : integer; g v, v n, v e, v s, v w : integer; g w, w n, w e, w s, w w : integer; u n, u e, u s, u w := J q + g u, I p + g u, 1 g u, 1 g u ; v n, v e, v s, v w := J q + g v, I p + g v, 1 g v, 1 g v ; w n, w e, w s, w w := J q + g w, I p + g w, 1 g w, 1 g w ; ; i : 0 i < I p :: u[i, u s ] := v[i, v s ] + αw[i, w s ]; ; i : 0 i < I p :: u[i, u n ] := v[i, v n ] + αw[i, w n ]; ; i : 0 j < J q :: u[u w, j] := v[v w, j] + αw[w w, j]; ; i : 0 j < J q :: u[u e, j] := v[v e, j] + αw[w e, j]; u[u w, u s ] := v[v w, v s ] + αw[w w, w s ]; u[u w, u n ] := v[v w, v n ] + αw[w w, w n ]; u[u e, u s ] := v[v e, v s ] + αw[w e, w s ]; u[u e, u n ] := v[v e, v n ] + αw[w e, w n ] 0..P 1 0..Q 1 (p, q) program Inner-Product(π uv, u, g u, v, g v ) {π uv := u(g u ) T v(g v )} u, v: array [ 3..I p + 2, 3..J q + 2] of real; g u, u n, u e : integer; g v, v n, v e : integer; {Outer-boundary variables are assumed to be 0!} u n, u e := J q + g u, I p + g u, 1 g u ; v n, v e := J q + g v, I p + g v, 1 g v ; π uv := u[u e, u n ]v[v e, v n ]; π uv := π uv + +i : 0 i < I p :: u[i, u n ]v[i, v n ]; π uv := π uv + +i : 0 j < J q :: u[u e, j]v[v e, j]; Recursive-Double-Sum(π uv ) P 1 0..Q 1 (p, q) program Zero-Exterior(u, g u ) u: array [ 3..I p + 2, 3..J q + 2] of real; g u, u n, u e, u s, u w : integer; u n, u e, u s, u w := J q + g u, I p + g u, 1 g u, 1 g u, 1 g u ; if q = 0 then begin ; i : 0 i < I p :: u[i, u s ] := 0; u[u w, u s ], u[u e, u s ] := 0, 0; if p = 0 then begin ; j : 0 j < J q :: u[u w, j] := 0; u[u w, u s ], u[u w, u n ] := 0, 0; if q = Q 1 then begin ; i : 0 i < I p :: u[i, u n ] := 0; u[u w, u n ], u[u e, u n ] := 0, 0; if p = P 1 then begin ; j : 0 j < J q :: u[u e, j] := 0; u[u e, u s ], u[u e, u n ] := 0, 0; 0..P 1 0..Q 1 (p, q) program Poisson-Solver(u, f ) u, f : array [ 3..I p + 2, 3..J q + 2] of real; i, j, k: integer {The inner ghost boundary is assumed to carry the u-information!} ; i, j : 0 j < J q and 0 i < I p :: u[i, j] := 0.25 (h 2 f [i, j] + u[i 1, j] + u[i + 1, j]+ u[i, j 1] + u[i, j + 1]) 0..P 1 0..Q 1 (p, q) program Laplace-Solver(u) u: array [ 3..I p + 2, 3..J q + 2] of real; i, j, k: integer {The inner ghost boundary is assumed to carry the u-information!} ; i, j : 0 j < J q and 0 i < I p :: u[i, j] := 0.25 (u[i 1, j] + u[i + 1, j]+ u[i, j 1] + u[i, j + 1]) 31 32

9 0..P 1 0..Q 1 (p, q) program Update-Ghost-Boundary(u) u: array [ 3..I p + 2, 3..J q + 2] of real; s {u[i, J q 1] : i 1..I p } to (p, q + 1); receive {u[i, 2] : i 1..I p } from (p, q 1); s {u[i, 0] : i 1..I p } to (p, q 1); receive {u[i, J q + 1] : i 1..I p } from (p, q + 1); s {u[i p 1, j] : j 1..J q } to (p + 1, q); receive {u[ 2, j] : j 1..J q } from (p 1, q); s {u[0, j] : j 1..J q } to (p 1, q); receive {u[i p + 1, j] : j 1..J q } from (p + 1, q); 0..P 1 0..Q 1 (p, q) program Residual(u, f ) u, f : array [ 3..I p + 2, 3..J q + 2] of real; Poisson-Solver(u, f ); Update-Ghost-Boundary(u); ; i : 1 i I p :: f [i, 1] := f [i, 1] h 2 (4u[i, 1] u[i 1, 1] u[i + 1, 1] u[i, 2] u[i, 0]); f [i, J q ] := f [i, J q ] h 2 (4u[i, J q ] u[i 1, J q ] u[i + 1, J q ] u[i, J q 1] u[i, J q + 1]) ; ; j : 0 i < j q :: f [ 1, j] := f [ 1, j] h 2 (4u[ 1, j] u[ 1, j 1] u[ 1, j + 1] u[ 2, j] u[0, j]); f [I p, j] := f [I p, j] h 2 (4u[I p, j] u[i p, j 1] u[i p, j + 1] u[i p 1, j] u[i p + 1, j]) ; Zero-Exterior(f, 0) P 1 0..Q 1 (p, q) program Apply-Capacitance-Matrix(u, f ) u, f : array [ 3..I p + 2, 3..J q + 2] of real; Laplace-Solver(u); Update-Ghost-Boundary(u); ; i : 1 i I p :: f [i, 1] := h 2 (4u[i, 1] u[i 1, 1] u[i + 1, 1] u[i, 2] u[i, 0]); f [i, J q ] := h 2 (4u[i, J q ] u[i 1, J q ] u[i + 1, J q ] u[i, J q 1] u[i, J q + 1]) ; ; j : 0 i < j q :: f [ 1, j] := h 2 (4u[ 1, j] u[ 1, j 1] u[ 1, j + 1] u[ 2, j] u[0, j]); f [I p, j] := h 2 (4u[I p, j] u[i p, j 1] u[i p, j + 1] u[i p 1, j] u[i p + 1, j]) ; Zero-Exterior(f, 0) P 1 0..Q 1 (p, q) program Domain-Decomposition u, f : array [ 3..I p + 2, 3..J q + 2] of real; ξ, β, Πr 0 r, π r 1 r, π pw: real; k: integer ; i, j : (i, j) 3..I p J q + 2 :: u[i, j], f [i, j] = 0, 0; ; i, j : (i, j) 1..I p 1..J q :: f [i, j] = f Mp+i+1,Nq+j+1; ; i, j : (i, j) 1..I p 1..J q :: u[i, j] = ũ (0) M ; p+i+1,n q+j+1 if p = 0 then ; j : j 0..J q :: u[ 1, j] = g 0,Nq+j+1; if p = P 1 then ; j : j 0..J q :: u[i p, j] = g M,Nq+j+1; if q = 0 then ; i : i 0..I p :: u[i, 1] = g Mp+i+1,0; if q = Q 1 then ; i : i 0..I p :: u[i, J q ] = g Mp+i+1,N Residual(u, f ); Assign(u, 2, u, 0); Assign(f, 1, f, 0); Assign(u, 0, f, 0); Inner-Product(πr 0 r, f, 0, f, 0); Apply-Capacitance-Matrix(u, f ); Inner-Product(π pw, u, 0, f, 0); ξ := πr 0 r /π pw; Vector-Sum(u, 2, u, 2, ξ, u, 0); Vector-Sum(f, 1, f, 1, ξ, f, 0); Inner-Product(πr 1 r, f, 1, f, 1); β := πr 1 r /π r 0 r ; Vector-Sum(u, 0, f, 1, β, u, 0); πr 0 r := π r 1 r ; ; Assign(u, 0, u, 2); 36 Poisson-Solver(u, f )

Answers - Worksheet A ALGEBRA PMT. 1 a = 7 b = 11 c = 1 3. e = 0.1 f = 0.3 g = 2 h = 10 i = 3 j = d = k = 3 1. = 1 or 0.5 l =

Answers - Worksheet A ALGEBRA PMT. 1 a = 7 b = 11 c = 1 3. e = 0.1 f = 0.3 g = 2 h = 10 i = 3 j = d = k = 3 1. = 1 or 0.5 l = C ALGEBRA Answers - Worksheet A a 7 b c d e 0. f 0. g h 0 i j k 6 8 or 0. l or 8 a 7 b 0 c 7 d 6 e f g 6 h 8 8 i 6 j k 6 l a 9 b c d 9 7 e 00 0 f 8 9 a b 7 7 c 6 d 9 e 6 6 f 6 8 g 9 h 0 0 i j 6 7 7 k 9

Διαβάστε περισσότερα

Chapter 6: Systems of Linear Differential. be continuous functions on the interval

Chapter 6: Systems of Linear Differential. be continuous functions on the interval Chapter 6: Systems of Linear Differential Equations Let a (t), a 2 (t),..., a nn (t), b (t), b 2 (t),..., b n (t) be continuous functions on the interval I. The system of n first-order differential equations

Διαβάστε περισσότερα

Q π (/) ^ ^ ^ Η φ. <f) c>o. ^ ο. ö ê ω Q. Ο. o 'c. _o _) o U 03. ,,, ω ^ ^ -g'^ ο 0) f ο. Ε. ιη ο Φ. ο 0) κ. ο 03.,Ο. g 2< οο"" ο φ.

Q π (/) ^ ^ ^ Η φ. <f) c>o. ^ ο. ö ê ω Q. Ο. o 'c. _o _) o U 03. ,,, ω ^ ^ -g'^ ο 0) f ο. Ε. ιη ο Φ. ο 0) κ. ο 03.,Ο. g 2< οο ο φ. II 4»» «i p û»7'' s V -Ζ G -7 y 1 X s? ' (/) Ζ L. - =! i- Ζ ) Η f) " i L. Û - 1 1 Ι û ( - " - ' t - ' t/î " ι-8. Ι -. : wî ' j 1 Τ J en " il-' - - ö ê., t= ' -; '9 ',,, ) Τ '.,/,. - ϊζ L - (- - s.1 ai

Διαβάστε περισσότερα

Matrices and vectors. Matrix and vector. a 11 a 12 a 1n a 21 a 22 a 2n A = b 1 b 2. b m. R m n, b = = ( a ij. a m1 a m2 a mn. def

Matrices and vectors. Matrix and vector. a 11 a 12 a 1n a 21 a 22 a 2n A = b 1 b 2. b m. R m n, b = = ( a ij. a m1 a m2 a mn. def Matrices and vectors Matrix and vector a 11 a 12 a 1n a 21 a 22 a 2n A = a m1 a m2 a mn def = ( a ij ) R m n, b = b 1 b 2 b m Rm Matrix and vectors in linear equations: example E 1 : x 1 + x 2 + 3x 4 =

Διαβάστε περισσότερα

Lecture 2: Dirac notation and a review of linear algebra Read Sakurai chapter 1, Baym chatper 3

Lecture 2: Dirac notation and a review of linear algebra Read Sakurai chapter 1, Baym chatper 3 Lecture 2: Dirac notation and a review of linear algebra Read Sakurai chapter 1, Baym chatper 3 1 State vector space and the dual space Space of wavefunctions The space of wavefunctions is the set of all

Διαβάστε περισσότερα

Durbin-Levinson recursive method

Durbin-Levinson recursive method Durbin-Levinson recursive method A recursive method for computing ϕ n is useful because it avoids inverting large matrices; when new data are acquired, one can update predictions, instead of starting again

Διαβάστε περισσότερα

Tridiagonal matrices. Gérard MEURANT. October, 2008

Tridiagonal matrices. Gérard MEURANT. October, 2008 Tridiagonal matrices Gérard MEURANT October, 2008 1 Similarity 2 Cholesy factorizations 3 Eigenvalues 4 Inverse Similarity Let α 1 ω 1 β 1 α 2 ω 2 T =......... β 2 α 1 ω 1 β 1 α and β i ω i, i = 1,...,

Διαβάστε περισσότερα

Numerical Analysis FMN011

Numerical Analysis FMN011 Numerical Analysis FMN011 Carmen Arévalo Lund University carmen@maths.lth.se Lecture 12 Periodic data A function g has period P if g(x + P ) = g(x) Model: Trigonometric polynomial of order M T M (x) =

Διαβάστε περισσότερα

Chapter 6: Systems of Linear Differential. be continuous functions on the interval

Chapter 6: Systems of Linear Differential. be continuous functions on the interval Chapter 6: Systems of Linear Differential Equations Let a (t), a 2 (t),..., a nn (t), b (t), b 2 (t),..., b n (t) be continuous functions on the interval I. The system of n first-order differential equations

Διαβάστε περισσότερα

Παρουσίαση 3ης Άσκησης

Παρουσίαση 3ης Άσκησης Παρουσίαση 3ης Άσκησης Παράλληλος προγραμματισμός για αρχιτεκτονικές κατανεμημένης μνήμης με MPI Συστήματα Παράλληλης Επεξεργασίας 9ο Εξάμηνο, ΣΗΜΜΥ Εργ. Υπολογιστικών Συστημάτων Σχολή ΗΜΜΥ, Ε.Μ.Π. Νοέμβριος

Διαβάστε περισσότερα

Second Order RLC Filters

Second Order RLC Filters ECEN 60 Circuits/Electronics Spring 007-0-07 P. Mathys Second Order RLC Filters RLC Lowpass Filter A passive RLC lowpass filter (LPF) circuit is shown in the following schematic. R L C v O (t) Using phasor

Διαβάστε περισσότερα

The Jordan Form of Complex Tridiagonal Matrices

The Jordan Form of Complex Tridiagonal Matrices The Jordan Form of Complex Tridiagonal Matrices Ilse Ipsen North Carolina State University ILAS p.1 Goal Complex tridiagonal matrix α 1 β 1. γ T = 1 α 2........ β n 1 γ n 1 α n Jordan decomposition T =

Διαβάστε περισσότερα

1 String with massive end-points

1 String with massive end-points 1 String with massive end-points Πρόβλημα 5.11:Θεωρείστε μια χορδή μήκους, τάσης T, με δύο σημειακά σωματίδια στα άκρα της, το ένα μάζας m, και το άλλο μάζας m. α) Μελετώντας την κίνηση των άκρων βρείτε

Διαβάστε περισσότερα

g-selberg integrals MV Conjecture An A 2 Selberg integral Summary Long Live the King Ole Warnaar Department of Mathematics Long Live the King

g-selberg integrals MV Conjecture An A 2 Selberg integral Summary Long Live the King Ole Warnaar Department of Mathematics Long Live the King Ole Warnaar Department of Mathematics g-selberg integrals The Selberg integral corresponds to the following k-dimensional generalisation of the beta integral: D Here and k t α 1 i (1 t i ) β 1 1 i

Διαβάστε περισσότερα

Matrices and Determinants

Matrices and Determinants Matrices and Determinants SUBJECTIVE PROBLEMS: Q 1. For what value of k do the following system of equations possess a non-trivial (i.e., not all zero) solution over the set of rationals Q? x + ky + 3z

Διαβάστε περισσότερα

DiracDelta. Notations. Primary definition. Specific values. General characteristics. Traditional name. Traditional notation

DiracDelta. Notations. Primary definition. Specific values. General characteristics. Traditional name. Traditional notation DiracDelta Notations Traditional name Dirac delta function Traditional notation x Mathematica StandardForm notation DiracDeltax Primary definition 4.03.02.000.0 x Π lim ε ; x ε0 x 2 2 ε Specific values

Διαβάστε περισσότερα

On the Galois Group of Linear Difference-Differential Equations

On the Galois Group of Linear Difference-Differential Equations On the Galois Group of Linear Difference-Differential Equations Ruyong Feng KLMM, Chinese Academy of Sciences, China Ruyong Feng (KLMM, CAS) Galois Group 1 / 19 Contents 1 Basic Notations and Concepts

Διαβάστε περισσότερα

Review of Single-Phase AC Circuits

Review of Single-Phase AC Circuits Single-Phase AC Circuits in a DC Circuit In a DC circuit, we deal with one type of power. P = I I W = t2 t 1 Pdt = P(t 2 t 1 ) = P t (J) DC CIRCUIT in an AC Circuit Instantaneous : p(t) v(t)i(t) i(t)=i

Διαβάστε περισσότερα

Partial Differential Equations in Biology The boundary element method. March 26, 2013

Partial Differential Equations in Biology The boundary element method. March 26, 2013 The boundary element method March 26, 203 Introduction and notation The problem: u = f in D R d u = ϕ in Γ D u n = g on Γ N, where D = Γ D Γ N, Γ D Γ N = (possibly, Γ D = [Neumann problem] or Γ N = [Dirichlet

Διαβάστε περισσότερα

ES440/ES911: CFD. Chapter 5. Solution of Linear Equation Systems

ES440/ES911: CFD. Chapter 5. Solution of Linear Equation Systems ES440/ES911: CFD Chapter 5. Solution of Linear Equation Systems Dr Yongmann M. Chung http://www.eng.warwick.ac.uk/staff/ymc/es440.html Y.M.Chung@warwick.ac.uk School of Engineering & Centre for Scientific

Διαβάστε περισσότερα

DERIVATION OF MILES EQUATION FOR AN APPLIED FORCE Revision C

DERIVATION OF MILES EQUATION FOR AN APPLIED FORCE Revision C DERIVATION OF MILES EQUATION FOR AN APPLIED FORCE Revision C By Tom Irvine Email: tomirvine@aol.com August 6, 8 Introduction The obective is to derive a Miles equation which gives the overall response

Διαβάστε περισσότερα

The challenges of non-stable predicates

The challenges of non-stable predicates The challenges of non-stable predicates Consider a non-stable predicate Φ encoding, say, a safety property. We want to determine whether Φ holds for our program. The challenges of non-stable predicates

Διαβάστε περισσότερα

Homework 8 Model Solution Section

Homework 8 Model Solution Section MATH 004 Homework Solution Homework 8 Model Solution Section 14.5 14.6. 14.5. Use the Chain Rule to find dz where z cosx + 4y), x 5t 4, y 1 t. dz dx + dy y sinx + 4y)0t + 4) sinx + 4y) 1t ) 0t + 4t ) sinx

Διαβάστε περισσότερα

Equations. BSU Math 275 sec 002,003 Fall 2018 (Ultman) Final Exam Notes 1. du dv. FTLI : f (B) f (A) = f dr. F dr = Green s Theorem : y da

Equations. BSU Math 275 sec 002,003 Fall 2018 (Ultman) Final Exam Notes 1. du dv. FTLI : f (B) f (A) = f dr. F dr = Green s Theorem : y da BSU Math 275 sec 002,003 Fall 2018 (Ultman) Final Exam Notes 1 Equations r(t) = x(t) î + y(t) ĵ + z(t) k r = r (t) t s = r = r (t) t r(u, v) = x(u, v) î + y(u, v) ĵ + z(u, v) k S = ( ( ) r r u r v = u

Διαβάστε περισσότερα

ΚΥΠΡΙΑΚΗ ΕΤΑΙΡΕΙΑ ΠΛΗΡΟΦΟΡΙΚΗΣ CYPRUS COMPUTER SOCIETY ΠΑΓΚΥΠΡΙΟΣ ΜΑΘΗΤΙΚΟΣ ΔΙΑΓΩΝΙΣΜΟΣ ΠΛΗΡΟΦΟΡΙΚΗΣ 24/3/2007

ΚΥΠΡΙΑΚΗ ΕΤΑΙΡΕΙΑ ΠΛΗΡΟΦΟΡΙΚΗΣ CYPRUS COMPUTER SOCIETY ΠΑΓΚΥΠΡΙΟΣ ΜΑΘΗΤΙΚΟΣ ΔΙΑΓΩΝΙΣΜΟΣ ΠΛΗΡΟΦΟΡΙΚΗΣ 24/3/2007 Οδηγίες: Να απαντηθούν όλες οι ερωτήσεις. Όλοι οι αριθμοί που αναφέρονται σε όλα τα ερωτήματα μικρότεροι του 10000 εκτός αν ορίζεται διαφορετικά στη διατύπωση του προβλήματος. Αν κάπου κάνετε κάποιες υποθέσεις

Διαβάστε περισσότερα

Example Sheet 3 Solutions

Example Sheet 3 Solutions Example Sheet 3 Solutions. i Regular Sturm-Liouville. ii Singular Sturm-Liouville mixed boundary conditions. iii Not Sturm-Liouville ODE is not in Sturm-Liouville form. iv Regular Sturm-Liouville note

Διαβάστε περισσότερα

Statistics 104: Quantitative Methods for Economics Formula and Theorem Review

Statistics 104: Quantitative Methods for Economics Formula and Theorem Review Harvard College Statistics 104: Quantitative Methods for Economics Formula and Theorem Review Tommy MacWilliam, 13 tmacwilliam@college.harvard.edu March 10, 2011 Contents 1 Introduction to Data 5 1.1 Sample

Διαβάστε περισσότερα

SCHOOL OF MATHEMATICAL SCIENCES G11LMA Linear Mathematics Examination Solutions

SCHOOL OF MATHEMATICAL SCIENCES G11LMA Linear Mathematics Examination Solutions SCHOOL OF MATHEMATICAL SCIENCES GLMA Linear Mathematics 00- Examination Solutions. (a) i. ( + 5i)( i) = (6 + 5) + (5 )i = + i. Real part is, imaginary part is. (b) ii. + 5i i ( + 5i)( + i) = ( i)( + i)

Διαβάστε περισσότερα

6.3 Forecasting ARMA processes

6.3 Forecasting ARMA processes 122 CHAPTER 6. ARMA MODELS 6.3 Forecasting ARMA processes The purpose of forecasting is to predict future values of a TS based on the data collected to the present. In this section we will discuss a linear

Διαβάστε περισσότερα

MATHEMATICS. 1. If A and B are square matrices of order 3 such that A = -1, B =3, then 3AB = 1) -9 2) -27 3) -81 4) 81

MATHEMATICS. 1. If A and B are square matrices of order 3 such that A = -1, B =3, then 3AB = 1) -9 2) -27 3) -81 4) 81 1. If A and B are square matrices of order 3 such that A = -1, B =3, then 3AB = 1) -9 2) -27 3) -81 4) 81 We know that KA = A If A is n th Order 3AB =3 3 A. B = 27 1 3 = 81 3 2. If A= 2 1 0 0 2 1 then

Διαβάστε περισσότερα

x j (t) = e λ jt v j, 1 j n

x j (t) = e λ jt v j, 1 j n 9.5: Fundamental Sets of Eigenvector Solutions Homogenous system: x 8 5 10 = Ax, A : n n Ex.: A = Characteristic Polynomial: (degree n) p(λ) = det(a λi) Def.: The multiplicity of a root λ i of p(λ) is

Διαβάστε περισσότερα

w o = R 1 p. (1) R = p =. = 1

w o = R 1 p. (1) R = p =. = 1 Πανεπιστήµιο Κρήτης - Τµήµα Επιστήµης Υπολογιστών ΗΥ-570: Στατιστική Επεξεργασία Σήµατος 205 ιδάσκων : Α. Μουχτάρης Τριτη Σειρά Ασκήσεων Λύσεις Ασκηση 3. 5.2 (a) From the Wiener-Hopf equation we have:

Διαβάστε περισσότερα

Sheet H d-2 3D Pythagoras - Answers

Sheet H d-2 3D Pythagoras - Answers 1. 1.4cm 1.6cm 5cm 1cm. 5cm 1cm IGCSE Higher Sheet H7-1 4-08d-1 D Pythagoras - Answers. (i) 10.8cm (ii) 9.85cm 11.5cm 4. 7.81m 19.6m 19.0m 1. 90m 40m. 10cm 11.cm. 70.7m 4. 8.6km 5. 1600m 6. 85m 7. 6cm

Διαβάστε περισσότερα

New Adaptive Projection Technique for Krylov Subspace Method

New Adaptive Projection Technique for Krylov Subspace Method 1 2 New Adaptive Projection Technique for Krylov Subspace Method Akinori Kumagai 1 and Takashi Nodera 2 Generally projection technique in the numerical operation is one of the preconditioning commonly

Διαβάστε περισσότερα

Finite difference method for 2-D heat equation

Finite difference method for 2-D heat equation Finite difference method for 2-D heat equation Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

Διαβάστε περισσότερα

Ε ανάληψη. Πληροφορηµένη αναζήτηση µε εριορισµό µνήµης. Ευρετικές συναρτήσεις. Το ική αναζήτηση

Ε ανάληψη. Πληροφορηµένη αναζήτηση µε εριορισµό µνήµης. Ευρετικές συναρτήσεις. Το ική αναζήτηση ΠΛΗ 405 Τεχνητή Νοηµοσύνη Ικανο οίηση Περιορισµών Constraint Satisfaction Τµήµα Ηλεκτρονικών Μηχανικών και Μηχανικών Υ ολογιστών Πολυτεχνείο Κρήτης Ε ανάληψη Πληροφορηµένη αναζήτηση µε εριορισµό µνήµης

Διαβάστε περισσότερα

ΗΜΥ 100 ΕΙΣΑΓΩΓΉ ΣΤΗΝ ΤΕΧΝΟΛΟΓΊΑ

ΗΜΥ 100 ΕΙΣΑΓΩΓΉ ΣΤΗΝ ΤΕΧΝΟΛΟΓΊΑ ΗΜΥ 100 ΕΙΣΑΓΩΓΉ ΣΤΗΝ ΤΕΧΝΟΛΟΓΊΑ Δρ. Στέλιος Τιμοθέου ΤΜΗΜΑ ΗΛΕΚΤΡΟΛΟΓΩΝ ΜΗΧΑΝΙΚΩΝ ΚΑΙ ΜΗΧΑΝΙΚΩΝ ΥΠΟΛΟΓΙΣΤΩΝ ΠΟΛΥΤΕΧΝΙΚΗ ΣΧΟΛΗ ΠΑΝΕΠΙΣΤΗΜΙΟ ΚΥΠΡΟΥ ΤΑ ΘΕΜΑΤΑ ΜΑΣ ΣΗΜΕΡΑ Εισαγωγή στον Προγραμματισμό Λογικό

Διαβάστε περισσότερα

ECE Spring Prof. David R. Jackson ECE Dept. Notes 2

ECE Spring Prof. David R. Jackson ECE Dept. Notes 2 ECE 634 Spring 6 Prof. David R. Jackson ECE Dept. Notes Fields in a Source-Free Region Example: Radiation from an aperture y PEC E t x Aperture Assume the following choice of vector potentials: A F = =

Διαβάστε περισσότερα

EE512: Error Control Coding

EE512: Error Control Coding EE512: Error Control Coding Solution for Assignment on Finite Fields February 16, 2007 1. (a) Addition and Multiplication tables for GF (5) and GF (7) are shown in Tables 1 and 2. + 0 1 2 3 4 0 0 1 2 3

Διαβάστε περισσότερα

Chap. 6 Pushdown Automata

Chap. 6 Pushdown Automata Chap. 6 Pushdown Automata 6.1 Definition of Pushdown Automata Example 6.1 L = {wcw R w (0+1) * } P c 0P0 1P1 1. Start at state q 0, push input symbol onto stack, and stay in q 0. 2. If input symbol is

Διαβάστε περισσότερα

❷ s é 2s é í t é Pr 3

❷ s é 2s é í t é Pr 3 ❷ s é 2s é í t é Pr 3 t tr t á t r í í t 2 ➄ P á r í3 í str t s tr t r t r s 3 í rá P r t P P á í 2 rá í s é rá P r t P 3 é r 2 í r 3 t é str á 2 rá rt 3 3 t str 3 str ýr t ý í r t t2 str s í P á í t

Διαβάστε περισσότερα

Second Order Partial Differential Equations

Second Order Partial Differential Equations Chapter 7 Second Order Partial Differential Equations 7.1 Introduction A second order linear PDE in two independent variables (x, y Ω can be written as A(x, y u x + B(x, y u xy + C(x, y u u u + D(x, y

Διαβάστε περισσότερα

Πανεπιστήµιο Κρήτης - Τµήµα Επιστήµης Υπολογιστών. ΗΥ-570: Στατιστική Επεξεργασία Σήµατος. ιδάσκων : Α. Μουχτάρης. εύτερη Σειρά Ασκήσεων.

Πανεπιστήµιο Κρήτης - Τµήµα Επιστήµης Υπολογιστών. ΗΥ-570: Στατιστική Επεξεργασία Σήµατος. ιδάσκων : Α. Μουχτάρης. εύτερη Σειρά Ασκήσεων. Πανεπιστήµιο Κρήτης - Τµήµα Επιστήµης Υπολογιστών ΗΥ-570: Στατιστική Επεξεργασία Σήµατος 2015 ιδάσκων : Α. Μουχτάρης εύτερη Σειρά Ασκήσεων Λύσεις Ασκηση 1. 1. Consder the gven expresson for R 1/2 : R 1/2

Διαβάστε περισσότερα

Note: Please use the actual date you accessed this material in your citation.

Note: Please use the actual date you accessed this material in your citation. MIT OpenCourseWare http://ocw.mit.edu 6.03/ESD.03J Electromagnetics and Applications, Fall 005 Please use the following citation format: Markus Zahn, 6.03/ESD.03J Electromagnetics and Applications, Fall

Διαβάστε περισσότερα

Srednicki Chapter 55

Srednicki Chapter 55 Srednicki Chapter 55 QFT Problems & Solutions A. George August 3, 03 Srednicki 55.. Use equations 55.3-55.0 and A i, A j ] = Π i, Π j ] = 0 (at equal times) to verify equations 55.-55.3. This is our third

Διαβάστε περισσότερα

High order interpolation function for surface contact problem

High order interpolation function for surface contact problem 3 016 5 Journal of East China Normal University Natural Science No 3 May 016 : 1000-564101603-0009-1 1 1 1 00444; E- 00030 : Lagrange Lobatto Matlab : ; Lagrange; : O41 : A DOI: 103969/jissn1000-56410160300

Διαβάστε περισσότερα

Μονοδιάστατοι πίνακες

Μονοδιάστατοι πίνακες Μονοδιάστατοι πίνακες Τι είναι ο πίνακας στον προγραμματισμό; Ο πίνακας είναι μια σύνθετη μεταβλητή που καταλαμβάνει παραπάνω από μια θέση στην μνήμη του Η/Υ, έχει ένα συγκεκριμένο όνομα και δέχεται ένα

Διαβάστε περισσότερα

New bounds for spherical two-distance sets and equiangular lines

New bounds for spherical two-distance sets and equiangular lines New bounds for spherical two-distance sets and equiangular lines Michigan State University Oct 8-31, 016 Anhui University Definition If X = {x 1, x,, x N } S n 1 (unit sphere in R n ) and x i, x j = a

Διαβάστε περισσότερα

Reminders: linear functions

Reminders: linear functions Reminders: linear functions Let U and V be vector spaces over the same field F. Definition A function f : U V is linear if for every u 1, u 2 U, f (u 1 + u 2 ) = f (u 1 ) + f (u 2 ), and for every u U

Διαβάστε περισσότερα

Παράλληλη Επεξεργασία Κεφάλαιο 4 Επικοινωνία Διεργασιών

Παράλληλη Επεξεργασία Κεφάλαιο 4 Επικοινωνία Διεργασιών Παράλληλη Επεξεργασία Κεφάλαιο 4 Επικοινωνία Διεργασιών Κωνσταντίνος Μαργαρίτης Καθηγητής Τμήμα Εφαρμοσμένης Πληροφορικής Πανεπιστήμιο Μακεδονίας kmarg@uom.gr http://eos.uom.gr/~kmarg Αρετή Καπτάν Υποψήφια

Διαβάστε περισσότερα

Mellin transforms and asymptotics: Harmonic sums

Mellin transforms and asymptotics: Harmonic sums Mellin tranform and aymptotic: Harmonic um Phillipe Flajolet, Xavier Gourdon, Philippe Duma Die Theorie der reziproen Funtionen und Integrale it ein centrale Gebiet, welche manche anderen Gebiete der Analyi

Διαβάστε περισσότερα

HOMEWORK 4 = G. In order to plot the stress versus the stretch we define a normalized stretch:

HOMEWORK 4 = G. In order to plot the stress versus the stretch we define a normalized stretch: HOMEWORK 4 Problem a For the fast loading case, we want to derive the relationship between P zz and λ z. We know that the nominal stress is expressed as: P zz = ψ λ z where λ z = λ λ z. Therefore, applying

Διαβάστε περισσότερα

Inverse trigonometric functions & General Solution of Trigonometric Equations. ------------------ ----------------------------- -----------------

Inverse trigonometric functions & General Solution of Trigonometric Equations. ------------------ ----------------------------- ----------------- Inverse trigonometric functions & General Solution of Trigonometric Equations. 1. Sin ( ) = a) b) c) d) Ans b. Solution : Method 1. Ans a: 17 > 1 a) is rejected. w.k.t Sin ( sin ) = d is rejected. If sin

Διαβάστε περισσότερα

Διανύσματα στις 3 Διαστάσεις

Διανύσματα στις 3 Διαστάσεις project 2 Διανύσματα στις 3 Διαστάσεις Περιεχόμενα: Prj02.1 Το Πρόβλημα... 485 Prj02.2 Ο Τύπος Vector3 και οι Δημιουργοί... 486 Prj02.3 Οι Τελεστές Σύγκρισης... 487 Prj02.4 Οι Τελεστές +, -, *, ^... 488

Διαβάστε περισσότερα

Practice Exam 2. Conceptual Questions. 1. State a Basic identity and then verify it. (a) Identity: Solution: One identity is csc(θ) = 1

Practice Exam 2. Conceptual Questions. 1. State a Basic identity and then verify it. (a) Identity: Solution: One identity is csc(θ) = 1 Conceptual Questions. State a Basic identity and then verify it. a) Identity: Solution: One identity is cscθ) = sinθ) Practice Exam b) Verification: Solution: Given the point of intersection x, y) of the

Διαβάστε περισσότερα

Ordinal Arithmetic: Addition, Multiplication, Exponentiation and Limit

Ordinal Arithmetic: Addition, Multiplication, Exponentiation and Limit Ordinal Arithmetic: Addition, Multiplication, Exponentiation and Limit Ting Zhang Stanford May 11, 2001 Stanford, 5/11/2001 1 Outline Ordinal Classification Ordinal Addition Ordinal Multiplication Ordinal

Διαβάστε περισσότερα

Πρόβλημα 1: Αναζήτηση Ελάχιστης/Μέγιστης Τιμής

Πρόβλημα 1: Αναζήτηση Ελάχιστης/Μέγιστης Τιμής Πρόβλημα 1: Αναζήτηση Ελάχιστης/Μέγιστης Τιμής Να γραφεί πρόγραμμα το οποίο δέχεται ως είσοδο μια ακολουθία S από n (n 40) ακέραιους αριθμούς και επιστρέφει ως έξοδο δύο ακολουθίες από θετικούς ακέραιους

Διαβάστε περισσότερα

Differentiation exercise show differential equation

Differentiation exercise show differential equation Differentiation exercise show differential equation 1. If y x sin 2x, prove that x d2 y 2 2 + 2y x + 4xy 0 y x sin 2x sin 2x + 2x cos 2x 2 2cos 2x + (2 cos 2x 4x sin 2x) x d2 y 2 2 + 2y x + 4xy (2x cos

Διαβάστε περισσότερα

Παράλληλη Επεξεργασία Κεφάλαιο 6 ο Σύγχρονος Παραλληλισμός

Παράλληλη Επεξεργασία Κεφάλαιο 6 ο Σύγχρονος Παραλληλισμός Παράλληλη Επεξεργασία Κεφάλαιο 6 ο Σύγχρονος Παραλληλισμός Κωνσταντίνος Μαργαρίτης Καθηγητής Τμήμα Εφαρμοσμένης Πληροφορικής Πανεπιστήμιο Μακεδονίας kmarg@uom.gr http://eos.uom.gr/~kmarg Αρετή Καπτάν Υποψήφια

Διαβάστε περισσότερα

Συνόρθωση κατά στάδια και αναδρομικοί αλγόριθμοι βέλτιστης εκτίμησης

Συνόρθωση κατά στάδια και αναδρομικοί αλγόριθμοι βέλτιστης εκτίμησης Ειδικά Θέματα Συνορθώσεων & Εφαρμογές 8 ο εξάμηνο, Ακαδημαϊκό έτος 2018-2019 Συνόρθωση κατά στάδια και αναδρομικοί αλγόριθμοι βέλτιστης εκτίμησης Χριστόφορος Κωτσάκης Τμήμα Αγρονόμων και Τοπογράφων Μηχανικών

Διαβάστε περισσότερα

The ε-pseudospectrum of a Matrix

The ε-pseudospectrum of a Matrix The ε-pseudospectrum of a Matrix Feb 16, 2015 () The ε-pseudospectrum of a Matrix Feb 16, 2015 1 / 18 1 Preliminaries 2 Definitions 3 Basic Properties 4 Computation of Pseudospectrum of 2 2 5 Problems

Διαβάστε περισσότερα

ΚΥΠΡΙΑΚΗ ΕΤΑΙΡΕΙΑ ΠΛΗΡΟΦΟΡΙΚΗΣ CYPRUS COMPUTER SOCIETY ΠΑΓΚΥΠΡΙΟΣ ΜΑΘΗΤΙΚΟΣ ΔΙΑΓΩΝΙΣΜΟΣ ΠΛΗΡΟΦΟΡΙΚΗΣ 6/5/2006

ΚΥΠΡΙΑΚΗ ΕΤΑΙΡΕΙΑ ΠΛΗΡΟΦΟΡΙΚΗΣ CYPRUS COMPUTER SOCIETY ΠΑΓΚΥΠΡΙΟΣ ΜΑΘΗΤΙΚΟΣ ΔΙΑΓΩΝΙΣΜΟΣ ΠΛΗΡΟΦΟΡΙΚΗΣ 6/5/2006 Οδηγίες: Να απαντηθούν όλες οι ερωτήσεις. Ολοι οι αριθμοί που αναφέρονται σε όλα τα ερωτήματα είναι μικρότεροι το 1000 εκτός αν ορίζεται διαφορετικά στη διατύπωση του προβλήματος. Διάρκεια: 3,5 ώρες Καλή

Διαβάστε περισσότερα

Συνόρθωση κατά στάδια και αναδρομικοί αλγόριθμοι βέλτιστης εκτίμησης

Συνόρθωση κατά στάδια και αναδρομικοί αλγόριθμοι βέλτιστης εκτίμησης Ειδικά Θέματα Συνορθώσεων & Εφαρμογές 8 ο εξάμηνο, Ακαδημαϊκό έτος 2016-2017 Συνόρθωση κατά στάδια και αναδρομικοί αλγόριθμοι βέλτιστης εκτίμησης Χριστόφορος Κωτσάκης Τμήμα Αγρονόμων Τοπογράφων Μηχανικών

Διαβάστε περισσότερα

ΑΛΓΟΡΙΘΜΟΙ Άνοιξη I. ΜΗΛΗΣ

ΑΛΓΟΡΙΘΜΟΙ  Άνοιξη I. ΜΗΛΗΣ ΑΛΓΟΡΙΘΜΟΙ http://eclass.aueb.gr/courses/inf161/ Άνοιξη 2016 - I. ΜΗΛΗΣ ΠΑΡΑΔΕΙΓΜΑΤΑ ΑΛΓΟΡΙΘΜΩΝ ΚΑΙ ΠΟΛΥΠΛΟΚΟΤΗΤΑΣ ΑΛΓΟΡΙΘΜΟΙ - ΑΝΟΙΞΗ 2016 - Ι. ΜΗΛΗΣ - 03 - EXAMPLES ALG & COMPL 1 Example: GCD συνάρτηση

Διαβάστε περισσότερα

Notes on the Open Economy

Notes on the Open Economy Notes on the Open Econom Ben J. Heijdra Universit of Groningen April 24 Introduction In this note we stud the two-countr model of Table.4 in more detail. restated here for convenience. The model is Table.4.

Διαβάστε περισσότερα

Trigonometric Formula Sheet

Trigonometric Formula Sheet Trigonometric Formula Sheet Definition of the Trig Functions Right Triangle Definition Assume that: 0 < θ < or 0 < θ < 90 Unit Circle Definition Assume θ can be any angle. y x, y hypotenuse opposite θ

Διαβάστε περισσότερα

f a o gy s m a l nalg d co h n to h e y o m ia lalg e br coh the oogy lagebr

f a o gy s m a l nalg d co h n to h e y o m ia lalg e br coh the oogy lagebr - - - * k ˆ v ˆ k ˆ ˆ E x ˆ ˆ [ v ˆ ˆ ˆ ˆ ˆ E x ˆ ˆ ˆ ˆ v ˆ Ex U U ˆ ˆ ˆ ˆ ˆ ˆ v ˆ M v ˆ v M v ˆ ˆ I U ˆ I 9 70 k k ˆ ˆ - I I 9ˆ 70 ˆ [ ˆ - v - - v k k k ˆ - ˆ k ˆ k [ ˆ ˆ D M ˆ k k 0 D M k [ 0 M v M ˆ

Διαβάστε περισσότερα

Dynamic types, Lambda calculus machines Section and Practice Problems Apr 21 22, 2016

Dynamic types, Lambda calculus machines Section and Practice Problems Apr 21 22, 2016 Harvard School of Engineering and Applied Sciences CS 152: Programming Languages Dynamic types, Lambda calculus machines Apr 21 22, 2016 1 Dynamic types and contracts (a) To make sure you understand the

Διαβάστε περισσότερα

Dr. D. Dinev, Department of Structural Mechanics, UACEG

Dr. D. Dinev, Department of Structural Mechanics, UACEG Lecture 4 Material behavior: Constitutive equations Field of the game Print version Lecture on Theory of lasticity and Plasticity of Dr. D. Dinev, Department of Structural Mechanics, UACG 4.1 Contents

Διαβάστε περισσότερα

ΜΕΤΑΠΤΥΧΙΑΚΗ ΙΠΛΩΜΑΤΙΚΗ ΕΡΓΑΣΙΑ. Ελευθερίου Β. Χρυσούλα. Επιβλέπων: Νικόλαος Καραμπετάκης Καθηγητής Α.Π.Θ.

ΜΕΤΑΠΤΥΧΙΑΚΗ ΙΠΛΩΜΑΤΙΚΗ ΕΡΓΑΣΙΑ. Ελευθερίου Β. Χρυσούλα. Επιβλέπων: Νικόλαος Καραμπετάκης Καθηγητής Α.Π.Θ. ΑΡΙΣΤΟΤΕΛΕΙΟ ΠΑΝΕΠΙΣΤΗΜΙΟ ΘΕΣΣΑΛΟΝΙΚΗΣ ΤΜΗΜΑ ΜΑΘΗΜΑΤΙΚΩΝ ΜΕΤΑΠΤΥΧΙΑΚΟ ΠΡΟΓΡΑΜΜΑ ΣΠΟΥ ΩΝ ΘΕΩΡΗΤΙΚΗ ΠΛΗΡΟΦΟΡΙΚΗ ΚΑΙ ΘΕΩΡΙΑ ΣΥΣΤΗΜΑΤΩΝ ΚΑΙ ΕΛΕΓΧΟΥ Αναγνώριση συστημάτων με δεδομένη συνεχή και κρουστική συμπεριφορά

Διαβάστε περισσότερα

Κεθάιαην Επηθακπύιηα θαη Επηθαλεηαθά Οινθιεξώκαηα

Κεθάιαην Επηθακπύιηα θαη Επηθαλεηαθά Οινθιεξώκαηα Δπηθακπύιηα Οινθιεξώκαηα Κεθάιαην Επηθακπύιηα θαη Επηθαλεηαθά Οινθιεξώκαηα Επηθακπύιηα Οινθιεξώκαηα θαη εθαξκνγέο. Επηθακπύιην Οινθιήξωκα. Έζηω όηη ε βαζκωηή ζπλάξηεζε f(x,y,z) είλαη νξηζκέλε πάλω ζε κία

Διαβάστε περισσότερα

b. Use the parametrization from (a) to compute the area of S a as S a ds. Be sure to substitute for ds!

b. Use the parametrization from (a) to compute the area of S a as S a ds. Be sure to substitute for ds! MTH U341 urface Integrals, tokes theorem, the divergence theorem To be turned in Wed., Dec. 1. 1. Let be the sphere of radius a, x 2 + y 2 + z 2 a 2. a. Use spherical coordinates (with ρ a) to parametrize.

Διαβάστε περισσότερα

Discontinuous Hermite Collocation and Diagonally Implicit RK3 for a Brain Tumour Invasion Model

Discontinuous Hermite Collocation and Diagonally Implicit RK3 for a Brain Tumour Invasion Model 1 Discontinuous Hermite Collocation and Diagonally Implicit RK3 for a Brain Tumour Invasion Model John E. Athanasakis Applied Mathematics & Computers Laboratory Technical University of Crete Chania 73100,

Διαβάστε περισσότερα

Ó³ Ÿ , º 3(180).. 313Ä320

Ó³ Ÿ , º 3(180).. 313Ä320 Ó³ Ÿ. 213.. 1, º 3(18).. 313Ä32 ˆ ˆŠ Œ ˆ ˆ Œ ƒ Ÿ. ˆŸ ˆŸ ƒ ƒ Ÿ ˆ Š ˆ Šˆ Š ŒŒ ˆ ˆ ˆ ˆ ˆ Œ ˆŠ.. μ a, Œ.. Œ Í ± μ,. ƒ. ²Ò ± a ˆ É ÉÊÉ Ö ÒÌ ² μ μ ±μ ± ³ ʱ, Œμ ± ÊÎ μ- ² μ É ²Ó ± É ÉÊÉ Ö μ Ë ± ³... ±μ ²ÓÍÒ

Διαβάστε περισσότερα

Histogram list, 11 RANDOM NUMBERS & HISTOGRAMS. r : RandomReal. ri : RandomInteger. rd : RandomInteger 1, 6

Histogram list, 11 RANDOM NUMBERS & HISTOGRAMS. r : RandomReal. ri : RandomInteger. rd : RandomInteger 1, 6 In[1]:= In[2]:= RANDOM NUMBERS & HISTOGRAMS r : RandomReal In[3]:= In[4]:= In[5]:= ri : RandomInteger In[6]:= rd : RandomInteger 1, 6 In[7]:= list Table rd rd, 100 2 dice Out[7]= 7, 11, 7, 10, 7, 8, 3,

Διαβάστε περισσότερα

Ó³ Ÿ , º 3(194).. 673Ä677. Š Œ œ ƒˆˆ ˆ ˆŠ. ˆ.. ³ Ì μ, ƒ.. Š ³ÒÏ,ˆ..Š Ö, Ÿ. ʲ ±μ ±

Ó³ Ÿ , º 3(194).. 673Ä677. Š Œ œ ƒˆˆ ˆ ˆŠ. ˆ.. ³ Ì μ, ƒ.. Š ³ÒÏ,ˆ..Š Ö, Ÿ. ʲ ±μ ± Ó³ Ÿ. 2015.. 12, º 3(194.. 673Ä677 Š Œ œ ƒˆˆ ˆ ˆŠ ˆŸ ˆ Šˆ ˆ ˆ Œ ˆŠ ˆ.. ³ Ì μ, ƒ.. Š ³ÒÏ,ˆ..Š Ö, Ÿ. ʲ ±μ ± Ñ Ò É ÉÊÉ Ö ÒÌ ² μ, Ê ˆ É ÉÊÉ Ö μ Ë ± μ²ó ±μ ± ³ ʱ, Š ±μ, μ²óï μé É ² Ò Ê Ö Ö Î ² Ò Ê²ÓÉ ÉÒ,

Διαβάστε περισσότερα

Εισαγωγή στη Fortran. Μάθημα 3 ο. Ελευθερία Λιούκα

Εισαγωγή στη Fortran. Μάθημα 3 ο. Ελευθερία Λιούκα Εισαγωγή στη Fortran Μάθημα 3 ο Ελευθερία Λιούκα liouka.eleftheria@gmail.com Περιεχόμενα Loops External Functions Subroutines Arrays Common mistakes Loops Ανάγκη να εκτελέσουμε τις ίδιες εντολές πολλές

Διαβάστε περισσότερα

Lecture 10 - Representation Theory III: Theory of Weights

Lecture 10 - Representation Theory III: Theory of Weights Lecture 10 - Representation Theory III: Theory of Weights February 18, 2012 1 Terminology One assumes a base = {α i } i has been chosen. Then a weight Λ with non-negative integral Dynkin coefficients Λ

Διαβάστε περισσότερα

Matrix Algorithms. Παρουσίαση στα πλαίσια του μαθήματος «Παράλληλοι. Αλγόριθμοι» Γ. Καούρη Β. Μήτσου

Matrix Algorithms. Παρουσίαση στα πλαίσια του μαθήματος «Παράλληλοι. Αλγόριθμοι» Γ. Καούρη Β. Μήτσου Matrix Algorithms Παρουσίαση στα πλαίσια του μαθήματος «Παράλληλοι Αλγόριθμοι» Γ. Καούρη Β. Μήτσου Περιεχόμενα παρουσίασης Πολλαπλασιασμός πίνακα με διάνυσμα Πολλαπλασιασμός πινάκων Επίλυση τριγωνικού

Διαβάστε περισσότερα

ΑΛΓΟΡΙΘΜΟΙ Άνοιξη I. ΜΗΛΗΣ

ΑΛΓΟΡΙΘΜΟΙ  Άνοιξη I. ΜΗΛΗΣ ΑΛΓΟΡΙΘΜΟΙ http://eclass.aueb.gr/courses/inf161/ Άνοιξη 216 - I. ΜΗΛΗΣ ΔΥΝΑΜΙΚΟΣ ΠΡΟΓΡΑΜΜΑΤΙΣΜΟΣ ΑΛΓΟΡΙΘΜΟΙ - ΑΝΟΙΞΗ 216 - Ι. ΜΗΛΗΣ 9 DP II 1 Dynamic Programming ΓΕΝΙΚΗ ΙΔΕΑ 1. Ορισμός υπο-προβλήματος/ων

Διαβάστε περισσότερα

ΗΛΙΑΣΚΟΣ ΦΡΟΝΤΙΣΤΗΡΙΑ. Τεχνολογικής Κατεύθυνσης Προγραμματισμός Γ Λυκείου Μέρος 2 ο ΥΠΗΡΕΣΙΕΣ ΠΑΙΔΕΙΑΣ ΥΨΗΛΟΥ ΕΠΙΠΕΔΟΥ ΣΤΕΦΑΝΟΣ ΗΛΙΑΣΚΟΣ

ΗΛΙΑΣΚΟΣ ΦΡΟΝΤΙΣΤΗΡΙΑ. Τεχνολογικής Κατεύθυνσης Προγραμματισμός Γ Λυκείου Μέρος 2 ο ΥΠΗΡΕΣΙΕΣ ΠΑΙΔΕΙΑΣ ΥΨΗΛΟΥ ΕΠΙΠΕΔΟΥ ΣΤΕΦΑΝΟΣ ΗΛΙΑΣΚΟΣ ΗΛΙΑΣΚΟΣ ΦΡΟΝΤΙΣΤΗΡΙΑ ΥΠΗΡΕΣΙΕΣ ΠΑΙΔΕΙΑΣ ΥΨΗΛΟΥ ΕΠΙΠΕΔΟΥ Τεχνολογικής Κατεύθυνσης Προγραμματισμός Γ Λυκείου Μέρος 2 ο ΣΤΕΦΑΝΟΣ ΗΛΙΑΣΚΟΣ e-mail: info@iliaskos.gr www.iliaskos.gr 4 - - 75 - true true - false

Διαβάστε περισσότερα

Wavelet based matrix compression for boundary integral equations on complex geometries

Wavelet based matrix compression for boundary integral equations on complex geometries 1 Wavelet based matrix compression for boundary integral equations on complex geometries Ulf Kähler Chemnitz University of Technology Workshop on Fast Boundary Element Methods in Industrial Applications

Διαβάστε περισσότερα

V r,k j F k m N k+1 N k N k+1 H j n = 7 n = 16 Ṽ r ñ,ñ j Ṽ Ṽ j x / Ṽ W 2r V r D N T T 2r 2r N k F k N 2r Ω R 2 n Ω I n = { N: n} n N R 2 x R 2, I n Ω R 2 u R 2, I n x k+1 = x k + u k, u, x R 2,

Διαβάστε περισσότερα

ΗΜΥ 100 Εισαγωγή στην Τεχνολογία ιάλεξη 16

ΗΜΥ 100 Εισαγωγή στην Τεχνολογία ιάλεξη 16 ΗΜΥ 100 Εισαγωγή στην Τεχνολογία ιάλεξη 16 7 Νοεµβρίου, 2006 Γεώργιος Έλληνας Επίκουρος Καθηγητής ΤΜΗΜΑ ΗΛΕΚΤΡΟΛΟΓΩΝ ΜΗΧΑΝΙΚΩΝ ΚΑΙ ΜΗΧΑΝΙΚΩΝ ΥΠΟΛΟΓΙΣΤΩΝ ΠΟΛΥΤΕΧΝΙΚΗ ΣΧΟΛΗ ΠΑΝΕΠΙΣΤΗΜΙΟ ΚΥΠΡΟΥ ΤΑ ΘΕΜΑΤΑ

Διαβάστε περισσότερα

k A = [k, k]( )[a 1, a 2 ] = [ka 1,ka 2 ] 4For the division of two intervals of confidence in R +

k A = [k, k]( )[a 1, a 2 ] = [ka 1,ka 2 ] 4For the division of two intervals of confidence in R + Chapter 3. Fuzzy Arithmetic 3- Fuzzy arithmetic: ~Addition(+) and subtraction (-): Let A = [a and B = [b, b in R If x [a and y [b, b than x+y [a +b +b Symbolically,we write A(+)B = [a (+)[b, b = [a +b

Διαβάστε περισσότερα

ΓΡΑΜΜΙΚΟΣ & ΔΙΚΤΥΑΚΟΣ ΠΡΟΓΡΑΜΜΑΤΙΣΜΟΣ

ΓΡΑΜΜΙΚΟΣ & ΔΙΚΤΥΑΚΟΣ ΠΡΟΓΡΑΜΜΑΤΙΣΜΟΣ ΓΡΑΜΜΙΚΟΣ & ΔΙΚΤΥΑΚΟΣ ΠΡΟΓΡΑΜΜΑΤΙΣΜΟΣ Ενότητα 24: Ειδικές Περιπτώσεις του Προβλήματος Ροής Ελαχίστου Κόστους Σαμαράς Νικόλαος Άδειες Χρήσης Το παρόν εκπαιδευτικό υλικό υπόκειται σε άδειες χρήσης Creative

Διαβάστε περισσότερα

Άσκηση 1. O υπολογισμός να γίνει: α) με την τεχνική αθροίσματος σε μεταβλητή

Άσκηση 1. O υπολογισμός να γίνει: α) με την τεχνική αθροίσματος σε μεταβλητή Άσκηση 1 Να γραφεί κώδικας FORTRAN που θα υπολογίζει το άθροισμα όλων των στοιχείων ενός διανύσματος a (μονοδιάστατη array) διάστασης Ν. Τα στοιχεία του διανύσματος a δίνονται από τη σχέση: a(i) = 2*i

Διαβάστε περισσότερα

Spherical Coordinates

Spherical Coordinates Spherical Coordinates MATH 311, Calculus III J. Robert Buchanan Department of Mathematics Fall 2011 Spherical Coordinates Another means of locating points in three-dimensional space is known as the spherical

Διαβάστε περισσότερα

D Alembert s Solution to the Wave Equation

D Alembert s Solution to the Wave Equation D Alembert s Solution to the Wave Equation MATH 467 Partial Differential Equations J. Robert Buchanan Department of Mathematics Fall 2018 Objectives In this lesson we will learn: a change of variable technique

Διαβάστε περισσότερα

1. (a) (5 points) Find the unit tangent and unit normal vectors T and N to the curve. r(t) = 3cost, 4t, 3sint

1. (a) (5 points) Find the unit tangent and unit normal vectors T and N to the curve. r(t) = 3cost, 4t, 3sint 1. a) 5 points) Find the unit tangent and unit normal vectors T and N to the curve at the point P, π, rt) cost, t, sint ). b) 5 points) Find curvature of the curve at the point P. Solution: a) r t) sint,,

Διαβάστε περισσότερα

Jordan Form of a Square Matrix

Jordan Form of a Square Matrix Jordan Form of a Square Matrix Josh Engwer Texas Tech University josh.engwer@ttu.edu June 3 KEY CONCEPTS & DEFINITIONS: R Set of all real numbers C Set of all complex numbers = {a + bi : a b R and i =

Διαβάστε περισσότερα

M p f(p, q) = (p + q) O(1)

M p f(p, q) = (p + q) O(1) l k M = E, I S = {S,..., S t } E S i = p i {,..., t} S S q S Y E q X S X Y = X Y I X S X Y = X Y I S q S q q p+q p q S q p i O q S pq p i O S 2 p q q p+q p q p+q p fp, q AM S O fp, q p + q p p+q p AM

Διαβάστε περισσότερα

Διανύσµατα στο επίπεδο

Διανύσµατα στο επίπεδο Διανύσµατα στο επίπεδο Ένα διάνυσµα v έχει αρχικό και τελικό σηµείο. Χαρακτηρίζεται από: διεύθυνση (ευθεία επί της οποίας κείται φορά (προς ποια κατεύθυνση της ευθείας δείχνει µέτρο (το µήκος του, v ή

Διαβάστε περισσότερα

Lecture 13 - Root Space Decomposition II

Lecture 13 - Root Space Decomposition II Lecture 13 - Root Space Decomposition II October 18, 2012 1 Review First let us recall the situation. Let g be a simple algebra, with maximal toral subalgebra h (which we are calling a CSA, or Cartan Subalgebra).

Διαβάστε περισσότερα

«Σχεδιασμός Ολοκληρωμένων Κυκλωμάτων» Χειμερινό εξάμηνο Συντρέχων Κώδικας

«Σχεδιασμός Ολοκληρωμένων Κυκλωμάτων» Χειμερινό εξάμηνο Συντρέχων Κώδικας «Σχεδιασμός Ολοκληρωμένων Κυκλωμάτων» Χειμερινό εξάμηνο 216-217 Συντρέχων Κώδικας Παρασκευάς Κίτσος http://diceslab.cied.teiwest.gr Επίκουρος Καθηγητής Tμήμα Μηχανικών Πληροφορικής ΤΕ E-mail: pkitsos@teimes.gr

Διαβάστε περισσότερα

DESIGN OF MACHINERY SOLUTION MANUAL h in h 4 0.

DESIGN OF MACHINERY SOLUTION MANUAL h in h 4 0. DESIGN OF MACHINERY SOLUTION MANUAL -7-1! PROBLEM -7 Statement: Design a double-dwell cam to move a follower from to 25 6, dwell for 12, fall 25 and dwell for the remader The total cycle must take 4 sec

Διαβάστε περισσότερα

= λ 1 1 e. = λ 1 =12. has the properties e 1. e 3,V(Y

= λ 1 1 e. = λ 1 =12. has the properties e 1. e 3,V(Y Stat 50 Homework Solutions Spring 005. (a λ λ λ 44 (b trace( λ + λ + λ 0 (c V (e x e e λ e e λ e (λ e by definition, the eigenvector e has the properties e λ e and e e. (d λ e e + λ e e + λ e e 8 6 4 4

Διαβάστε περισσότερα

Τμήμα Μηχανολόγων Μηχανικών Πανεπιστήμιο Θεσσαλίας ΠΡΟΓΡΑΜΜΑΤΙΣΜΟΣ Η/Υ ΠΙΝΑΚΕΣ. Ιωάννης Λυχναρόπουλος Μαθηματικός, MSc, PhD

Τμήμα Μηχανολόγων Μηχανικών Πανεπιστήμιο Θεσσαλίας ΠΡΟΓΡΑΜΜΑΤΙΣΜΟΣ Η/Υ ΠΙΝΑΚΕΣ. Ιωάννης Λυχναρόπουλος Μαθηματικός, MSc, PhD Τμήμα Μηχανολόγων Μηχανικών Πανεπιστήμιο Θεσσαλίας ΠΡΟΓΡΑΜΜΑΤΙΣΜΟΣ Η/Υ ΠΙΝΑΚΕΣ Ιωάννης Λυχναρόπουλος Μαθηματικός, MSc, PhD ΕΙΣΑΓΩΓΗ Οι πίνακες είναι συλλογές δεδομένων που μοιράζονται τα ίδια χαρακτηριστικά.

Διαβάστε περισσότερα

Εισαγωγή στον Προγραμματισμό

Εισαγωγή στον Προγραμματισμό Εισαγωγή στον Προγραμματισμό Αριθμητική Δημήτρης Μιχαήλ Τμήμα Πληροφορικής και Τηλεματικής Χαροκόπειο Πανεπιστήμιο Ακ. Έτος 2012-2013 Δεύτερο Πρόγραμμα 1 / * Second Simple Program : add 2 numbers * / 2

Διαβάστε περισσότερα

2. THEORY OF EQUATIONS. PREVIOUS EAMCET Bits.

2. THEORY OF EQUATIONS. PREVIOUS EAMCET Bits. EAMCET-. THEORY OF EQUATIONS PREVIOUS EAMCET Bits. Each of the roots of the equation x 6x + 6x 5= are increased by k so that the new transformed equation does not contain term. Then k =... - 4. - Sol.

Διαβάστε περισσότερα