view +scheme/hypsyst2d.m @ 291:807dfe8be3ec feature/hypsyst

Have made a lot of stupid changes in hypsyst in order to find a stupid bug
author Ylva Rydin <ylva.rydin@telia.com>
date Wed, 21 Sep 2016 16:30:34 +0200
parents d32f674bcbe5
children 3d275c5e45b3
line wrap: on
line source

classdef hypsyst2d < scheme.Scheme
    properties
        m % Number of points in each direction, possibly a vector
        h % Grid spacing
        x,y % Grid
        X,Y % Values of x and y for each grid point
        order % Order accuracy for the approximation
        
        D % non-stabalized scheme operator
        A, B, E
        
        H % Discrete norm
        % Norms in the x and y directions
        Hxi,Hyi % Kroneckerd norms. 1'*Hx*v corresponds to integration in the x dir.
        I_x,I_y, I_N
        e_w, e_e, e_s, e_n
        params %parameters for the coeficient matrices
        matrices
    end
    
    
    methods
        function obj = hypsyst2d(m,lim,order,matrices,params)
            
            xlim = lim{1};
            ylim = lim{2};
            
            if length(m) == 1
                m = [m m];
            end
            
            m_x = m(1);
            m_y = m(2);
            
            obj.matrices=matrices;
            
            ops_x = sbp.D2Standard(m_x,xlim,order);
            ops_y = sbp.D2Standard(m_y,ylim,order);
            
            obj.x=ops_x.x;
            obj.y=ops_y.x;
            
            obj.X = kr(obj.x,ones(m_y,1));
            obj.Y = kr(ones(m_x,1),obj.y);
            
            I_x = speye(m_x);
            I_y = speye(m_y);
            obj.I_N=speye(m_x*m_y);
            I_n=  eye(4);
            
            
            D1_x = kr(kr(I_n,ops_x.D1),I_y);
            obj.Hxi= kr(kr(I_n,ops_x.HI),I_y);
            D1_y=kr(I_n,kr(I_x,ops_y.D1));
            obj.Hyi=kr(I_n,kr(I_x,ops_y.HI));
            
            obj.e_w=kr(I_n,kr(ops_x.e_l,I_y));
            obj.e_e=kr(I_n,kr(ops_x.e_r,I_y));
            obj.e_s=kr(I_n,kr(I_x,ops_y.e_l));
            obj.e_n=kr(I_n,kr(I_x,ops_y.e_r));
            
            obj.m=m;
            obj.h=[ops_x.h ops_y.h];
            obj.order=order;
            obj.params=params;
            
            obj.A=obj.matrixBuild(matrices.A);
            obj.B=obj.matrixBuild(matrices.B);
            obj.E=obj.matrixBuild(matrices.E);
            
            A=kron(matrices.A(params,0,0),obj.I_N);
            B=kron(matrices.B(params,0,0),obj.I_N);
            
          obj.D=-obj.A*D1_x-obj.B*D1_y-obj.E;
           
        end
        % Closure functions return the opertors applied to the own doamin to close the boundary
        % Penalty functions return the opertors to force the solution. In the case of an interface it returns the operator applied to the other doamin.
        %       boundary            is a string specifying the boundary e.g. 'l','r' or 'e','w','n','s'.
        %       type                is a string specifying the type of boundary condition if there are several.
        %       data                is a function returning the data that should be applied at the boundary.
        %       neighbour_scheme    is an instance of Scheme that should be interfaced to.
        %       neighbour_boundary  is a string specifying which boundary to interface to.
        function [closure, penalty] = boundary_condition(obj,boundary,type)
            default_arg('type','neumann');
            default_arg('data',0);
            
            switch type
                case{'c','char'}
                    [closure,penalty]=GetBoundarydata_char_fel(obj,boundary);
                otherwise
                    error('No such boundary condition')
            end
        end
        
        function [closure, penalty] = interface(obj,boundary,neighbour_scheme,neighbour_boundary)
            error('An interface function does not exist yet');
        end
        
        function N = size(obj)
            N = obj.m;
        end
        
          function [ret]=matrixBuild(obj,mat)
            %extra info for coordinate transfomration mult my y_ny  and
            %x,ny osv...
            params=obj.params;
            X=obj.X;
            Y=obj.Y;
            
            if isa(mat,'function_handle')
                matVec=mat(params,X',Y');
                side=length(X');
            else
                matVec=mat;
                side=max(size(mat))/4;
            end
            matVec=sparse(matVec);
            
            
            ret=[diag(matVec(1,(1-1)*side+1:1*side)) diag(matVec(1,(2-1)*side+1:2*side)) diag(matVec(1,(3-1)*side+1:3*side)) diag(matVec(1,(4-1)*side+1:4*side))
                diag(matVec(2,(1-1)*side+1:1*side)) diag(matVec(2,(2-1)*side+1:2*side)) diag(matVec(2,(3-1)*side+1:3*side)) diag(matVec(2,(4-1)*side+1:4*side))
                diag(matVec(3,(1-1)*side+1:1*side)) diag(matVec(3,(2-1)*side+1:2*side)) diag(matVec(3,(3-1)*side+1:3*side)) diag(matVec(3,(4-1)*side+1:4*side))
                diag(matVec(4,(1-1)*side+1:1*side)) diag(matVec(4,(2-1)*side+1:2*side)) diag(matVec(4,(3-1)*side+1:3*side)) diag(matVec(4,(4-1)*side+1:4*side))];
          end
            function [closure, penalty]=GetBoundarydata_char(obj,boundary)
            params=obj.params;
            x=obj.x;
            y=obj.y;
    
            switch boundary
                case {'w','W','west'}
                    e_=obj.e_w;
                    mat=obj.matrices.A;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,0,0);
                    Hi=obj.Hxi;
                    mat_plus=V*(D+abs(D))*Vi/2;
                   
                    mat_plus=e_'*kron(mat_plus,obj.I_N)*e_;

                    tau=-1;             
                    closure=Hi*e_*tau*mat_plus*e_';
                    penalty=Hi*e_*tau*mat_plus;
       
                case {'e','E','east'}
                    e_=obj.e_e;
                    mat=obj.matrices.A;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,0,0);
                    Hi=obj.Hxi;
                    tau=1;
                    mat_minus=V*(D-abs(D))*Vi/2;      
                    mat_minus=e_'*kron(mat_minus,obj.I_N)*e_;
                    closure=Hi*e_*tau*mat_minus*e_';
                    penalty=Hi*e_*tau*mat_minus;
                    
                case {'s','S','south'}
                    e_=obj.e_s;
                    mat=obj.matrices.B;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,0,0);
                    Hi=obj.Hyi;
                    mat_plus=V*(D+abs(D))*Vi/2;
                    
                    mat_plus=e_'*kron(mat_plus,obj.I_N)*e_;
                    tau=-1;             
                    closure=Hi*e_*tau*mat_plus*e_';
                    penalty=Hi*e_*tau*mat_plus;
                  
                case {'n','N','north'}
                    e_=obj.e_n;
                    mat=obj.matrices.B;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,0,0);
                    Hi=obj.Hyi;
                    tau=1;
                    mat_minus=V*(D-abs(D))*Vi/2;     
                    
                    mat_minus=e_'*kron(mat_minus,obj.I_N)*e_;
                    closure=Hi*e_*tau*mat_minus*e_';
                    penalty=Hi*e_*tau*mat_minus;
                  
            end      
          end 
        
          
          
           function [closure, penalty]=GetBoundarydata_charfel2(obj,boundary)
            params=obj.params;
            x=obj.x;
            y=obj.y;
    
            switch boundary
                case {'w','W','west'}
                    e_=obj.e_w;
                    mat=obj.matrices.A;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x(1),y);
                    Hi=obj.Hxi;
                    mat_plus=V*(D+abs(D))*Vi/2;
                    
                    tau=-1;             
                    closure=Hi*e_*tau*mat_plus*e_';
                    penalty=Hi*e_*tau*mat_plus;
       
                case {'e','E','east'}
                    e_=obj.e_e;j
                    mat=obj.matrices.A;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x(end),y);
                    Hi=obj.Hxi;
                    tau=1;
                  
                    closure=Hi*e_*tau*mat_minus*e_';
                    penalty=Hi*e_*tau*mat_minus;
                    
                case {'s','S','south'}
                    e_=obj.e_s;
                    mat=obj.matrices.B;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x,y(1));
                    Hi=obj.Hyi;
                   
                    tau=-1;             
                    closure=Hi*e_*tau*mat_plus*e_';
                    penalty=Hi*e_*tau*mat_plus;
                  
                case {'n','N','north'}
                    e_=obj.e_n;
                    mat=obj.matrices.B;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x,y(end));
                    Hi=obj.Hyi;
                    tau=1;
                  
                    closure=Hi*e_*tau*mat_minus*e_';
                    penalty=Hi*e_*tau*mat_minus;
                  
            end      
          end 
          
          
        function [closure, penalty]=GetBoundarydata_char_fel(obj,boundary)
            params=obj.params;
            x=obj.x;
            y=obj.y;
            
            side=max(length(x),length(y));
            
            
            switch boundary
                case {'w','W','west'}
                    e_=obj.e_w;
                    mat=obj.matrices.A;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x(1),y);
                    Hi=obj.Hxi;
                    tau=sparse(4*side,pos*side);
                    V_plus=V(:,1:pos*side);   
                    Vi_plus=Vi(1:pos*side,:); 
                    tau(1:pos*side,:)=-abs(D(1:pos*side,1:pos*side));  
                    mat_plus=V*(D+abs(D))*Vi/2;
                    
                    closure=Hi*e_*V*tau*Vi_plus*e_';
                    penalty=Hi*e_*V*tau*Vi_plus;
       
                case {'e','E','east'}
                    e_=obj.e_e;
                    mat=obj.matrices.A;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x(end),y);
                    Hi=obj.Hxi;
                    tau=sparse(4*side,(4-pos)*side);
                    tau(pos*side+1:4*side,:)=-abs(D(pos*side+1:4*side,pos*side+1:4*side));
                     Vi_minus=Vi(pos*side+1:4*side,:);
                    mat_minus=V*(D-abs(D))*Vi/2;
              
                    closure=Hi*e_*V*tau*Vi_minus*e_';
                    penalty=Hi*e_*V*tau*Vi_minus;
                    
                case {'s','S','south'}
                    e_=obj.e_s;
                    mat=obj.matrices.B;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x,y(1));
                    Hi=obj.Hyi;
                    tau=sparse(4*side,pos*side);
                    V_plus=V(:,1:pos*side);   
                    Vi_plus=Vi(1:pos*side,:); 
                    tau(1:pos*side,:)=-abs(D(1:pos*side,1:pos*side));  
                    mat_plus=V*(D+abs(D))*Vi/2;
                    
                    closure=Hi*e_*V*tau*Vi_plus*e_';
                    penalty=Hi*e_*V*tau*Vi_plus;
                case {'n','N','north'}
                    e_=obj.e_n;
                    mat=obj.matrices.B;
                    [V,Vi,D,pos]=obj.matrixDiag(mat,x,y(end));
                    Hi=obj.Hyi;
                    tau=sparse(4*side,(4-pos)*side);
                    tau(pos*side+1:4*side,:)=-abs(D(pos*side+1:4*side,pos*side+1:4*side));
                    Vi_minus=Vi(pos*side+1:4*side,:);
                    mat_minus=V*(D-abs(D))*Vi/2;
                    
                    closure=Hi*e_*V*tau*Vi_minus*e_';
                    penalty=Hi*e_*V*tau*Vi_minus;
            end      
          end
        
        function [V,Vi, D,pos]=matrixDiag(obj,mat,x,y)
            params=obj.params;
            syms xs ys;
            [V, D]=eig(mat(params,xs,ys));
            xs=1;ys=1;
            DD=eval(diag(D));
            
            pos=find(DD>=0); %Now zero eigenvalues are calculated as possitive, Maybe it should not????
            neg=find(DD<0);
            syms xs ys
            DD=diag(D);
            
            D=diag([DD(pos); DD(neg)]);
            V=[V(:,pos) V(:,neg)];
          
            xs=x; ys=y;
       
            
            side=max(length(x),length(y));
            Dret=zeros(4,side*4);
            Vret=zeros(4,side*4);
            for ii=1:4
                for jj=1:4
                    Dret(jj,(ii-1)*side+1:side*ii)=eval(D(jj,ii));
                    Vret(jj,(ii-1)*side+1:side*ii)=eval(V(jj,ii));
                end
            end
           
            D=sparse(Dret);
            V=sparse(normc(Vret));
            V=obj.matrixBuild(V);
            D=obj.matrixBuild(D);
            Vi=inv(V);
            pos=length(pos);
        end
        
    end
    
    methods(Static)
        % Calculates the matrcis need for the inteface coupling between boundary bound_u of scheme schm_u
        % and bound_v of scheme schm_v.
        %   [uu, uv, vv, vu] = inteface_couplong(A,'r',B,'l')
        function [uu, uv, vv, vu] = interface_coupling(schm_u,bound_u,schm_v,bound_v)
            [uu,uv] = schm_u.interface(bound_u,schm_v,bound_v);
            [vv,vu] = schm_v.interface(bound_v,schm_u,bound_u);
        end
        
      
    end
end