Changeset 23950


Ignore:
Timestamp:
05/29/19 15:35:37 (6 years ago)
Author:
Mathieu Morlighem
Message:

CHG: changed the way effective pressure is being updated

Location:
issm/trunk-jpl/src/c
Files:
3 edited

Legend:

Unmodified
Added
Removed
  • issm/trunk-jpl/src/c/analyses/HydrologyGlaDSAnalysis.cpp

    r23948 r23950  
    152152
    153153        /*Get all inputs and parameters*/
    154         IssmDouble dt,c_t;
    155         element->FindParam(&dt,TimesteppingTimeStepEnum);
    156         element->FindParam(&c_t,HydrologyPressureMeltCoefficientEnum);
     154        IssmDouble dt        = element->FindParam(TimesteppingTimeStepEnum);
     155        IssmDouble c_t       = element->FindParam(HydrologyPressureMeltCoefficientEnum);
     156        IssmDouble rho_water = element->FindParam(MaterialsRhoFreshwaterEnum);
     157        IssmDouble g         = element->FindParam(ConstantsGEnum);
    157158        Input* k_input   = element->GetInput(HydrologySheetConductivityEnum);_assert_(k_input);
    158159        Input* phi_input = element->GetInput(HydraulicPotentialEnum);      _assert_(phi_input);
     
    186187                                                        + coeff*dbasis[1*numnodes+i]*dbasis[1*numnodes+j]);
    187188                        }
     189                }
     190
     191                /*Transient term if dt*/
     192                if(dt>0.){
    188193                }
    189194        }
     
    286291}/*}}}*/
    287292void           HydrologyGlaDSAnalysis::InputUpdateFromSolution(IssmDouble* solution,Element* element){/*{{{*/
    288 
    289         /*Intermediary*/
    290         int* doflist = NULL;
    291         IssmDouble phi_0, phi_m, pi;
    292 
    293         /*Fetch number of nodes for this finite element*/
    294         int numnodes = element->GetNumberOfNodes();
    295 
    296         /*Fetch dof list and allocate solution vector*/
    297         element->GetDofListLocal(&doflist,NoneApproximationEnum,GsetEnum);
    298         IssmDouble* values = xNew<IssmDouble>(numnodes);
    299 
    300         /*Get thickness and base on nodes to apply cap on water head*/
    301    IssmDouble* N = xNew<IssmDouble>(numnodes);
    302         IssmDouble* h = xNew<IssmDouble>(numnodes);
    303         IssmDouble* thickness = xNew<IssmDouble>(numnodes);
    304         IssmDouble* bed       = xNew<IssmDouble>(numnodes);
    305         IssmDouble  rho_ice   = element->FindParam(MaterialsRhoIceEnum);
    306         IssmDouble  rho_water = element->FindParam(MaterialsRhoFreshwaterEnum);
    307         IssmDouble  g         = element->FindParam(ConstantsGEnum);
    308         element->GetInputListOnNodes(&thickness[0],ThicknessEnum);
    309         element->GetInputListOnNodes(&bed[0],BaseEnum);
    310 
    311         /*Use the dof list to index into the solution vector: */
    312         for(int i=0;i<numnodes;i++){
    313                 values[i]=solution[doflist[i]];
    314 
    315                 /*Elevation potential*/
    316                 phi_m = rho_water*g*bed[i];
    317 
    318                 /*Compute overburden pressure*/
    319                 pi = rho_ice*g*thickness[i];
    320 
    321                 /*Copmute overburden potential*/
    322                 phi_0 = phi_m + pi;
    323 
    324                 /*Calculate effective pressure*/
    325                 N[i] = phi_0 - values[i];
    326 
    327                 if(xIsNan<IssmDouble>(values[i])) _error_("NaN found in solution vector");
    328                 if(xIsInf<IssmDouble>(values[i])) _error_("Inf found in solution vector");
    329         }
    330 
    331         /*Add input to the element: */
    332         element->AddInput(HydraulicPotentialEnum,values,element->GetElementType());
    333    element->AddInput(EffectivePressureEnum,N,P1Enum);
    334 
    335         /*Free resources:*/
    336         xDelete<int>(doflist);
    337         xDelete<IssmDouble>(values);
    338         xDelete<IssmDouble>(N);
    339         xDelete<IssmDouble>(h);
    340         xDelete<IssmDouble>(bed);
    341         xDelete<IssmDouble>(thickness);
     293        element->InputUpdateFromSolutionOneDof(solution,HydraulicPotentialEnum);
     294        this->UpdateEffectivePressure(element);
    342295}/*}}}*/
    343296void           HydrologyGlaDSAnalysis::UpdateConstraints(FemModel* femmodel){/*{{{*/
     
    416369        delete gauss;
    417370}/*}}}*/
     371void HydrologyGlaDSAnalysis::UpdateEffectivePressure(FemModel* femmodel){/*{{{*/
     372
     373        for(int j=0;j<femmodel->elements->Size();j++){
     374                Element* element=(Element*)femmodel->elements->GetObjectByOffset(j);
     375                UpdateEffectivePressure(element);
     376        }
     377
     378}/*}}}*/
     379void HydrologyGlaDSAnalysis::UpdateEffectivePressure(Element* element){/*{{{*/
     380
     381        /*Skip if water or ice shelf element*/
     382        if(element->IsFloating()) return;
     383       
     384        /*Intermediary*/
     385        IssmDouble phi_0, phi_m, p_i;
     386        IssmDouble H,b,phi;
     387
     388        int numnodes = element->GetNumberOfNodes();
     389
     390        /*Get thickness and base on nodes to apply cap on water head*/
     391   IssmDouble* N = xNew<IssmDouble>(numnodes);
     392        IssmDouble  rho_ice   = element->FindParam(MaterialsRhoIceEnum);
     393        IssmDouble  rho_water = element->FindParam(MaterialsRhoFreshwaterEnum);
     394        IssmDouble  g         = element->FindParam(ConstantsGEnum);
     395        Input* H_input   = element->GetInput(ThicknessEnum); _assert_(H_input);
     396        Input* b_input   = element->GetInput(BedEnum); _assert_(b_input);
     397        Input* phi_input = element->GetInput(HydraulicPotentialEnum); _assert_(phi_input);
     398
     399        /* Start  looping on the number of gaussian points: */
     400        Gauss* gauss=element->NewGauss();
     401        for(int iv=0;iv<numnodes;iv++){
     402                gauss->GaussNode(element->FiniteElement(),iv);
     403
     404                /*Get input values at gauss points*/
     405                H_input->GetInputValue(&H,gauss);
     406                b_input->GetInputValue(&b,gauss);
     407                phi_input->GetInputValue(&phi,gauss);
     408
     409                /*Elevation potential*/
     410                phi_m = rho_water*g*b;
     411
     412                /*Compute overburden pressure*/
     413                p_i = rho_ice*g*H;
     414
     415                /*Copmute overburden potential*/
     416                phi_0 = phi_m + p_i;
     417
     418                /*Calculate effective pressure*/
     419                N[iv] = phi_0 - phi;
     420
     421                if(xIsNan<IssmDouble>(N[iv])) _error_("NaN found in solution vector");
     422                if(xIsInf<IssmDouble>(N[iv])) _error_("Inf found in solution vector");
     423        }
     424
     425        element->AddInput(EffectivePressureEnum,N,element->FiniteElement());
     426
     427        /*Clean up and return*/
     428        xDelete<IssmDouble>(N);
     429}/*}}}*/
  • issm/trunk-jpl/src/c/analyses/HydrologyGlaDSAnalysis.h

    r23942 r23950  
    3434                void UpdateSheetThickness(FemModel* femmodel);
    3535                void UpdateSheetThickness(Element*  element);
     36                void UpdateEffectivePressure(FemModel* femmodel);
     37                void UpdateEffectivePressure(Element*  element);
    3638};
    3739#endif
  • issm/trunk-jpl/src/c/cores/hydrology_core.cpp

    r23948 r23950  
    193193        /*Using the GlaDS model*/
    194194        else if (hydrology_model==HydrologyGlaDSEnum){
     195                HydrologyGlaDSAnalysis* analysis = new HydrologyGlaDSAnalysis();
    195196                femmodel->SetCurrentConfiguration(HydrologyGlaDSAnalysisEnum);
    196197                InputDuplicatex(femmodel,HydraulicPotentialEnum,HydraulicPotentialOldEnum);
     198                analysis->UpdateEffectivePressure(femmodel);
    197199                solutionsequence_shakti_nonlinear(femmodel);
    198200                if(VerboseSolution()) _printf0_("   updating sheet thickness\n");
    199                 HydrologyGlaDSAnalysis* analysis = new HydrologyGlaDSAnalysis();
    200201                analysis->UpdateSheetThickness(femmodel);
    201202                delete analysis;
Note: See TracChangeset for help on using the changeset viewer.